OOFEM  2.4
OOFEM.org - Object Oriented Finite Element Solver
error.h File Reference
#include "logger.h"
#include <string>
#include <cstdio>
#include <cstdlib>

Go to the source code of this file.

Namespaces

 oofem
 the oofem namespace is to define a context or scope in which all oofem names are defined.
 

Macros

#define OOFEM_EXIT(code)
 Cause oofem program termination by calling exit. More...
 
#define OOFEM_FATAL(...)   { oofem_logger.writeELogMsg(Logger :: LOG_LEVEL_FATAL, errorInfo(__func__).c_str(), __FILE__, __LINE__, __VA_ARGS__); OOFEM_EXIT(1); }
 Macros for printing errors. More...
 
#define OOFEM_ERROR(...)   { oofem_logger.writeELogMsg(Logger :: LOG_LEVEL_ERROR, errorInfo(__func__).c_str(), __FILE__, __LINE__, __VA_ARGS__); OOFEM_EXIT(1); }
 
#define OOFEM_WARNING(...)   oofem_logger.writeELogMsg(Logger :: LOG_LEVEL_WARNING, errorInfo(__func__).c_str(), __FILE__, __LINE__, __VA_ARGS__)
 
#define OOFEM_SERROR(...)   { oofem_logger.writeELogMsg(Logger :: LOG_LEVEL_ERROR, __func__, __FILE__, __LINE__, __VA_ARGS__); OOFEM_EXIT(1); }
 
#define OOFEM_SWARNING(...)   oofem_logger.writeELogMsg(Logger :: LOG_LEVEL_WARNING, __func__, __FILE__, __LINE__, __VA_ARGS__)
 

Functions

std::string oofem::errorInfo (const char *func)
 

Macro Definition Documentation

#define OOFEM_ERROR (   ...)    { oofem_logger.writeELogMsg(Logger :: LOG_LEVEL_ERROR, errorInfo(__func__).c_str(), __FILE__, __LINE__, __VA_ARGS__); OOFEM_EXIT(1); }

Definition at line 61 of file error.h.

Referenced by oofem::PrimaryField::__evaluateAt(), oofem::SlaveDof::__giveEquationNumber(), oofem::SlaveDof::__givePrescribedEquationNumber(), oofem::MMAContainingElementProjection::__init(), oofem::MMAClosestIPTransfer::__init(), oofem::MMALeastSquareProjection::__init(), oofem::MMAShapeFunctProjection::__mapVariable(), oofem::MMALeastSquareProjection::__mapVariable(), oofem::RandomMaterialExtensionInterface::_generateStatusVariables(), oofem::AdaptiveNonLinearStatic::adaptiveRemap(), oofem::Dictionary::add(), oofem::SparseMtrx::add(), oofem::FloatArray::add(), oofem::IntArray::add(), oofem::FloatMatrix::add(), oofem::Element::addDofManager(), oofem::ActiveBoundaryCondition::addElementSide(), oofem::FloatMatrix::addProductOf(), oofem::IntMatBilinearCZStatus::addStateVariables(), oofem::StructuralInterfaceMaterialStatus::addStateVariables(), oofem::FloatMatrix::addTProductOf(), oofem::PrimaryField::advanceSolution(), oofem::Parser::agr(), oofem::ParticleGrid< Point >::appendAllPoints(), oofem::Crack::AppendCohesiveZoneGaussPoint(), oofem::DofManager::appendDof(), oofem::Logger::appendErrorTo(), oofem::Logger::appendLogTo(), oofem::Quasicontinuum::applyApproach2(), oofem::Quasicontinuum::applyApproach3(), oofem::MDM::applyDamageToStiffness(), oofem::MDM::applyDamageTranformation(), oofem::StressVector::applyDeviatoricElasticCompliance(), oofem::StrainVector::applyDeviatoricElasticStiffness(), oofem::StrainVector::applyElasticStiffness(), oofem::SurfaceTensionBoundaryCondition::assemble(), oofem::SkylineUnsym::assemble(), oofem::DynCompRow::assemble(), oofem::DynCompCol::assemble(), oofem::SymCompCol::assemble(), oofem::Skyline::assemble(), oofem::CompCol::assemble(), oofem::FloatMatrix::assemble(), oofem::FloatArray::assemble(), oofem::EngngModel::assemble(), oofem::NLTransientTransportProblem::assembleAlgorithmicPartOfRhs(), oofem::AdaptiveNonLinearStatic::assembleInitialLoadVector(), oofem::FloatArray::assembleSquared(), oofem::EngngModel::assembleVectorFromElements(), oofem::Subdivision::assignGlobalNumbersToElements(), oofem::SloanGraph::assignNewNumbers(), oofem::AList< T >::at(), oofem::SpoolesSparseMtrx::at(), oofem::PetscSparseMtrx::at(), oofem::DynCompRow::at(), oofem::DynCompCol::at(), oofem::SymCompCol::at(), oofem::CompCol::at(), oofem::Skyline::at(), oofem::SkylineUnsym::backSubstitutionWith(), oofem::DynamicCommunicationBuffer::bcast(), oofem::BeamElementErrorCheckingRule::BeamElementErrorCheckingRule(), oofem::FloatArray::beDifferenceOf(), oofem::FloatMatrix::beInverseOf(), oofem::FloatMatrix::beLocalCoordSys(), oofem::FloatMatrix::beMatrixForm(), oofem::FloatMatrix::beMatrixFormOfStress(), oofem::FloatArray::beMaxOf(), oofem::FloatArray::beMinOf(), oofem::FloatArray::beProductOf(), oofem::FloatMatrix::beProductOf(), oofem::FloatMatrix::beProductTOf(), oofem::FloatArray::beSubArrayOf(), oofem::FloatMatrix::beSubMatrixOf(), oofem::FloatArray::beSymVectorForm(), oofem::FloatArray::beSymVectorFormOfStrain(), oofem::FloatArray::beTProductOf(), oofem::FloatMatrix::beTProductOf(), oofem::FloatMatrix::beUnitMatrix(), oofem::FloatArray::beVectorForm(), oofem::FloatArray::beVectorProductOf(), oofem::BinghamFluidMaterial2Status::BinghamFluidMaterial2Status(), oofem::Subdivision::RS_Triangle::bisect(), oofem::Subdivision::RS_Tetra::bisect(), oofem::Subdivision::bisectMesh(), oofem::BSplineInterpolation::boundaryEdgeEvalN(), oofem::BSplineInterpolation::boundaryEdgeGiveNodes(), oofem::BSplineInterpolation::boundaryEdgeGiveTransformationJacobian(), oofem::BSplineInterpolation::boundaryEdgeLocal2Global(), oofem::BSplineInterpolation::boundaryEvalN(), oofem::FEInterpolation1d::boundaryEvalNormal(), oofem::BSplineInterpolation::boundaryEvalNormal(), oofem::FEInterpolation1d::boundaryGiveNodes(), oofem::BSplineInterpolation::boundaryGiveNodes(), oofem::BSplineInterpolation::boundaryGiveTransformationJacobian(), oofem::BSplineInterpolation::boundaryLocal2Global(), oofem::FEInterpolation1d::boundarySurfaceEvaldNdx(), oofem::BSplineInterpolation::boundarySurfaceEvaldNdx(), oofem::FEInterpolation1d::boundarySurfaceEvalN(), oofem::BSplineInterpolation::boundarySurfaceEvalN(), oofem::FEInterpolation1d::boundarySurfaceEvalNormal(), oofem::BSplineInterpolation::boundarySurfaceEvalNormal(), oofem::FEInterpolation1d::boundarySurfaceGiveNodes(), oofem::BSplineInterpolation::boundarySurfaceGiveNodes(), oofem::FEInterpolation1d::boundarySurfaceGiveTransformationJacobian(), oofem::BSplineInterpolation::boundarySurfaceGiveTransformationJacobian(), oofem::FEInterpolation1d::boundarySurfaceLocal2global(), oofem::BSplineInterpolation::boundarySurfaceLocal2global(), oofem::PetscSparseMtrx::buildInternalStructure(), oofem::Skyline::buildInternalStructure(), oofem::SparseMtrx::buildInternalStructure(), oofem::NonlocalMaterialExtensionInterface::buildNonlocalPointTable(), oofem::HuertaErrorEstimator::buildRefinedMesh(), oofem::ArcPosSortFunction3< T >::calcArcPos(), oofem::ArcPosSortFunction4::calcArcPos(), oofem::ParmetisLoadBalancer::calculateLoadTransfer(), oofem::ParticleTopologyDescription::calculateShortestDistance(), oofem::StructuralPythonMaterial::callStressFunction(), oofem::StructuralPythonMaterial::callTangentFunction(), oofem::MacroLSpace::changeMicroBoundaryConditions(), oofem::RowColumn::checkBounds(), oofem::SparseMtrx::checkBounds(), oofem::FloatMatrix::checkBounds(), oofem::FloatArray::checkBounds(), oofem::Shell7Base::checkConsistency(), oofem::IntMatBilinearCZFagerstromRate::checkConsistency(), oofem::RigidArmNode::checkConsistency(), oofem::SUPG::checkConsistency(), oofem::NLStructuralElement::checkConsistency(), oofem::ParticleTopologyDescription::checkOverlap(), oofem::RowColumn::checkSizeTowards(), oofem::ConcreteFCM::checkSnapBack(), oofem::CompoDamageMat::checkSnapBack(), oofem::Homogenize::checkVolFraction(), oofem::MPlasticMaterial2::closestPointReturn(), oofem::cltypesGiveUnknownTypeModeKey(), oofem::TR1_2D_SUPG2::computeAccelerationTerm_MB(), oofem::TR1_2D_SUPG2::computeAdvectionDerivativeTerm_MB(), oofem::TR1_2D_SUPG2::computeAdvectionTerm_MB(), oofem::IDNLMaterial::computeAngleAndSigmaRatio(), oofem::FRCFCMNL::computeAngleBetweenVectors(), oofem::Crack::computeArcPoints(), oofem::Element::computeArea(), oofem::TransportElement::computeBCMtrxAt(), oofem::SUPGElement2::computeBCRhsTerm_MB(), oofem::TR1_2D_SUPG2::computeBCRhsTerm_MB(), oofem::SUPGElement2::computeBCRhsTerm_MC(), oofem::TransportElement::computeBCSubMtrxAt(), oofem::TransportElement::computeBCSubVectorAt(), oofem::TransportElement::computeBCVectorAt(), oofem::NLStructuralElement::computeBHmatrixAt(), oofem::LatticeDamage2d::computeBiot(), oofem::TrPlaneStrRot::computeBmatrixAt(), oofem::InterfaceElem1d::computeBmatrixAt(), oofem::LIBeam3dNL2::computeBmatrixAt(), oofem::LIBeam3dNL::computeBmatrixAt(), oofem::TR_SHELL01::computeBmatrixAt(), oofem::TR_SHELL02::computeBmatrixAt(), oofem::AbaqusUserElement::computeBmatrixAt(), oofem::TrPlaneStrRot::computeBodyLoadVectorAt(), oofem::CCTPlate::computeBodyLoadVectorAt(), oofem::TrPlaneStrRot3d::computeBodyLoadVectorAt(), oofem::TrPlanestressRotAllman3d::computeBodyLoadVectorAt(), oofem::DKTPlate3d::computeBodyLoadVectorAt(), oofem::CCTPlate3d::computeBodyLoadVectorAt(), oofem::QDKTPlate::computeBodyLoadVectorAt(), oofem::Quad1PlateSubSoil::computeBodyLoadVectorAt(), oofem::DKTPlate::computeBodyLoadVectorAt(), oofem::Tria1PlateSubSoil::computeBodyLoadVectorAt(), oofem::LineDistributedSpring::computeBodyLoadVectorAt(), oofem::Quad1Mindlin::computeBodyLoadVectorAt(), oofem::Quad1MindlinShell3D::computeBodyLoadVectorAt(), oofem::TR_SHELL02::computeBodyLoadVectorAt(), oofem::Shell7Base::computeBodyLoadVectorAt(), oofem::StructuralElement::computeBodyLoadVectorAt(), oofem::TransportElement::computeBoundaryEdgeLoadVector(), oofem::TrPlanestressRotAllman::computeBoundaryEdgeLoadVector(), oofem::Shell7BaseXFEM::computeBoundaryEdgeLoadVector(), oofem::Beam2d::computeBoundaryEdgeLoadVector(), oofem::Beam3d::computeBoundaryEdgeLoadVector(), oofem::StructuralElement::computeBoundaryEdgeLoadVector(), oofem::Element::computeBoundaryEdgeLoadVector(), oofem::TransportElement::computeBoundarySurfaceLoadVector(), oofem::tet21ghostsolid::computeBoundarySurfaceLoadVector(), oofem::Hexa21Stokes::computeBoundarySurfaceLoadVector(), oofem::Tet21Stokes::computeBoundarySurfaceLoadVector(), oofem::Tr21Stokes::computeBoundarySurfaceLoadVector(), oofem::Tr1BubbleStokes::computeBoundarySurfaceLoadVector(), oofem::Tet1BubbleStokes::computeBoundarySurfaceLoadVector(), oofem::Element::computeBoundarySurfaceLoadVector(), oofem::StructuralElement::computeBoundarySurfaceLoadVector(), oofem::Element::computeBoundaryVectorOf(), oofem::HeMoBazNajMaterial::computeCapacityCoeff(), oofem::HeMoTKMaterial::computeCapacityCoeff(), oofem::HeMoKunzelMaterial::computeCapacityCoeff(), oofem::TransportElement::computeCapacityMatrix(), oofem::NlIsoMoistureMaterial::computeCapTranspCoeff(), oofem::FreeWarping::computeCenterOfGravity(), oofem::RheoChainMaterial::computeCharTimes(), oofem::XfemStructuralElementInterface::computeCohesiveForces(), oofem::XfemStructuralElementInterface::computeCohesiveTangent(), oofem::TransportElement::computeConductivityMatrix(), oofem::HeMoBazNajMaterial::computeConductivityMtrx(), oofem::HeMoTKMaterial::computeConductivityMtrx(), oofem::HeMoKunzelMaterial::computeConductivityMtrx(), oofem::StructuralElementEvaluator::computeConsistentMassMatrix(), oofem::Tr2Shell7XFEM::computeConstitutiveMatrixAt(), oofem::HTSelement::computeConstitutiveMatrixAt(), oofem::Tr2Shell7::computeConstitutiveMatrixAt(), oofem::TR_SHELL01::computeConstitutiveMatrixAt(), oofem::TR_SHELL02::computeConstitutiveMatrixAt(), oofem::AbaqusUserElement::computeConstitutiveMatrixAt(), oofem::Crack::computeCrackIntersectionPoints(), oofem::FRCFCM::computeCrackSpacing(), oofem::KelvinChainSolidMaterial::computeCreepFunction(), oofem::Eurocode2CreepMaterial::computeCreepParams(), oofem::ConcreteFCM::computeD2ModulusForCrack(), oofem::TrabBone3D::computeDamage(), oofem::MPSDamMaterial::computeDamageForCohesiveCrack(), oofem::MDM::computeDamageOnPlane(), oofem::TrabBoneMaterial::computeDamageParam(), oofem::LatticeDamage2d::computeDamageParam(), oofem::ConcreteDPM::computeDamageParam(), oofem::ConcreteDPM2::computeDamageParamCompression(), oofem::IsotropicDamageMaterial1::computeDamageParamForCohesiveCrack(), oofem::ConcreteDPM2::computeDamageParamTension(), oofem::FRCFCMNL::computeDebondedLength(), oofem::GradDpElement::computeDeformationGradientVector(), oofem::NLStructuralElement::computeDeformationGradientVector(), oofem::tet21ghostsolid::computeDeformationGradientVectorFromDispl(), oofem::CylindricalALM::computeDeltaLambda(), oofem::BinghamFluidMaterial2::computeDeviatoricStrain(), oofem::BinghamFluidMaterial2::computeDeviatoricStress(), oofem::NewtonianFluidMaterial::computeDeviatoricStressVector(), oofem::FE2FluidMaterial::computeDeviatoricStressVector(), oofem::StressVector::computeDeviatoricVolumetricSplit(), oofem::StrainVector::computeDeviatoricVolumetricSplit(), oofem::StressVector::computeDeviatoricVolumetricSum(), oofem::StrainVector::computeDeviatoricVolumetricSum(), oofem::BinghamFluidMaterial2::computeDevStrainMagnitude(), oofem::BinghamFluidMaterial2::computeDevStressMagnitude(), oofem::TR1_2D_SUPG2::computeDiffusionDerivativeTerm_MB(), oofem::TR1_2D_SUPG2::computeDiffusionTerm_MB(), oofem::SolutionbasedShapeFunction::computeDofTransformation(), oofem::MixedGradientPressureDirichlet::computeDofTransformation(), oofem::ActiveBoundaryCondition::computeDofTransformation(), oofem::HeMoKunzelMaterial::computeDw(), oofem::TR1_2D_PFEM::computeEdgeBCSubVectorAt(), oofem::TransportElement::computeEdgeBCSubVectorAt(), oofem::SUPGElement2::computeEdgeLoadVector_MB(), oofem::SUPGElement2::computeEdgeLoadVector_MC(), oofem::LIBeam2d::computeEdgeVolumeAround(), oofem::LIBeam2dNL::computeEdgeVolumeAround(), oofem::LIBeam3d::computeEdgeVolumeAround(), oofem::Truss3d::computeEdgeVolumeAround(), oofem::LIBeam3dNL2::computeEdgeVolumeAround(), oofem::LIBeam3dNL::computeEdgeVolumeAround(), oofem::Truss2d::computeEdgeVolumeAround(), oofem::LIBeam3d2::computeEdgeVolumeAround(), oofem::ConcreteFCM::computeEffectiveShearModulus(), oofem::FRCFCM::computeEffectiveShearModulus(), oofem::Eurocode2CreepMaterial::computeElasticityStrengthParams(), oofem::WeakPeriodicBoundaryCondition::computeElementTangent(), oofem::Shell7BaseXFEM::computeEnrTractionForce(), oofem::IsotropicDamageMaterial1::computeEquivalentStrain(), oofem::AnisotropicDamageMaterial::computeEquivalentStrain(), oofem::MPSMaterial::computeEquivalentTime(), oofem::IsotropicDamageMaterial::computeEta(), oofem::IsotropicDamageMaterial1::computeEta(), oofem::Tet1BubbleStokes::computeExternalForcesVector(), oofem::NonLinearStatic::computeExternalLoadReactionContribution(), oofem::FRCFCM::computeFiberBond(), oofem::MacroLSpace::computeField(), oofem::AbaqusUserElement::computeField(), oofem::Element::computeField(), oofem::TransportElement::computeFlow(), oofem::B3SolidMaterial::computeFlowTermViscosity(), oofem::MPSMaterial::computeFlowTermViscosity(), oofem::Tr2Shell7::computeGaussPoints(), oofem::MazarsMaterial::computeGc(), oofem::XfemStructuralElementInterface::computeGlobalCohesiveTractionVector(), oofem::MazarsMaterial::computeGt(), oofem::HydrationModel::computeHydrationDegreeIncrement(), oofem::StructuralElement::computeInitialStressMatrix(), oofem::Beam3d::computeInternalForcesFromBodyLoadVectorAtPoint(), oofem::Beam3d::computeInternalForcesFromBoundaryEdgeLoadVectorAtPoint(), oofem::TransportElement::computeInternalSourceRhsVectorAt(), oofem::HydratingConcreteMat::computeInternalSourceVector(), oofem::CemhydMat::computeInternalSourceVector(), oofem::Quasicontinuum::computeIntersectionsOfLinkWithInterpElements(), oofem::HydrationModel::computeIntSource(), oofem::TransportElement::computeIntSourceLHSMatrix(), oofem::Node::computeL2GTransformation(), oofem::Element::computeLength(), oofem::Structural3DElement::computeLoadLEToLRotationMatrix(), oofem::Structural3DElement::computeLoadLSToLRotationMatrix(), oofem::tet21ghostsolid::computeLoadVector(), oofem::Node::computeLoadVector(), oofem::Element::computeLoadVector(), oofem::DofManager::computeLoadVector(), oofem::SurfaceTensionBoundaryCondition::computeLoadVectorFromElement(), oofem::IntElSurfTr1::computeLocalCoordinates(), oofem::InterfaceElement3dTrLin::computeLocalCoordinates(), oofem::InterfaceElem1d::computeLocalCoordinates(), oofem::BasicGeometry::computeLocalCoordinates(), oofem::MDM::computeLocalDamageTensor(), oofem::FEI2dQuadConst::computeLocalEdgeMapping(), oofem::FEI2dTrConst::computeLocalEdgeMapping(), oofem::FEI2dQuadLin::computeLocalEdgeMapping(), oofem::FEI2dTrQuad::computeLocalEdgeMapping(), oofem::FEI2dTrLin::computeLocalEdgeMapping(), oofem::FEI3dHexaLin::computeLocalEdgeMapping(), oofem::FEI3dLineLin::computeLocalEdgeMapping(), oofem::FEI3dTetLin::computeLocalEdgeMapping(), oofem::FEI2dLineLin::computeLocalEdgeMapping(), oofem::FEI3dTrLin::computeLocalEdgeMapping(), oofem::FEI3dWedgeQuad::computeLocalEdgeMapping(), oofem::FEI2dQuadQuad::computeLocalEdgeMapping(), oofem::FEI3dTetQuad::computeLocalEdgeMapping(), oofem::FEI3dTrQuad::computeLocalEdgeMapping(), oofem::FEI3dWedgeLin::computeLocalEdgeMapping(), oofem::FEI3dHexaQuad::computeLocalEdgeMapping(), oofem::BeamBaseElement::computeLocalForceLoadVector(), oofem::InterfaceElem1d::computeLocalSlipDir(), oofem::IntElPoint::computeLocalSlipDir(), oofem::FEI3dHexaTriQuad::computeLocalSurfaceMapping(), oofem::FEI3dLineLin::computeLocalSurfaceMapping(), oofem::FEI3dHexaLin::computeLocalSurfaceMapping(), oofem::FEI3dTetLin::computeLocalSurfaceMapping(), oofem::FEI3dWedgeQuad::computeLocalSurfaceMapping(), oofem::FEI3dWedgeLin::computeLocalSurfaceMapping(), oofem::FEI3dTetQuad::computeLocalSurfaceMapping(), oofem::FEI3dHexaQuad::computeLocalSurfaceMapping(), oofem::TR1_2D_SUPG2::computeLSICStabilizationTerm_MB(), oofem::LineDistributedSpring::computeLumpedMassMatrix(), oofem::Quad1PlateSubSoil::computeLumpedMassMatrix(), oofem::Tria1PlateSubSoil::computeLumpedMassMatrix(), oofem::StructuralElementEvaluator::computeLumpedMassMatrix(), oofem::StructuralElement::computeLumpedMassMatrix(), oofem::Shell7Base::computeLumpedMassMatrix(), oofem::TR_SHELL01::computeMassMatrix(), oofem::TR_SHELL02::computeMassMatrix(), oofem::NlDEIDynamic::computeMassMtrx(), oofem::RigidArmNode::computeMasterContribution(), oofem::MaterialForceEvaluator::computeMaterialForce(), oofem::B3SolidMaterial::computeMicroPrestress(), oofem::Element::computeMidPlaneNormal(), oofem::IntElPoint::computeNmatrixAt(), oofem::TR_SHELL01::computeNmatrixAt(), oofem::TR_SHELL02::computeNmatrixAt(), oofem::FRCFCMNL::computeNonlocalStressInFibers(), oofem::FRCFCMNL::computeNonlocalStressInFibersInUncracked(), oofem::FloatMatrix::computeNorm(), oofem::SparseMtrx::computeNorm(), oofem::Line::computeNormalSignDist(), oofem::Triangle::computeNormalSignDist(), oofem::PointSwarm::computeNormalSignDist(), oofem::IntElPoint::computeNumberOfDofs(), oofem::InterfaceElem1d::computeNumberOfDofs(), oofem::FRCFCM::computeOverallElasticStiffness(), oofem::SPRNodalRecoveryModel::computePolynomialTerms(), oofem::MMALeastSquareProjection::computePolynomialTerms(), oofem::Shell7Base::computePressureForceAt(), oofem::TR1_2D_SUPG2_AXI::computePressureTerm_MC(), oofem::TR1_2D_SUPG2::computePressureTerm_MC(), oofem::MPSMaterial::computePsiE(), oofem::MPSMaterial::computePsiR(), oofem::MPSMaterial::computePsiS(), oofem::DustMaterial::computeQFromPlastVolEps(), oofem::FloatMatrix::computeReciprocalCondition(), oofem::DruckerPragerCutMat::computeReducedSSGradientMatrix(), oofem::StructuralElement::computeResultingIPEigenstrainAt(), oofem::StructuralElement::computeResultingIPTemperatureAt(), oofem::LIBeam3d2::computeRotMtrx(), oofem::LIBeam3dNL::computeRotMtrx(), oofem::LIBeam3dNL2::computeRotMtrx(), oofem::FCMMaterial::computeShearSlipOnCrack(), oofem::Eurocode2CreepMaterial::computeShrinkageParams(), oofem::B3Material::computeShrinkageStrainVector(), oofem::LIBeam3d2::computeSMtrx(), oofem::LIBeam3dNL::computeSMtrx(), oofem::LIBeam3dNL2::computeSMtrx(), oofem::MacroLSpace::computeStiffnessMatrix(), oofem::tet21ghostsolid::computeStiffnessMatrix(), oofem::IntElLine1IntPen::computeStiffnessMatrix(), oofem::IntElLine2IntPen::computeStiffnessMatrix(), oofem::StructuralInterfaceElement::computeStiffnessMatrix(), oofem::NLStructuralElement::computeStiffnessMatrix(), oofem::TR_SHELL02::computeStiffnessMatrix(), oofem::TR_SHELL01::computeStiffnessMatrix(), oofem::GradDpElement::computeStiffnessMatrix_kk(), oofem::GradDpElement::computeStiffnessMatrix_ku(), oofem::GradDpElement::computeStiffnessMatrix_uk(), oofem::GradDpElement::computeStiffnessMatrix_uu(), oofem::IntElLine1PF::computeStiffnessMatrix_uu(), oofem::Quasicontinuum::computeStiffnessTensorOf1Link(), oofem::Shell7Base::computeStrainVectorInLayer(), oofem::StructuralMaterial::computeStressIndependentStrainVector(), oofem::LatticeDamage2d::computeStressIndependentStrainVector(), oofem::StructuralMaterial::computeStressIndependentStrainVector_3d(), oofem::FRCFCM::computeStressInFibersInCracked(), oofem::Tr2Shell7XFEM::computeStressVector(), oofem::Tr2Shell7::computeStressVector(), oofem::TR_SHELL01::computeStressVector(), oofem::TR_SHELL02::computeStressVector(), oofem::AbaqusUserElement::computeStressVector(), oofem::GradDpElement::computeStressVectorAndLocalCumulatedStrain(), oofem::TransportElement::computeSurfaceBCSubVectorAt(), oofem::SUPGElement2::computeSurfaceLoadVector_MB(), oofem::SUPGElement2::computeSurfaceLoadVector_MC(), oofem::CCTPlate::computeSurfaceNMatrix(), oofem::StructuralFE2MaterialStatus::computeTangent(), oofem::PrescribedGradientBCNeumann::computeTangent(), oofem::TransportGradientNeumann::computeTangent(), oofem::TransportGradientPeriodic::computeTangent(), oofem::PrescribedGradient::computeTangent(), oofem::PrescribedGenStrainShell7::computeTangent(), oofem::TransportGradientDirichlet::computeTangent(), oofem::PrescribedGradientBCWeak::computeTangent(), oofem::TransportElement::computeTangentFromEdgeLoad(), oofem::SurfaceTensionBoundaryCondition::computeTangentFromElement(), oofem::TransportElement::computeTangentFromSurfaceLoad(), oofem::Triangle::computeTangentialSignDist(), oofem::PointSwarm::computeTangentialSignDist(), oofem::FE2FluidMaterialStatus::computeTangents(), oofem::MixedGradientPressureWeakPeriodic::computeTangents(), oofem::MixedGradientPressureDirichlet::computeTangents(), oofem::MixedGradientPressureNeumann::computeTangents(), oofem::FRCFCM::computeTempDamage(), oofem::FCMMaterial::computeTotalD2Modulus(), oofem::QClinearStatic::computeTotalVolumeOfInterpolationMesh(), oofem::AnisotropicDamageMaterial::computeTraceD(), oofem::Shell7Base::computeTractionForce(), oofem::IntElPoint::computeTransformationMatrixAt(), oofem::PlasticMaterial::computeTrialStressIncrement(), oofem::ConstantEdgeLoad::computeValueAt(), oofem::InteractionLoad::computeValueAt(), oofem::ConstantPressureLoad::computeValueAt(), oofem::ConstantSurfaceLoad::computeValueAt(), oofem::NeumannMomentLoad::computeValueAt(), oofem::ForeignTemperatureFieldLoad::computeValueAt(), oofem::UserDefinedTemperatureField::computeValueAt(), oofem::BoundaryLoad::computeValueAt(), oofem::ConstantPressureLoad::computeValues(), oofem::Element::computeVolume(), oofem::StressStrainBaseVector::computeVolumetricPart(), oofem::DruckerPragerPlasticitySM::computeYieldStressInShear(), oofem::DruckerPragerPlasticitySM::computeYieldStressPrime(), oofem::StructuralElement::condense(), oofem::MixedGradientPressureWeakPeriodic::constructFullMatrixForm(), oofem::ContactElement::ContactElement(), oofem::StressStrainBaseVector::convertFromFullForm(), oofem::SuperLUSolver::convertRhs(), oofem::FloatMatrix::copyColumn(), oofem::StructuralFE2MaterialStatus::copyStateVariables(), oofem::Homogenize::counto(), oofem::Domain::createDofs(), oofem::Quasicontinuum::createGlobalStiffnesMatrix(), oofem::FreemInterface::createInput(), oofem::T3DInterface::createInput(), oofem::Subdivision::createMesh(), oofem::T3DInterface::createQCInterpolationMesh(), oofem::StructuralFE2MaterialStatus::createRVE(), oofem::FE2FluidMaterialStatus::createRVE(), oofem::CemhydMat::CreateStatus(), oofem::PrescribedGradientBCWeak::createTractionMesh(), oofem::T3DInterface::createVTKExportMesh(), oofem::IsotropicDamageMaterial::damageFunctionPrime(), oofem::IsotropicDamageMaterial1::damageFunctionPrime(), oofem::PFEM::deactivateTooCloseParticles(), oofem::WallClockLoadBalancerMonitor::decide(), oofem::LoadBalancer::deleteRemoteDofManagers(), oofem::DIIDynamic::determineConstants(), oofem::NonLinearDynamic::determineConstants(), oofem::SPRNodalRecoveryModel::determinePatchType(), oofem::CemhydMatStatus::distrib3d(), oofem::GPInitModule::doInit(), oofem::LEPlic::doInterfaceRemapping(), oofem::LEPlic::doLagrangianPhase(), oofem::PrescribedGradientHomogenization::domainSize(), oofem::TopologyDescription::doOutput(), oofem::ErrorCheckingExportModule::doOutput(), oofem::MatlabExportModule::doOutputReactionForces(), oofem::FloatArray::dotProduct(), oofem::drawIGAPatchDeformedGeometry(), oofem::IGAElement::drawRawGeometry(), oofem::BsplinePlaneStressElement::drawScalar(), oofem::NURBSPlaneStressElement::drawScalar(), oofem::TSplinePlaneStressElement::drawScalar(), oofem::NURBSSpace3dElement::drawScalar(), oofem::Lattice2d::drawYourself(), oofem::Lattice2d_mt::drawYourself(), oofem::Element::drawYourself(), oofem::Concrete2::dtp2(), oofem::Concrete2::dtp3(), oofem::FEI2dLineQuad::edgeComputeLength(), oofem::FEI3dTrLin::edgeComputeLength(), oofem::FEI3dTetQuad::edgeComputeLength(), oofem::FEI3dTrQuad::edgeComputeLength(), oofem::FEI2dQuadConst::edgeEvaldNds(), oofem::FEI3dWedgeQuad::edgeEvaldNdx(), oofem::FEI3dTrLin::edgeEvaldNdx(), oofem::FEI3dTrQuad::edgeEvaldNdx(), oofem::FEI3dTetQuad::edgeEvaldNdx(), oofem::FEI3dWedgeLin::edgeEvaldNdx(), oofem::FEInterpolation3d::edgeEvaldNdxi(), oofem::FEI2dQuadConst::edgeEvalNormal(), oofem::FEI2dTrConst::edgeEvalNormal(), oofem::FEI3dTrLin::edgeGiveTransformationJacobian(), oofem::FEI3dWedgeQuad::edgeGiveTransformationJacobian(), oofem::FEI3dTetQuad::edgeGiveTransformationJacobian(), oofem::FEI3dWedgeLin::edgeGiveTransformationJacobian(), oofem::FEI2dQuadConst::edgeLocal2global(), oofem::EigenValueErrorCheckingRule::EigenValueErrorCheckingRule(), oofem::TR1_2D_CBS::EIPrimaryFieldI_evaluateFieldVectorAt(), oofem::TransportElement::EIPrimaryFieldI_evaluateFieldVectorAt(), oofem::TR1_2D_SUPG2::EIPrimaryFieldI_evaluateFieldVectorAt(), oofem::TR1_2D_SUPG::EIPrimaryFieldI_evaluateFieldVectorAt(), oofem::EIPrimaryUnknownMapperInterface::EIPrimaryUnknownMI_computePrimaryUnknownVectorAtLocal(), oofem::ElementErrorCheckingRule::ElementErrorCheckingRule(), oofem::NonlocalMaterialExtensionInterface::endIPNonlocalAverage(), oofem::ZZErrorEstimator::estimateError(), oofem::HuertaErrorEstimator::estimateError(), oofem::ZZRemeshingCriteria::estimateMeshDensities(), oofem::HuertaRemeshingCriteria::estimateMeshDensities(), oofem::FiberedCrossSection::estimatePackSize(), oofem::LayeredCrossSection::estimatePackSize(), oofem::ScalarFunction::eval(), oofem::FEInterpolation::evald2Ndx2(), oofem::NURBSInterpolation::evaldNdx(), oofem::FEI3dTetLin::evaldNdx(), oofem::FEI3dTrLin::evaldNdx(), oofem::FEI3dTrQuad::evaldNdx(), oofem::TSplineInterpolation::evaldNdx(), oofem::BSplineInterpolation::evaldNdx(), oofem::FEInterpolation::evaldNdxi(), oofem::Delamination::evalGradLevelSetNormal(), oofem::Delamination::evalLevelSetTangential(), oofem::NURBSInterpolation::evalN(), oofem::TSplineInterpolation::evalN(), oofem::BSplineInterpolation::evalN(), oofem::FEInterpolation::evalNXIntegral(), oofem::InterpolatingFuction::evaluate(), oofem::CalculatorFunction::evaluate(), oofem::Function::evaluate(), oofem::LocalGaussianRandomFunction::evaluateAccelerationAtTime(), oofem::CalculatorFunction::evaluateAccelerationAtTime(), oofem::UniformGridField::evaluateAt(), oofem::UnstructuredGridField::evaluateAt(), oofem::InterpolatingFuction::evaluateAtTime(), oofem::PiecewiseLinFunction::evaluateAtTime(), oofem::PeriodicPiecewiseLinFunction::evaluateAtTime(), oofem::CalculatorFunction::evaluateAtTime(), oofem::Function::evaluateAtTime(), oofem::EnrFrontLinearBranchFuncOneEl::evaluateEnrFuncAt(), oofem::EnrFrontCohesiveBranchFuncOneEl::evaluateEnrFuncAt(), oofem::Delamination::evaluateEnrFuncAt(), oofem::Delamination::evaluateEnrFuncDerivAt(), oofem::Delamination::evaluateEnrFuncInNode(), oofem::FractureManager::evaluateFailureCriterias(), oofem::PrescribedGenStrainShell7::evaluateHigherOrderContribution(), oofem::Shell7BaseXFEM::evaluateLevelSet(), oofem::InterfaceElem1d::evaluateLocalCoordinateSystem(), oofem::LocalGaussianRandomFunction::evaluateVelocityAtTime(), oofem::PiecewiseLinFunction::evaluateVelocityAtTime(), oofem::PeriodicPiecewiseLinFunction::evaluateVelocityAtTime(), oofem::CalculatorFunction::evaluateVelocityAtTime(), oofem::EngngModel::exchangeRemoteElementData(), oofem::Subdivision::exchangeSharedEdges(), oofem::VTKExportModule::exportCellVars(), oofem::VTKXMLExportModule::exportIntVarsInGpAs(), oofem::POIExportModule::exportPrimVarAs(), oofem::VTKExportModule::exportPrimVarAs(), oofem::FE2FluidMaterialStatus::FE2FluidMaterialStatus(), oofem::FETICommunicator::FETICommunicator(), oofem::LEPlic::findCellLineConstant(), oofem::GaussPoint::findFirstIndexOfSlaveGaussPoint(), oofem::QClinearStatic::findNearestParticle(), oofem::PrescribedGradientBCPeriodic::findSlaveToMasterMap(), oofem::TransportGradientPeriodic::findSlaveToMasterMap(), oofem::OctreeSpatialLocalizer::findTerminalContaining(), oofem::Shell7Base::fitRecoveredStress2BC(), oofem::FloatMatrix::FloatMatrix(), oofem::MDM::formTransformationMatrix(), oofem::Subdivision::RS_Triangle::generate(), oofem::Subdivision::RS_Tetra::generate(), oofem::QClinearStatic::generateInterpolationMesh(), oofem::Parser::get_token(), oofem::PythonExpression::getDict(), oofem::IntegrationRule::getIntegrationPoint(), oofem::VTKXMLExportModule::getNodalVariableFromIS(), oofem::VTKXMLExportModule::getNodalVariableFromPrimaryField(), oofem::VTKXMLExportModule::getNodalVariableFromXFEMST(), oofem::ParticleGrid< Point >::getPointsWithin(), oofem::LobattoIntegrationRule::getRequiredNumberOfIntegrationPoints(), oofem::GaussIntegrationRule::getRequiredNumberOfIntegrationPoints(), oofem::PythonExpression::getScalar(), oofem::PrescribedGradient::give(), oofem::RotatingBoundary::give(), oofem::PrescribedGenStrainShell7::give(), oofem::UserDefDirichletBC::give(), oofem::TransportGradientDirichlet::give(), oofem::BoundaryCondition::give(), oofem::VariableCrossSection::give(), oofem::Material::give(), oofem::FiberedCrossSection::give(), oofem::CrossSection::give(), oofem::PerfectlyPlasticMaterial::give(), oofem::RCM2Material::give(), oofem::StructuralInterfaceCrossSection::give1dStiffnessMatrix_dTdj(), oofem::StructuralInterfaceCrossSection::give1dStiffnessMatrix_Eng(), oofem::CebFipSlip90Material::give1dStiffnessMatrix_Eng(), oofem::RankineMat::give1dStressStiffMtrx(), oofem::StructuralMaterial::give1dStressStiffMtrx_dCde(), oofem::FiberedCrossSection::give2dBeamStiffMtrx(), oofem::LayeredCrossSection::give2dBeamStiffMtrx(), oofem::StructuralMaterial::give2dLatticeStiffMtrx(), oofem::FiberedCrossSection::give2dPlateStiffMtrx(), oofem::FiberedCrossSection::give2dPlateSubSoilStiffMtrx(), oofem::LayeredCrossSection::give2dPlateSubSoilStiffMtrx(), oofem::StructuralMaterial::give2dPlateSubSoilStiffMtrx(), oofem::StructuralInterfaceCrossSection::give2dStiffnessMatrix_dTdj(), oofem::StructuralInterfaceCrossSection::give2dStiffnessMatrix_Eng(), oofem::LayeredCrossSection::give3dBeamStiffMtrx(), oofem::WinklerMaterial::give3dBeamSubSoilStiffMtrx(), oofem::StructuralMaterial::give3dBeamSubSoilStiffMtrx(), oofem::StructuralCrossSection::give3dDegeneratedShellStiffMtrx(), oofem::StructuralMaterial::give3dLatticeStiffMtrx(), oofem::MooneyRivlinMaterial::give3dMaterialStiffnessMatrix(), oofem::PlasticMaterial::give3dMaterialStiffnessMatrix(), oofem::StructuralFE2Material::give3dMaterialStiffnessMatrix(), oofem::PerfectlyPlasticMaterial::give3dMaterialStiffnessMatrix(), oofem::MPlasticMaterial::give3dMaterialStiffnessMatrix(), oofem::MPlasticMaterial2::give3dMaterialStiffnessMatrix(), oofem::DruckerPragerPlasticitySM::give3dMaterialStiffnessMatrix(), oofem::StructuralMaterial::give3dMaterialStiffnessMatrix(), oofem::DustMaterial::give3dMaterialStiffnessMatrix(), oofem::StructuralMaterial::give3dMaterialStiffnessMatrix_dCde(), oofem::FiberedCrossSection::give3dShellStiffMtrx(), oofem::StructuralInterfaceCrossSection::give3dStiffnessMatrix_dTdj(), oofem::ExpCZMaterial::give3dStiffnessMatrix_Eng(), oofem::StructuralInterfaceCrossSection::give3dStiffnessMatrix_Eng(), oofem::HeMoTKMaterial::give_delta_gw(), oofem::ActiveDof::giveActiveBoundaryCondition(), oofem::OctreeSpatialLocalizer::giveAllElementsWithIpWithinBox(), oofem::FEInterpolation2d::giveArea(), oofem::MasterDof::giveBc(), oofem::Domain::giveBc(), oofem::RefinedElement::giveBcDofArray2D(), oofem::RefinedElement::giveBcDofArray3D(), oofem::PrescribedGradientBCPeriodic::giveBcValue(), oofem::MixedGradientPressureDirichlet::giveBcValue(), oofem::BSplineInterpolation::giveBoundaryEdgeIntegrationRule(), oofem::RefinedElement::giveBoundaryFlagArray(), oofem::FEI3dLineLin::giveBoundaryIntegrationRule(), oofem::FEI3dTrLin::giveBoundaryIntegrationRule(), oofem::FEI3dTrQuad::giveBoundaryIntegrationRule(), oofem::FEInterpolation3d::giveBoundaryIntegrationRule(), oofem::BSplineInterpolation::giveBoundaryIntegrationRule(), oofem::RefinedElement::giveBoundaryLoadArray2D(), oofem::RefinedElement::giveBoundaryLoadArray3D(), oofem::Tr2Shell7::giveBoundaryLocationArray(), oofem::ListBasedEI::giveBoundingSphere(), oofem::BasicGeometry::giveBoundingSphere(), oofem::FiberedCrossSection::giveCauchyStresses(), oofem::LayeredCrossSection::giveCauchyStresses(), oofem::StructuralMaterial::giveCauchyStressVector_1d(), oofem::StructuralMaterial::giveCauchyStressVector_3d(), oofem::StructuralMaterial::giveCauchyStressVector_PlaneStrain(), oofem::StructuralMaterial::giveCauchyStressVector_PlaneStress(), oofem::GradDpMaterialExtensionInterface::giveCauchyStressVectorGrad(), oofem::VTKExportModule::giveCellType(), oofem::VTKXMLExportModule::giveCellType(), oofem::Element::giveCharacteristicLength(), oofem::IsotropicMoistureTransferMaterial::giveCharacteristicMatrix(), oofem::StructuralElementEvaluator::giveCharacteristicMatrix(), oofem::TransportElement::giveCharacteristicMatrix(), oofem::SUPGElement2::giveCharacteristicMatrix(), oofem::Tr1Darcy::giveCharacteristicMatrix(), oofem::CBSElement::giveCharacteristicMatrix(), oofem::IsotropicHeatTransferMaterial::giveCharacteristicMatrix(), oofem::NonlinearMassTransferMaterial::giveCharacteristicMatrix(), oofem::AnisotropicMassTransferMaterial::giveCharacteristicMatrix(), oofem::Hexa21Stokes::giveCharacteristicMatrix(), oofem::PFEMElement::giveCharacteristicMatrix(), oofem::Tet21Stokes::giveCharacteristicMatrix(), oofem::SUPGElement::giveCharacteristicMatrix(), oofem::Tr21Stokes::giveCharacteristicMatrix(), oofem::Tr1BubbleStokes::giveCharacteristicMatrix(), oofem::StructuralInterfaceElement::giveCharacteristicMatrix(), oofem::Tet1BubbleStokes::giveCharacteristicMatrix(), oofem::HeMoBazNajMaterial::giveCharacteristicMatrix(), oofem::HeMoTKMaterial::giveCharacteristicMatrix(), oofem::StructuralElement::giveCharacteristicMatrix(), oofem::HeMoKunzelMaterial::giveCharacteristicMatrix(), oofem::Element::giveCharacteristicMatrix(), oofem::PlaneStress2d::giveCharacteristicSize(), oofem::TrPlaneStress2d::giveCharacteristicSize(), oofem::TrPlaneStrRot3d::giveCharacteristicTensor(), oofem::RerShell::giveCharacteristicTensor(), oofem::TrPlanestressRotAllman3d::giveCharacteristicTensor(), oofem::DKTPlate3d::giveCharacteristicTensor(), oofem::CCTPlate3d::giveCharacteristicTensor(), oofem::LinQuad3DPlaneStress::giveCharacteristicTensor(), oofem::MITC4Shell::giveCharacteristicTensor(), oofem::IsotropicMoistureTransferMaterial::giveCharacteristicValue(), oofem::HydratingHeMoMaterial::giveCharacteristicValue(), oofem::AnisotropicMassTransferMaterial::giveCharacteristicValue(), oofem::IsotropicHeatTransferMaterial::giveCharacteristicValue(), oofem::HydratingConcreteMat::giveCharacteristicValue(), oofem::HydratingIsoHeatMaterial::giveCharacteristicValue(), oofem::CemhydMat::giveCharacteristicValue(), oofem::LatticeTransportMaterial::giveCharacteristicValue(), oofem::HydrationModel::giveCharacteristicValue(), oofem::Element::giveCharacteristicValue(), oofem::TransportElement::giveCharacteristicVector(), oofem::Tr1Darcy::giveCharacteristicVector(), oofem::SUPGElement2::giveCharacteristicVector(), oofem::CBSElement::giveCharacteristicVector(), oofem::Hexa21Stokes::giveCharacteristicVector(), oofem::Tet21Stokes::giveCharacteristicVector(), oofem::PFEMElement::giveCharacteristicVector(), oofem::SUPGElement::giveCharacteristicVector(), oofem::Tr21Stokes::giveCharacteristicVector(), oofem::Tr1BubbleStokes::giveCharacteristicVector(), oofem::Tet1BubbleStokes::giveCharacteristicVector(), oofem::StructuralInterfaceElement::giveCharacteristicVector(), oofem::StructuralElement::giveCharacteristicVector(), oofem::Element::giveCharacteristicVector(), oofem::FiberedCrossSection::giveCharMaterialStiffnessMatrix(), oofem::LayeredCrossSection::giveCharMaterialStiffnessMatrix(), oofem::OctantRec::giveChild(), oofem::OctantRecT< oofem::UnstructuredGridField::Cell >::giveChild(), oofem::OctreeSpatialLocalizer::giveClosestIP(), oofem::OctreeSpatialLocalizer::giveClosestIPWithinOctant(), oofem::FETIBoundaryDofManager::giveCodeNumber(), oofem::RefinedElement::giveCompatibleBcDofArray(), oofem::HydratingConcreteMat::giveConcreteCapacity(), oofem::CemhydMat::giveConcreteCapacity(), oofem::HydratingConcreteMat::giveConcreteDensity(), oofem::CemhydMat::giveConcreteDensity(), oofem::Domain::giveContactManager(), oofem::SpoolesSparseMtrx::GiveCopy(), oofem::Skyline::GiveCopy(), oofem::RowColumn::GiveCopy(), oofem::SparseMtrx::GiveCopy(), oofem::FiberedCrossSection::giveCorrespondingSlaveMaterialMode(), oofem::LayeredCrossSection::giveCorrespondingSlaveMaterialMode(), oofem::ConcreteFCM::giveCrackingModulus(), oofem::FRCFCM::giveCrackingModulus(), oofem::Domain::giveCrossSection(), oofem::Element::giveCrossSection(), oofem::VTKXMLExportModule::giveDataHeaders(), oofem::Domain::giveDefaultNodeDofIDArry(), oofem::FloatMatrix::giveDeterminant(), oofem::NewtonianFluidMaterial::giveDeviatoricStiffnessMatrix(), oofem::BinghamFluidMaterial2::giveDeviatoricStiffnessMatrix(), oofem::FE2FluidMaterial::giveDeviatoricStiffnessMatrix(), oofem::MITC4Shell::giveDirectorVectors(), oofem::TransientTransportProblem::giveDiscreteTime(), oofem::IncrementalLinearStatic::giveDiscreteTime(), oofem::NonStationaryTransportProblem::giveDiscreteTime(), oofem::StaggeredProblem::giveDiscreteTime(), oofem::MicroMaterial::giveDofEquationNumber(), oofem::Domain::giveDofManager(), oofem::Element::giveDofManager(), oofem::TransportElement::giveDofManDofIDMask(), oofem::IntElPoint::giveDofManDofIDMask(), oofem::Tr_Warp::giveDofManDofIDMask(), oofem::Domain::giveDofManPlaceInArray(), oofem::DofManager::giveDofWithID(), oofem::EngngModel::giveDomain(), oofem::StructuralInterfaceMaterialPhF::giveDrivingForce(), oofem::StructuralInterfaceMaterialPhF::giveDrivingForcePrime(), oofem::Tr_Warp::giveEdgeDofMapping(), oofem::Tr2Shell7XFEM::giveEdgeDofMapping(), oofem::Tr2Shell7::giveEdgeDofMapping(), oofem::LIBeam2d::giveEdgeDofMapping(), oofem::DKTPlate3d::giveEdgeDofMapping(), oofem::CCTPlate::giveEdgeDofMapping(), oofem::LIBeam2dNL::giveEdgeDofMapping(), oofem::LIBeam3d::giveEdgeDofMapping(), oofem::Truss3d::giveEdgeDofMapping(), oofem::TrPlanestressRotAllman::giveEdgeDofMapping(), oofem::LIBeam3dNL2::giveEdgeDofMapping(), oofem::LIBeam3dNL::giveEdgeDofMapping(), oofem::Quad1Mindlin::giveEdgeDofMapping(), oofem::Truss2d::giveEdgeDofMapping(), oofem::QDKTPlate::giveEdgeDofMapping(), oofem::DKTPlate::giveEdgeDofMapping(), oofem::LIBeam3d2::giveEdgeDofMapping(), oofem::PFEMElement2d::giveEdgeDofMapping(), oofem::Quad1MindlinShell3D::giveEdgeDofMapping(), oofem::MITC4Shell::giveEdgeDofMapping(), oofem::Subdivision::RS_Triangle::giveEdgeIndex(), oofem::Subdivision::RS_Tetra::giveEdgeIndex(), oofem::RCSDEMaterial::giveEffectiveMaterialStiffnessMatrix(), oofem::RCSDMaterial::giveEffectiveMaterialStiffnessMatrix(), oofem::PerfectlyPlasticMaterial::giveEffectiveMaterialStiffnessMatrix(), oofem::KelvinChainMaterial::giveEigenStrainVector(), oofem::KelvinChainSolidMaterial::giveEigenStrainVector(), oofem::MaxwellChainMaterial::giveEigenStrainVector(), oofem::B3SolidMaterial::giveEigenStrainVector(), oofem::MPSMaterial::giveEigenStrainVector(), oofem::Domain::giveElement(), oofem::VTKExportModule::giveElementCell(), oofem::VTKXMLExportModule::giveElementCell(), oofem::Domain::giveElementPlaceInArray(), oofem::OctreeSpatialLocalizer::giveElementsWithIPWithinBox(), oofem::Domain::giveElementsWithMaterialNum(), oofem::KelvinChainSolidMaterial::giveEModulus(), oofem::KelvinChainMaterial::giveEModulus(), oofem::MaxwellChainMaterial::giveEModulus(), oofem::Eurocode2CreepMaterial::giveEModulus(), oofem::MPSMaterial::giveEModulus(), oofem::Domain::giveEngngModel(), oofem::StructuralInterfaceElementPhF::giveEngTraction(), oofem::StructuralInterfaceMaterialPhF::giveEngTraction_3d(), oofem::ErrorCheckingExportModule::giveErrorCheck(), oofem::StructuralMaterial::giveEshelbyStressVector_PlaneStrain(), oofem::VariableCrossSection::giveExpression(), oofem::Shell7BaseXFEM::giveFailedInterfaceNumber(), oofem::StationaryTransportProblem::giveField(), oofem::TransientTransportProblem::giveField(), oofem::SimpleCrossSection::giveFirstPKStresses(), oofem::FiberedCrossSection::giveFirstPKStresses(), oofem::LayeredCrossSection::giveFirstPKStresses(), oofem::LargeStrainMasterMaterialGrad::giveFirstPKStressVectorGrad(), oofem::GradDpMaterialExtensionInterface::giveFirstPKStressVectorGrad(), oofem::StructuralInterfaceElement::giveFirstPKTraction(), oofem::IntMatBilinearCZFagerstromRate::giveFirstPKTraction_3d(), oofem::StructuralInterfaceMaterial::giveFirstPKTraction_3d(), oofem::IntMatBilinearCZ::giveFirstPKTraction_3d(), oofem::IntMatBilinearCZFagerstrom::giveFirstPKTraction_3d(), oofem::IntMatBilinearCZJansson::giveFirstPKTraction_3d(), oofem::HeMoBazNajMaterial::giveFluxVector(), oofem::Domain::giveFractureManager(), oofem::Domain::giveFunction(), oofem::FiberedCrossSection::giveGeneralizedStress_Beam2d(), oofem::LayeredCrossSection::giveGeneralizedStress_Beam2d(), oofem::FiberedCrossSection::giveGeneralizedStress_Beam3d(), oofem::LayeredCrossSection::giveGeneralizedStress_Beam3d(), oofem::FiberedCrossSection::giveGeneralizedStress_MembraneRot(), oofem::LayeredCrossSection::giveGeneralizedStress_MembraneRot(), oofem::FiberedCrossSection::giveGeneralizedStress_Plate(), oofem::LayeredCrossSection::giveGeneralizedStress_Plate(), oofem::FiberedCrossSection::giveGeneralizedStress_PlateSubSoil(), oofem::LayeredCrossSection::giveGeneralizedStress_PlateSubSoil(), oofem::FiberedCrossSection::giveGeneralizedStress_Shell(), oofem::LayeredCrossSection::giveGeneralizedStress_Shell(), oofem::BasicGeometry::giveGlobalCoordinates(), oofem::Element::giveGlobalIPValue(), oofem::HeMoTKMaterial::giveHumidity(), oofem::NlIsoMoistureMaterial::giveHumidity(), oofem::HeMoKunzelMaterial::giveHumidity(), oofem::B3SolidMaterial::giveHumidity(), oofem::MPSMaterial::giveHumidity(), oofem::B3SolidMaterial::giveHumidityIncrement(), oofem::MasterDof::giveIc(), oofem::Domain::giveIc(), oofem::MPSMaterial::giveInitViscosity(), oofem::OOFEMTXTDataReader::giveInputRecord(), oofem::MixedGradientPressureWeakPeriodic::giveInputRecord(), oofem::EnrichmentItem::giveInputRecord(), oofem::BasicGeometry::giveInputRecord(), oofem::MixedGradientPressureNeumann::giveInputRecord(), oofem::CompoDamageMat::giveInputRecord(), oofem::LevelSetPCS::giveInputRecord(), oofem::FEI2dLineHermite::giveIntegrationRule(), oofem::BSplineInterpolation::giveIntegrationRule(), oofem::Beam2d::giveInternalDofManager(), oofem::PrescribedGradientBCWeak::giveInternalDofManager(), oofem::Beam3d::giveInternalDofManager(), oofem::Element::giveInternalDofManager(), oofem::Beam2d::giveInternalDofManDofIDMask(), oofem::Beam3d::giveInternalDofManDofIDMask(), oofem::GradDpElement::giveInternalForcesVector(), oofem::TR_SHELL02::giveInternalForcesVector(), oofem::TR_SHELL01::giveInternalForcesVector(), oofem::Beam3d::giveInternalForcesVectorAtPoint(), oofem::tet21ghostsolid::giveInternalForcesVectorGivenSolution(), oofem::tet21ghostsolid::giveInternalForcesVectorGivenSolutionDebug(), oofem::IDGMaterial::giveInternalLength(), oofem::IDGMaterial::giveInternalLengthDerivative(), oofem::giveInternalStateValueType(), oofem::NonlocalMaterialExtensionInterface::giveIPIntegrationList(), oofem::FluidDynamicMaterial::giveIPValue(), oofem::FE2FluidMaterial::giveIPValue(), oofem::AbaqusUserElement::giveIPValue(), oofem::StructuralMaterial::giveIPValue(), oofem::HydratingConcreteMat::giveIsotropicConductivity(), oofem::CemhydMat::giveIsotropicConductivity(), oofem::NURBSInterpolation::giveJacobianMatrixAt(), oofem::TSplineInterpolation::giveJacobianMatrixAt(), oofem::FEI3dTrLin::giveJacobianMatrixAt(), oofem::FEI3dTrQuad::giveJacobianMatrixAt(), oofem::BSplineInterpolation::giveJacobianMatrixAt(), oofem::FEInterpolation::giveJacobianMatrixAt(), oofem::LinElBranchFunction::giveJump(), oofem::CohesiveBranchFunction::giveJump(), oofem::TSplineInterpolation::giveKnotSpanBasisFuncMask(), oofem::BSplineInterpolation::giveKnotSpanBasisFuncMask(), oofem::IGAElement::giveKnotSpanParallelMode(), oofem::LayeredCrossSection::giveLayer(), oofem::Shell7Base::giveLayerContributionToSR(), oofem::FEInterpolation1d::giveLength(), oofem::SloanLevelStructure::giveLevel(), oofem::NRSolver::giveLinearSolver(), oofem::CylindricalALM::giveLinearSolver(), oofem::Domain::giveLoad(), oofem::TrPlaneStrRot3d::giveLocalCoordinates(), oofem::RerShell::giveLocalCoordinates(), oofem::DKTPlate3d::giveLocalCoordinates(), oofem::CCTPlate3d::giveLocalCoordinates(), oofem::MITC4Shell::giveLocalCoordinates(), oofem::CCTPlate3d::giveLocalCoordinateSystem(), oofem::DKTPlate3d::giveLocalCoordinateSystem(), oofem::GradDpElement::giveLocalInternalForcesVector(), oofem::FEInterpolation::giveLocalNodeCoords(), oofem::DofManager::giveLocationArray(), oofem::MicroMaterial::giveMacroStiffnessMatrix(), oofem::POIExportModule::giveMapper(), oofem::ActiveBoundaryCondition::giveMasterDof(), oofem::DofManager::giveMasterDofIDArray(), oofem::StructuralCrossSection::giveMaterial(), oofem::Domain::giveMaterial(), oofem::Element::giveMaterial(), oofem::LevelSetPCS::giveMaterialMixtureAt(), oofem::IntElPoint::giveMaterialMode(), oofem::InterfaceElem1d::giveMaterialMode(), oofem::FCMMaterial::giveMaterialStiffnessMatrix(), oofem::CompoDamageMat::giveMatStiffRotationMatrix(), oofem::FiberedCrossSection::giveMembraneRotStiffMtrx(), oofem::LayeredCrossSection::giveMembraneRotStiffMtrx(), oofem::EngngModel::giveMetaStep(), oofem::MicroplaneMaterial::giveMicroplane(), oofem::MITC4Shell::giveMidplaneIPValue(), oofem::PrescribedGradientBCWeak::giveMirroredPointOnGammaMinus(), oofem::PrescribedGradientBCWeak::giveMirroredPointOnGammaPlus(), oofem::ModuleManager< InitModule >::giveModule(), oofem::NlIsoMoistureMaterial::giveMoistureCapacity(), oofem::CBS::giveNewEquationNumber(), oofem::PFEM::giveNewEquationNumber(), oofem::CBS::giveNewPrescribedEquationNumber(), oofem::PFEM::giveNewPrescribedEquationNumber(), oofem::Domain::giveNextFreeDofID(), oofem::NonLinearDynamic::giveNextStep(), oofem::NonLinearStatic::giveNextStep(), oofem::Domain::giveNode(), oofem::Element::giveNode(), oofem::Domain::giveNonlocalBarrier(), oofem::PolygonLine::giveNormal(), oofem::ConcreteFCM::giveNormalCrackingStress(), oofem::Element::giveNumberOfBoundarySides(), oofem::FCMMaterial::giveNumberOfCracksForShearDirection(), oofem::FEInterpolation::giveNumberOfEdges(), oofem::VTKExportModule::giveNumberOfElementCells(), oofem::ActiveBoundaryCondition::giveNumberOfMasterDofs(), oofem::FEInterpolation::giveNumberOfNodes(), oofem::VTKExportModule::giveNumberOfNodesPerCell(), oofem::VTKXMLExportModule::giveNumberOfNodesPerCell(), oofem::SlaveDof::giveNumberOfPrimaryMasterDofs(), oofem::DofManager::giveNumberOfPrimaryMasterDofs(), oofem::FEIVoidCellGeometry::giveNumberOfVertices(), oofem::DarcyFlow::giveNumericalMethod(), oofem::LinearStatic::giveNumericalMethod(), oofem::FreeWarping::giveNumericalMethod(), oofem::EigenValueDynamic::giveNumericalMethod(), oofem::DIIDynamic::giveNumericalMethod(), oofem::StaticStructural::giveNumericalMethod(), oofem::IncrementalLinearStatic::giveNumericalMethod(), oofem::LinearStability::giveNumericalMethod(), oofem::NonLinearDynamic::giveNumericalMethod(), oofem::NonLinearStatic::giveNumericalMethod(), oofem::NonStationaryTransportProblem::giveNumericalMethod(), oofem::SUPG::giveNumericalMethod(), oofem::PFEM::giveNumericalMethod(), oofem::CBS::giveNumericalMethod(), oofem::LinearStability::giveNumericalMethodForLinStaticProblem(), oofem::DofManExportModule::giveOutputStream(), oofem::OutputExportModule::giveOutputStream(), oofem::GPExportModule::giveOutputStream(), oofem::MatlabExportModule::giveOutputStream(), oofem::POIExportModule::giveOutputStream(), oofem::VTKExportModule::giveOutputStream(), oofem::VTKXMLExportModule::giveOutputStream(), oofem::EngngModel::giveOutputStream(), oofem::EngngModel::giveParallelContext(), oofem::LargeStrainMasterMaterialGrad::givePDGradMatrix_kk(), oofem::IDGMaterial::givePDGradMatrix_kk(), oofem::TrabBoneGrad3D::givePDGradMatrix_kk(), oofem::MisesMatGrad::givePDGradMatrix_kk(), oofem::RankineMatGrad::givePDGradMatrix_kk(), oofem::LargeStrainMasterMaterialGrad::givePDGradMatrix_ku(), oofem::IDGMaterial::givePDGradMatrix_ku(), oofem::TrabBoneGrad3D::givePDGradMatrix_ku(), oofem::MisesMatGrad::givePDGradMatrix_ku(), oofem::RankineMatGrad::givePDGradMatrix_ku(), oofem::LargeStrainMasterMaterialGrad::givePDGradMatrix_LD(), oofem::IDGMaterial::givePDGradMatrix_LD(), oofem::TrabBoneGrad3D::givePDGradMatrix_LD(), oofem::MisesMatGrad::givePDGradMatrix_LD(), oofem::RankineMatGrad::givePDGradMatrix_LD(), oofem::LargeStrainMasterMaterialGrad::givePDGradMatrix_uk(), oofem::IDGMaterial::givePDGradMatrix_uk(), oofem::TrabBoneGrad3D::givePDGradMatrix_uk(), oofem::MisesMatGrad::givePDGradMatrix_uk(), oofem::RankineMatGrad::givePDGradMatrix_uk(), oofem::LargeStrainMasterMaterialGrad::givePDGradMatrix_uu(), oofem::IDGMaterial::givePDGradMatrix_uu(), oofem::TrabBoneGrad3D::givePDGradMatrix_uu(), oofem::MisesMatGrad::givePDGradMatrix_uu(), oofem::RankineMatGrad::givePDGradMatrix_uu(), oofem::NlIsoMoistureMaterial::givePermeability(), oofem::StructuralMaterial::givePlaneStrainStiffMtrx_dCde(), oofem::RankineMatNl::givePlaneStressStiffMtrx(), oofem::StructuralMaterial::givePlaneStressStiffMtrx_dCde(), oofem::HydratingConcreteMat::GivePower(), oofem::PrimaryField::givePrescribedVector(), oofem::TimeStep::givePreviousStep(), oofem::ProcessCommunicator::giveProcessCommunicatorBuff(), oofem::Load::giveProperty(), oofem::BoundaryLoad::giveProperty(), oofem::LatticeDamage2d::giveRandomParameters(), oofem::MDM::giveRawMDMParameters(), oofem::RCM2Material::giveRealPrincipalStressVector3d(), oofem::FiberedCrossSection::giveRealStress_1d(), oofem::LayeredCrossSection::giveRealStress_1d(), oofem::FiberedCrossSection::giveRealStress_3d(), oofem::LayeredCrossSection::giveRealStress_3d(), oofem::StructuralCrossSection::giveRealStress_3dDegeneratedShell(), oofem::FiberedCrossSection::giveRealStress_PlaneStrain(), oofem::LayeredCrossSection::giveRealStress_PlaneStrain(), oofem::FiberedCrossSection::giveRealStress_PlaneStress(), oofem::FiberedCrossSection::giveRealStress_Warping(), oofem::LayeredCrossSection::giveRealStress_Warping(), oofem::StructuralCrossSection::giveRealStresses(), oofem::RCSDNLMaterial::giveRealStressVector(), oofem::SteelRelaxMat::giveRealStressVector(), oofem::CompoDamageMat::giveRealStressVector(), oofem::IsotropicDamageMaterial::giveRealStressVector(), oofem::FCMMaterial::giveRealStressVector(), oofem::MPSDamMaterial::giveRealStressVector(), oofem::MDM::giveRealStressVector(), oofem::LatticeDamage2d::giveRealStressVector(), oofem::StructuralMaterial::giveRealStressVector_2dPlateSubSoil(), oofem::MooneyRivlinMaterial::giveRealStressVector_3d(), oofem::LargeStrainMasterMaterial::giveRealStressVector_3d(), oofem::MicroMaterial::giveRealStressVector_3d(), oofem::MisesMatNl::giveRealStressVector_3d(), oofem::StructuralMaterial::giveRealStressVector_3d(), oofem::StructuralMaterial::giveRealStressVector_3dBeamSubSoil(), oofem::StructuralMaterial::giveRealStressVector_Lattice2d(), oofem::StructuralMaterial::giveRealStressVector_Lattice3d(), oofem::AnisotropicDamageMaterial::giveRealStressVector_PlaneStress(), oofem::StructuralMaterial::giveRealStressVector_Warping(), oofem::IDGMaterial::giveRealStressVectorGrad(), oofem::GradDpMaterialExtensionInterface::giveRealStressVectorGrad(), oofem::Shell7BaseXFEM::giveRecoveredTransverseInterfaceStress(), oofem::Shell7Base::giveRecoveredTransverseInterfaceStress(), oofem::DruckerPragerPlasticitySM::giveRegAlgorithmicStiffMatrix(), oofem::ExportModule::giveRegionSet(), oofem::IDNLMaterial::giveRemoteNonlocalStiffnessContribution(), oofem::TR_SHELL02::giveRotationMatrix(), oofem::TR_SHELL01::giveRotationMatrix(), oofem::Element::giveRotationMatrix(), oofem::SkylineUnsym::giveRowColumn(), oofem::Domain::giveSet(), oofem::B3Material::giveShrinkageStrainVector(), oofem::B3SolidMaterial::giveShrinkageStrainVector(), oofem::Eurocode2CreepMaterial::giveShrinkageStrainVector(), oofem::MPSMaterial::giveShrinkageStrainVector(), oofem::Domain::giveSide(), oofem::Element::giveSide(), oofem::PrescribedGradientBCWeak::giveSideIndex(), oofem::FiberedCrossSection::giveSlaveGaussPoint(), oofem::LayeredCrossSection::giveSlaveGaussPoint(), oofem::GaussPoint::giveSlaveGaussPoint(), oofem::StaggeredProblem::giveSlaveProblem(), oofem::PrimaryField::giveSolutionVector(), oofem::Element::giveSpatialDimension(), oofem::HydrationModel::giveStatus(), oofem::FE2FluidMaterial::giveStiffnessMatrices(), oofem::LargeStrainMasterMaterialGrad::giveStiffnessMatrix(), oofem::IDGMaterial::giveStiffnessMatrix(), oofem::MisesMatGrad::giveStiffnessMatrix(), oofem::RankineMatGrad::giveStiffnessMatrix(), oofem::TrabBoneGrad3D::giveStiffnessMatrix(), oofem::StructuralMaterial::giveStiffnessMatrix(), oofem::LatticeDamage2d::giveStiffnessMatrix(), oofem::FiberedCrossSection::giveStiffnessMatrix_1d(), oofem::LayeredCrossSection::giveStiffnessMatrix_1d(), oofem::FiberedCrossSection::giveStiffnessMatrix_3d(), oofem::LayeredCrossSection::giveStiffnessMatrix_3d(), oofem::SimpleCrossSection::giveStiffnessMatrix_dCde(), oofem::FiberedCrossSection::giveStiffnessMatrix_dCde(), oofem::LayeredCrossSection::giveStiffnessMatrix_dCde(), oofem::SimpleCrossSection::giveStiffnessMatrix_dPdF(), oofem::FiberedCrossSection::giveStiffnessMatrix_dPdF(), oofem::LayeredCrossSection::giveStiffnessMatrix_dPdF(), oofem::StructuralInterfaceElement::giveStiffnessMatrix_dTdj(), oofem::FiberedCrossSection::giveStiffnessMatrix_PlaneStrain(), oofem::LayeredCrossSection::giveStiffnessMatrix_PlaneStrain(), oofem::FiberedCrossSection::giveStiffnessMatrix_PlaneStress(), oofem::Skyline::giveSubMatrix(), oofem::SparseMtrx::giveSubMatrix(), oofem::BasicGeometry::giveSubPolygon(), oofem::TrPlaneStrRot3d::giveSurfaceDofMapping(), oofem::CCTPlate3d::giveSurfaceDofMapping(), oofem::QDKTPlate::giveSurfaceDofMapping(), oofem::DKTPlate3d::giveSurfaceDofMapping(), oofem::Quad1PlateSubSoil::giveSurfaceDofMapping(), oofem::Tria1PlateSubSoil::giveSurfaceDofMapping(), oofem::DKTPlate::giveSurfaceDofMapping(), oofem::MITC4Shell::giveSurfaceDofMapping(), oofem::PolygonLine::giveTangent(), oofem::StructuralInterfaceMaterialPhF::giveTangents(), oofem::MisesMat::giveTemperature(), oofem::MPSMaterial::giveTemperature(), oofem::SimpleCrossSection::giveTemperatureVector(), oofem::TwoFluidMaterial::giveTempVOF(), oofem::OrthotropicLinearElasticMaterial::giveTensorRotationMatrix(), oofem::GeneralBoundaryCondition::giveTimeFunction(), oofem::AdaptiveNonLinearStatic::giveTimeStepLoadLevel(), oofem::FloatMatrix::giveTrace(), oofem::Shell7Base::giveTractionBC(), oofem::CBS::giveTractionPressure(), oofem::Domain::giveTransactionManager(), oofem::MixedGradientPressureDirichlet::giveUnknown(), oofem::ActiveBoundaryCondition::giveUnknown(), oofem::NLTransientTransportProblem::giveUnknownComponent(), oofem::StationaryTransportProblem::giveUnknownComponent(), oofem::LinearStatic::giveUnknownComponent(), oofem::FreeWarping::giveUnknownComponent(), oofem::DEIDynamic::giveUnknownComponent(), oofem::IncrementalLinearStatic::giveUnknownComponent(), oofem::EigenValueDynamic::giveUnknownComponent(), oofem::TransientTransportProblem::giveUnknownComponent(), oofem::StaticStructural::giveUnknownComponent(), oofem::DIIDynamic::giveUnknownComponent(), oofem::AdaptiveNonLinearStatic::giveUnknownComponent(), oofem::LinearStability::giveUnknownComponent(), oofem::NonLinearDynamic::giveUnknownComponent(), oofem::NlDEIDynamic::giveUnknownComponent(), oofem::NonStationaryTransportProblem::giveUnknownComponent(), oofem::NonLinearStatic::giveUnknownComponent(), oofem::SUPG::giveUnknownComponent(), oofem::PFEM::giveUnknownComponent(), oofem::CBS::giveUnknownComponent(), oofem::NLTransientTransportProblem::giveUnknownDictHashIndx(), oofem::NonStationaryTransportProblem::giveUnknownDictHashIndx(), oofem::SUPG::giveUnknownDictHashIndx(), oofem::PFEM::giveUnknownDictHashIndx(), oofem::DofDistributedPrimaryField::giveUnknownValue(), oofem::PrimaryField::giveUnknownValue(), oofem::DofManager::giveUnknownVectorOfType(), oofem::Node::giveUpdatedCoordinate(), oofem::SUPG::giveVariableScale(), oofem::CBS::giveVariableScale(), oofem::DruckerPragerPlasticitySM::giveVertexAlgorithmicStiffMatrix(), oofem::FEIVoidCellGeometry::giveVertexCoordinates(), oofem::FEInterpolation3d::giveVolume(), oofem::Domain::giveXfemManager(), oofem::NURBSInterpolation::global2local(), oofem::FEI3dTrLin::global2local(), oofem::FEI3dWedgeQuad::global2local(), oofem::TSplineInterpolation::global2local(), oofem::BSplineInterpolation::global2local(), oofem::AList< T >::growTo(), oofem::RowColumn::growTo(), oofem::SkylineUnsym::growTo(), oofem::Homogenize::hansen(), oofem::MasterDof::hasBc(), oofem::MasterDof::hasIc(), oofem::Homogenize::herveZaoui(), oofem::Quasicontinuum::homogenizationOfStiffMatrix(), oofem::HydrationModel::HydrationModel(), oofem::DynCompRow::ILUPYourself(), oofem::FiberedCrossSection::imposeStrainConstrainsOnGradient(), oofem::LayeredCrossSection::imposeStrainConstrainsOnGradient(), oofem::StructuralCrossSection::imposeStrainConstrainsOnGradient(), oofem::FiberedCrossSection::imposeStressConstrainsOnGradient(), oofem::LayeredCrossSection::imposeStressConstrainsOnGradient(), oofem::StructuralCrossSection::imposeStressConstrainsOnGradient(), oofem::AList< T >::includes(), oofem::DiagPreconditioner::init(), oofem::CompCol_ICPreconditioner::init(), oofem::CompCol_ILUPreconditioner::init(), oofem::CompRow_ILUPreconditioner::init(), oofem::Natural2GlobalOrdering::init(), oofem::MicroMaterial::init(), oofem::CemhydMatStatus::init(), oofem::MPSDamMaterial::initDamaged(), oofem::IsotropicDamageMaterial1::initDamaged(), oofem::OctreeSpatialLocalizer::initElementIPDataStructure(), oofem::TR1_2D_SUPG::initGeometry(), oofem::ParmetisLoadBalancer::initGlobalParmetisElementNumbering(), oofem::CompCol_ICPreconditioner::initialize(), oofem::ActiveDof::initialize(), oofem::SlaveDof::initialize(), oofem::HOMExportModule::initialize(), oofem::PrimaryField::initialize(), oofem::LevelSetPCS::initialize(), oofem::AdaptiveNonLinearStatic::initializeAdaptive(), oofem::AdaptiveNonLinearStatic::initializeAdaptiveFrom(), oofem::qcNode::initializeAsRepnode(), oofem::EngngModel::initializeCommMaps(), oofem::XfemStructuralElementInterface::initializeCZMaterial(), oofem::MicroplaneMaterial::initializeData(), oofem::MDM::initializeData(), oofem::LIBeam3d::initializeFrom(), oofem::PiecewiseLinFunction::initializeFrom(), oofem::MacroLSpace::initializeFrom(), oofem::QCFullsolveddomain::initializeFrom(), oofem::ScalarErrorIndicator::initializeFrom(), oofem::LIBeam3d2::initializeFrom(), oofem::InitModule::initializeFrom(), oofem::LineDistributedSpring::initializeFrom(), oofem::SymmetryBarrier::initializeFrom(), oofem::AnisotropicLinearElasticMaterial::initializeFrom(), oofem::LoadBalancerMonitor::initializeFrom(), oofem::TrPlaneStrRot::initializeFrom(), oofem::Delamination::initializeFrom(), oofem::IncrementalLinearStatic::initializeFrom(), oofem::qcNode::initializeFrom(), oofem::InterfaceElem1d::initializeFrom(), oofem::LIBeam3dNL2::initializeFrom(), oofem::LIBeam3dNL::initializeFrom(), oofem::WallClockLoadBalancerMonitor::initializeFrom(), oofem::EigenValueDynamic::initializeFrom(), oofem::NodalSpringElement::initializeFrom(), oofem::AdaptiveNonLinearStatic::initializeFrom(), oofem::IntMatIsoDamageTable::initializeFrom(), oofem::ConcreteFCM::initializeFrom(), oofem::LinearStability::initializeFrom(), oofem::MixedGradientPressureWeakPeriodic::initializeFrom(), oofem::FRCFCM::initializeFrom(), oofem::HeMoKunzelMaterial::initializeFrom(), oofem::PrescribedGradientBCWeak::initializeFrom(), oofem::CemhydMat::initializeFrom(), oofem::NonLinearDynamic::initializeFrom(), oofem::B3SolidMaterial::initializeFrom(), oofem::AbaqusUserMaterial::initializeFrom(), oofem::QClinearStatic::initializeFrom(), oofem::CompoDamageMat::initializeFrom(), oofem::RankineMat::initializeFrom(), oofem::NlIsoMoistureMaterial::initializeFrom(), oofem::SteelRelaxMat::initializeFrom(), oofem::StaggeredProblem::initializeFrom(), oofem::HuertaErrorEstimator::initializeFrom(), oofem::NRSolver::initializeFrom(), oofem::Shell7BaseXFEM::initializeFrom(), oofem::Node::initializeFrom(), oofem::IsoInterfaceDamageMaterial_2::initializeFrom(), oofem::Eurocode2CreepMaterial::initializeFrom(), oofem::LatticeTransportMaterial::initializeFrom(), oofem::AbaqusUserElement::initializeFrom(), oofem::CylindricalALM::initializeFrom(), oofem::MPSDamMaterial::initializeFrom(), oofem::IsotropicDamageMaterial1::initializeFrom(), oofem::MPSMaterial::initializeFrom(), oofem::NonlocalMaterialExtensionInterface::initializeFrom(), oofem::DofManager::initializeFrom(), oofem::EngngModel::initializeFrom(), oofem::QClinearStatic::initializeFullSolvedDomain(), oofem::LoadBalancer::initializeWtp(), oofem::XfemManager::initiateFronts(), oofem::EngngModel::initParallel(), oofem::OctreeSpatialLocalizer::insertNodeIntoOctree(), oofem::FEInterpolation2d::inside(), oofem::EngngModel::instanciateDefaultMetaStep(), oofem::GeometryBasedEI::instanciateYourself(), oofem::NucleationCriterion::instanciateYourself(), oofem::Delamination::instanciateYourself(), oofem::Node2NodeContact::instanciateYourself(), oofem::ContactManager::instanciateYourself(), oofem::ModuleManager< InitModule >::instanciateYourself(), oofem::XfemManager::instanciateYourself(), oofem::FractureManager::instanciateYourself(), oofem::ParticleTopologyDescription::instanciateYourself(), oofem::Domain::instanciateYourself(), oofem::PrescribedGradientBCNeumann::integrateTangent(), oofem::IntMatBilinearCZJanssonStatus::IntMatBilinearCZJanssonStatus(), oofem::HeMoTKMaterial::inverse_sorption_isotherm(), oofem::B3Material::inverse_sorption_isotherm(), oofem::HeMoBazNajMaterial::isCharacteristicMtrxSymmetric(), oofem::HeMoTKMaterial::isCharacteristicMtrxSymmetric(), oofem::HeMoKunzelMaterial::isCharacteristicMtrxSymmetric(), oofem::Load::isDofExcluded(), oofem::FloatArray::isFinite(), oofem::FCMMaterial::isIntact(), oofem::FCMMaterial::isIntactForShear(), oofem::FloatMatrix::jaco_(), oofem::Homogenize::kusterToksoz(), oofem::Domain::LB_giveUpdatedGlobalNumber(), oofem::Domain::LB_giveUpdatedLocalNumber(), oofem::EngngModel::letOutputBaseFileNameBe(), oofem::RheoChainMaterialStatus::letTempHiddenVarsVectorBe(), oofem::LoadLevelErrorCheckingRule::LoadLevelErrorCheckingRule(), oofem::NURBSInterpolation::local2global(), oofem::TSplineInterpolation::local2global(), oofem::BSplineInterpolation::local2global(), oofem::Parser::look(), oofem::TR1_2D_SUPG::LS_PCS_computeS(), oofem::Tet1_3D_SUPG::LS_PCS_computeVOFFractions(), oofem::TR1_2D_SUPG_AXI::LS_PCS_computeVOFFractions(), oofem::TR1_2D_SUPG::LS_PCS_computeVOFFractions(), oofem::EIPrimaryUnknownMapper::mapAndUpdate(), oofem::LSPrimaryVariableMapper::mapPrimaryVariables(), oofem::Element::mapStateVariables(), oofem::MMAContainingElementProjection::mapStatus(), oofem::MMAClosestIPTransfer::mapStatus(), oofem::MMAShapeFunctProjection::mapStatus(), oofem::MMALeastSquareProjection::mapStatus(), oofem::MMAShapeFunctProjection::mapVariable(), oofem::FETISolver::masterMapDirectionVector(), oofem::FETISolver::masterMapPPVector(), oofem::FETISolver::masterMapRBM(), oofem::FETISolver::masterMapResiduals(), oofem::FETISolver::masterMapSolution(), oofem::HeMoBazNajMaterial::matcond1d(), oofem::HeMoTKMaterial::matcond1d(), oofem::HeMoKunzelMaterial::matcond1d(), oofem::HeMoBazNajMaterial::matcond2d(), oofem::HeMoTKMaterial::matcond2d(), oofem::HeMoKunzelMaterial::matcond2d(), oofem::HeMoBazNajMaterial::matcond3d(), oofem::HeMoTKMaterial::matcond3d(), oofem::HeMoKunzelMaterial::matcond3d(), oofem::IntArray::maximum(), oofem::ConcreteFCM::maxShearStress(), oofem::FRCFCM::maxShearStress(), oofem::XfemStructureManager::mergeCloseCracks(), oofem::TriangleMesherInterface::meshPSLG(), oofem::NonlocalMaterialWTP::migrate(), oofem::IntArray::minimum(), oofem::MDM::MMI_map(), oofem::NonlocalMaterialExtensionInterface::modifyNonlocalWeightFunctionAround(), oofem::Material::modifyProperty(), oofem::LSpace::NodalAveragingRecoveryMI_computeNodalValue(), oofem::MITC4Shell::NodalAveragingRecoveryMI_computeNodalValue(), oofem::Shell7Base::nodalLeastSquareFitFromIP(), oofem::NodeErrorCheckingRule::NodeErrorCheckingRule(), oofem::QClinearStatic::nodeInFullSolvedDomainTest(), oofem::LocalGaussianRandomFunction::normal01CdfInverse(), oofem::LocalGaussianRandomFunction::normalCdfInverse(), oofem::FloatArray::normalize(), oofem::NCPrincipalStrain::nucleateEnrichmentItems(), oofem::NCPrincipalStress::nucleateEnrichmentItems(), oofem::NucleationCriterion::nucleateEnrichmentItems(), oofem::Subdivision::RS_Tetra::numberSharedEdges(), oofem::OOFEMTXTDataReader::OOFEMTXTDataReader(), oofem::MapBasedEntityRenumberingFunctor::operator()(), oofem::DynCompRow::operator()(), oofem::DynCompCol::operator()(), oofem::SymCompCol::operator()(), oofem::CompCol::operator()(), oofem::FloatMatrix::operator=(), oofem::GnuplotExportModule::outputReactionForces(), oofem::FiberedCrossSection::packUnknowns(), oofem::LayeredCrossSection::packUnknowns(), oofem::XfemElementInterface::partitionEdgeSegment(), oofem::LevelSetPCS::pcs_stage1(), oofem::DustMaterial::performF1return(), oofem::DustMaterial::performF2return(), oofem::RankineMat::performPlasticityReturn(), oofem::TrabBone3D::performPlasticityReturn(), oofem::ConcreteDPM2::performPlasticityReturn(), oofem::DruckerPragerPlasticitySM::performRegularReturn(), oofem::ConcreteDPM::performRegularReturn(), oofem::DustMaterial::performStressReturn(), oofem::DruckerPragerPlasticitySM::performVertexReturn(), oofem::PetscSolver::petsc_solve(), oofem::FloatArray::plusProduct(), oofem::DynamicCommunicationBuffer::popNewRecvPacket(), oofem::CommunicationPacketPool::popPacket(), oofem::Shell7Base::postInitialize(), oofem::HangingNode::postInitialize(), oofem::TR_SHELL02::postInitialize(), oofem::TR_SHELL01::postInitialize(), oofem::QClinearStatic::postInitialize(), oofem::qcNode::postInitializeAsHangingNode(), oofem::Parser::prim(), oofem::SUPG::printDofOutputAt(), oofem::CBS::printDofOutputAt(), oofem::PFEM::printDofOutputAt(), oofem::CompoDamageMatStatus::printOutputAt(), oofem::FloatArray::printYourselfToFile(), oofem::IntArray::printYourselfToFile(), oofem::FloatMatrix::printYourselfToFile(), oofem::NonLinearDynamic::proceedStep(), oofem::NonLinearStatic::proceedStep(), oofem::PLPrincipalStrain::propagateInterface(), oofem::PLCZdamageRadius::propagateInterface(), oofem::PLHoopStressCirc::propagateInterface(), oofem::CommunicationPacketPool::pushPacket(), oofem::AList< T >::put(), oofem::ReactionErrorCheckingRule::ReactionErrorCheckingRule(), oofem::POIExportModule::readPOIFile(), oofem::NonlocalMaterialExtensionInterface::rebuildNonlocalPointTable(), oofem::Shell7BaseXFEM::recoverShearStress(), oofem::Shell7Base::recoverShearStress(), oofem::Shell7Base::recoverValuesFromIP(), oofem::LevelSetPCS::reinitialization(), oofem::AList< T >::remove(), oofem::TopologyDescription::replaceFEMesh(), oofem::MPIBuffer::resize(), oofem::Truss2d::resolveCoordIndices(), oofem::Domain::resolveDomainDofsDefaults(), oofem::PrimaryField::resolveIndx(), oofem::Domain::restoreContext(), oofem::FloatArray::rotatedWith(), oofem::FloatMatrix::rotatedWith(), oofem::RowColumn::RowColumn(), oofem::Subdivision::RS_Tetra::RS_Tetra(), oofem::Subdivision::RS_Triangle::RS_Triangle(), oofem::RVEStokesFlowMaterialStatus::RVEStokesFlowMaterialStatus(), oofem::FloatMatrix::setColumn(), oofem::InterfaceElem1d::setCoordMode(), oofem::IntElPoint::setCoordMode(), oofem::EngngModel::setDomain(), oofem::UniformGridField::setGeometry(), oofem::Skyline::setInternalStructure(), oofem::MicroMaterial::setMacroProperties(), oofem::GaussPoint::setMaterialStatus(), oofem::HydratingHeMoMaterial::setMixture(), oofem::HydratingIsoHeatMaterial::setMixture(), oofem::HydrationModel::setMixture(), oofem::Quasicontinuum::setNoDimensions(), oofem::ParticleGridIterator< Point >::setPoint(), oofem::PrescribedGenStrainShell7::setPrescribedGenStrainShell7Voigt(), oofem::PrescribedGradientHomogenization::setPrescribedGradientVoigt(), oofem::FloatMatrix::setSubMatrix(), oofem::FloatMatrix::setTSubMatrix(), oofem::FETICommunicator::setUpCommunicationMaps(), oofem::ElementCommunicator::setUpCommunicationMaps(), oofem::IntegrationRule::setUpEmbeddedIntegrationPoints(), oofem::LayeredCrossSection::setupIntegrationPoints(), oofem::IntegrationRule::setUpIntegrationPoints(), oofem::Quasicontinuum::setupInterpolationMesh(), oofem::StructuralElement::setupIRForMassMtrxIntegration(), oofem::LobattoIntegrationRule::SetUpPointsOnTriangle(), oofem::HuertaErrorEstimatorInterface::setupRefinedElementProblem1D(), oofem::HuertaErrorEstimatorInterface::setupRefinedElementProblem2D(), oofem::HuertaErrorEstimatorInterface::setupRefinedElementProblem3D(), oofem::HuertaErrorEstimator::setupRefinedProblemProlog(), oofem::UniformGridField::setValues(), oofem::Grid::setZeroValues(), oofem::Subdivision::smoothMesh(), oofem::PetscSolver::solve(), oofem::MKLPardisoSolver::solve(), oofem::SLEPcSolver::solve(), oofem::PardisoProjectOrgSolver::solve(), oofem::GJacobi::solve(), oofem::LDLTFactorization::solve(), oofem::SuperLUSolver::solve(), oofem::SparseLinearSystemNM::solve(), oofem::SpoolesSolver::solve(), oofem::InverseIteration::solve(), oofem::SubspaceIteration::solve(), oofem::IMLSolver::solve(), oofem::FETISolver::solve(), oofem::CylindricalALM::solve(), oofem::IntElLine1PF::solveForLocalDamage(), oofem::FloatMatrix::solveForRhs(), oofem::DustMaterial::solveQ0(), oofem::HuertaErrorEstimator::solveRefinedElementProblem(), oofem::HuertaErrorEstimator::solveRefinedPatchProblem(), oofem::HuertaErrorEstimator::solveRefinedWholeProblem(), oofem::FluidMaterialEvaluator::solveYourself(), oofem::DarcyFlow::solveYourselfAt(), oofem::NLTransientTransportProblem::solveYourselfAt(), oofem::StationaryTransportProblem::solveYourselfAt(), oofem::LinearStatic::solveYourselfAt(), oofem::FluidStructureProblem::solveYourselfAt(), oofem::FreeWarping::solveYourselfAt(), oofem::DEIDynamic::solveYourselfAt(), oofem::IncrementalLinearStatic::solveYourselfAt(), oofem::StaticStructural::solveYourselfAt(), oofem::StokesFlow::solveYourselfAt(), oofem::DIIDynamic::solveYourselfAt(), oofem::AdaptiveNonLinearStatic::solveYourselfAt(), oofem::NonStationaryTransportProblem::solveYourselfAt(), oofem::SUPG::solveYourselfAt(), oofem::PFEM::solveYourselfAt(), oofem::CBS::solveYourselfAt(), oofem::HeMoTKMaterial::sorption_isotherm(), oofem::HeMoKunzelMaterial::sorptionIsotherm(), oofem::NlIsoMoistureMaterial::sorptionIsotherm(), oofem::HeMoKunzelMaterial::sorptionIsothermDerivative(), oofem::XfemStructureManager::splitCracks(), oofem::Q27Space::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::LWedge::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::Quad1PlaneStrain::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::L4Axisymm::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::QWedge::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::QSpace::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::PlaneStress2d::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::QBrick1_ht::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::LSpace::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::TrPlaneStrain::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::Brick1_ht::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::QTRSpace::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::QTrPlaneStress2d::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::Quad2PlateSubSoil::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::QTrPlaneStrain::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::Wedge_ht::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::QWedge_ht::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::Axisymm3d::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::LTRSpace::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::TrPlaneStress2d::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::MITC4Shell::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::Tria1PlateSubSoil::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::Quad1PlateSubSoil::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::LineDistributedSpring::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::Quad1Mindlin::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::Quad1MindlinShell3D::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::TR1_2D_SUPG2_AXI::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::CCTPlate::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::QDKTPlate::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::TR1_2D_CBS::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::TR1_2D_SUPG2::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::DKTPlate::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::TR1_2D_SUPG::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::StressStrainBaseVector::StressStrainBaseVector(), oofem::StructuralFE2MaterialStatus::StructuralFE2MaterialStatus(), oofem::FloatArray::subtract(), oofem::FloatMatrix::subtract(), oofem::FEI3dHexaLin::surfaceEvaldNdx(), oofem::FEI3dTrLin::surfaceEvaldNdx(), oofem::FEI3dTrQuad::surfaceEvaldNdx(), oofem::FEI3dHexaQuad::surfaceEvaldNdx(), oofem::FEInterpolation3d::surfaceEvaldNdx(), oofem::FEI3dLineLin::surfaceEvalN(), oofem::FEI3dLineLin::surfaceEvalNormal(), oofem::FEInterpolation3d::surfaceEvalNormal(), oofem::FEI3dLineLin::surfaceGiveTransformationJacobian(), oofem::FEI3dWedgeLin::surfaceGiveTransformationJacobian(), oofem::FEI3dTrLin::surfaceGiveTransformationJacobian(), oofem::FEI3dTrQuad::surfaceGiveTransformationJacobian(), oofem::FEI3dLineLin::surfaceLocal2global(), oofem::FloatMatrix::symmetrized(), oofem::T3DInterface::t3d_2_OOFEM(), oofem::Parser::term(), oofem::PetscSparseMtrx::times(), oofem::SpoolesSparseMtrx::times(), oofem::SkylineUnsym::times(), oofem::DynCompRow::times(), oofem::DynCompCol::times(), oofem::Skyline::times(), oofem::SymCompCol::times(), oofem::CompCol::times(), oofem::SparseMtrx::times(), oofem::DIIDynamic::timesMtrx(), oofem::NonLinearDynamic::timesMtrx(), oofem::PetscSparseMtrx::timesT(), oofem::SpoolesSparseMtrx::timesT(), oofem::SkylineUnsym::timesT(), oofem::DynCompRow::timesT(), oofem::DynCompCol::timesT(), oofem::CompCol::timesT(), oofem::SparseMtrx::timesT(), oofem::Skyline::toFloatMatrix(), oofem::SparseMtrx::toFloatMatrix(), oofem::Tr_Warp::transformCoordinates(), oofem::QClinearStatic::transformMeshToParticles(), oofem::Delaunay::triangulate(), oofem::AList< T >::unlink(), oofem::FiberedCrossSection::unpackAndUpdateUnknowns(), oofem::LayeredCrossSection::unpackAndUpdateUnknowns(), oofem::EngngModel::unpackDofManagers(), oofem::Subdivision::unpackIrregularSharedGlobnums(), oofem::LoadBalancer::unpackMigratingData(), oofem::EngngModel::unpackRemoteElementData(), oofem::ParmetisLoadBalancer::unpackSharedDmanPartitions(), oofem::Subdivision::unpackSharedEdges(), oofem::Subdivision::unpackSharedIrregulars(), oofem::PrimaryField::update(), oofem::Subdivision::RS_Triangle::update_neighbours(), oofem::Subdivision::RS_Tetra::update_neighbours(), oofem::NonLinearDynamic::updateAttributes(), oofem::NonLinearStatic::updateAttributes(), oofem::StaggeredProblem::updateAttributes(), oofem::PrescribedGenStrainShell7::updateCoefficientMatrix(), oofem::DarcyFlow::updateComponent(), oofem::StationaryTransportProblem::updateComponent(), oofem::TransientTransportProblem::updateComponent(), oofem::StaticStructural::updateComponent(), oofem::StokesFlow::updateComponent(), oofem::NonLinearDynamic::updateComponent(), oofem::NonLinearStatic::updateComponent(), oofem::SUPG::updateComponent(), oofem::EngngModel::updateComponent(), oofem::FCMMaterial::updateCrackStatus(), oofem::WeakPeriodicBoundaryCondition::updateDirection(), oofem::TR1_2D_SUPG2_AXI::updateIntegrationRules(), oofem::TR1_2D_SUPG2::updateIntegrationRules(), oofem::HydrationModel::updateInternalState(), oofem::EngngModel::updateSharedDofManagers(), oofem::RCM2Material::updateStatusForNewCrack(), oofem::AdaptiveLinearStatic::updateYourself(), oofem::ParticleTopologyDescription::updateYourself(), oofem::XfemStructuralElementInterface::XfemElementInterface_computeConsistentMassMatrix(), oofem::XfemStructuralElementInterface::XfemElementInterface_computeConstitutiveMatrixAt(), oofem::XfemStructuralElementInterface::XfemElementInterface_computeDeformationGradientVector(), oofem::XfemStructuralElementInterface::XfemElementInterface_computeStressVector(), oofem::XfemElementInterface::XfemElementInterface_prepareNodesForDelaunay(), oofem::XfemStructuralElementInterface::XfemElementInterface_updateIntegrationRule(), oofem::ZZErrorEstimatorInterface::ZZErrorEstimatorI_computeElementContributions(), oofem::Shell7Base::ZZNodalRecoveryMI_ComputeEstimatedInterpolationMtrx(), oofem::Tr_Warp::ZZNodalRecoveryMI_computeNNMatrix(), and oofem::ZZNodalRecoveryModelInterface::ZZNodalRecoveryMI_computeNNMatrix().

#define OOFEM_EXIT (   code)
Value:
fprintf(stderr, "oofem exit code %d\n", code); \
exit(code);
void printStatistics()
Prints number of errors and warning logged.
Definition: logger.C:332
Logger oofem_logger(Logger::LOG_LEVEL_INFO)
Definition: logger.h:115

Cause oofem program termination by calling exit.

Definition at line 50 of file error.h.

Referenced by oofem::ContextIOERR::print(), oofem::OOFEMTXTInputRecord::report_error(), and oofem::DynamicInputRecord::report_error().

#define OOFEM_FATAL (   ...)    { oofem_logger.writeELogMsg(Logger :: LOG_LEVEL_FATAL, errorInfo(__func__).c_str(), __FILE__, __LINE__, __VA_ARGS__); OOFEM_EXIT(1); }

Macros for printing errors.

This macro can be used only within classes that implement errorInfo function.

Definition at line 60 of file error.h.

Referenced by oofem::MMALeastSquareProjection::__init(), and oofem::FloatArray::resizeWithValues().

#define OOFEM_SWARNING (   ...)    oofem_logger.writeELogMsg(Logger :: LOG_LEVEL_WARNING, __func__, __FILE__, __LINE__, __VA_ARGS__)

Definition at line 64 of file error.h.

#define OOFEM_WARNING (   ...)    oofem_logger.writeELogMsg(Logger :: LOG_LEVEL_WARNING, errorInfo(__func__).c_str(), __FILE__, __LINE__, __VA_ARGS__)

Definition at line 62 of file error.h.

Referenced by oofem::PetscSparseMtrx::addDiagonal(), oofem::Logger::appendErrorTo(), oofem::Logger::appendLogTo(), oofem::Quasicontinuum::applyApproach2(), oofem::Quasicontinuum::applyApproach3(), oofem::EngngModel::balanceLoad(), oofem::NodeErrorCheckingRule::check(), oofem::ElementErrorCheckingRule::check(), oofem::BeamElementErrorCheckingRule::check(), oofem::ReactionErrorCheckingRule::check(), oofem::LoadLevelErrorCheckingRule::check(), oofem::EigenValueErrorCheckingRule::check(), oofem::BsplinePlaneStressElement::checkConsistency(), oofem::LumpedMassElement::checkConsistency(), oofem::HangingNode::checkConsistency(), oofem::qcNode::checkConsistency(), oofem::StationaryTransportProblem::checkConsistency(), oofem::NURBSPlaneStressElement::checkConsistency(), oofem::StokesFlow::checkConsistency(), oofem::TransientTransportProblem::checkConsistency(), oofem::TransportElement::checkConsistency(), oofem::StructuralInterfaceCrossSection::checkConsistency(), oofem::StructuralInterfaceElement::checkConsistency(), oofem::StructuralEngngModel::checkConsistency(), oofem::NonStationaryTransportProblem::checkConsistency(), oofem::SimpleCrossSection::checkConsistency(), oofem::SUPG::checkConsistency(), oofem::Node::checkConsistency(), oofem::FiberedCrossSection::checkConsistency(), oofem::NURBSSpace3dElement::checkConsistency(), oofem::LayeredCrossSection::checkConsistency(), oofem::PFEM::checkConsistency(), oofem::Material::checkConsistency(), oofem::CBS::checkConsistency(), oofem::StructuralElement::checkConsistency(), oofem::CommunicationPacketPool::clear(), oofem::MPlasticMaterial::closestPointReturn(), oofem::MPlasticMaterial2::closestPointReturn(), oofem::Quad1MindlinShell3D::computeBmatrixAt(), oofem::Eurocode2CreepMaterial::computeCharTimes(), oofem::MPSDamMaterial::computeDamageForCohesiveCrack(), oofem::IsotropicDamageMaterial1::computeDamageParamForCohesiveCrack(), oofem::SUPGElement::computeHomogenizedReinforceTerm_MB(), oofem::SUPGElement::computeHomogenizedReinforceTerm_MC(), oofem::NLStructuralElement::computeInitialStressMatrix(), oofem::TR1_2D_SUPG2_AXI::computeLEPLICVolumeFraction(), oofem::TR1_2D_SUPG2::computeLEPLICVolumeFraction(), oofem::NlDEIDynamic::computeMassMtrx(), oofem::LinearEdgeLoad::computeNArray(), oofem::SUPGElement::computeOutFlowBCTerm_MB(), oofem::SUPGElement::computePenetrationWithResistanceBCTerm_MB(), oofem::StructuralElement::computePointLoadVectorAt(), oofem::SUPGElement::computeSlipWithFrictionBCTerm_MB(), oofem::SurfaceTensionBoundaryCondition::computeTangentFromElement(), oofem::FRCFCM::computeTempDamage(), oofem::Element::computeVectorOf(), oofem::NonlocalMaterialExtensionInterface::computeWeightFunction(), oofem::CylindricalALM::convertHPCMap(), oofem::MPlasticMaterial::cuttingPlaneReturn(), oofem::MPlasticMaterial2::cuttingPlaneReturn(), oofem::IsotropicDamageMaterial1::damageFunction(), oofem::SPRNodalRecoveryModel::determinePatchAssemblyPoints(), oofem::LEPlic::doInterfaceRemapping(), oofem::EIPrimaryUnknownMapper::evaluateAt(), oofem::PiecewiseLinFunction::evaluateAtTime(), oofem::VTKExportModule::exportCellVars(), oofem::VTKXMLExportModule::exportExternalForces(), oofem::POIExportModule::exportIntVarAs(), oofem::VTKXMLExportModule::exportIntVarsInGpAs(), oofem::SkylineUnsym::factorized(), oofem::ParticleTopologyDescription::findDisplacement(), oofem::SloanGraph::findPeripheralNodes(), oofem::OOFEMTXTDataReader::finish(), oofem::OOFEMTXTInputRecord::finish(), oofem::VTKExportModule::getDofManPrimaryVariable(), oofem::VTKXMLExportModule::getNodalVariableFromPrimaryField(), oofem::ConcreteDPM2::give1dStressStiffMtrx(), oofem::LargeStrainMasterMaterialGrad::give3dGprime(), oofem::LargeStrainMasterMaterialGrad::give3dKappaMatrix(), oofem::ConcreteDPM2::give3dMaterialStiffnessMatrix(), oofem::StructuralInterfaceMaterial::give3dStiffnessMatrix_dTdj(), oofem::IntMatBilinearCZ::give3dStiffnessMatrix_dTdj(), oofem::HydratingConcreteMat::giveConcreteCapacity(), oofem::CemhydMat::giveConcreteCapacity(), oofem::HydratingConcreteMat::giveConcreteDensity(), oofem::CemhydMat::giveConcreteDensity(), oofem::ConcreteFCM::giveCrackingModulus(), oofem::VTKXMLExportModule::giveDataHeaders(), oofem::OOFEMTXTInputRecord::giveField(), oofem::StructuralMaterial::giveFirstPKStressVector_1d(), oofem::StructuralMaterial::giveFirstPKStressVector_PlaneStress(), oofem::LargeStrainMasterMaterialGrad::giveFirstPKStressVectorGrad(), oofem::BazantNajjarMoistureTransferMaterial::giveHumidity(), oofem::FEI3dWedgeQuad::giveIntegrationRule(), oofem::FEI3dWedgeLin::giveIntegrationRule(), oofem::LargeStrainMasterMaterialGrad::giveInternalLength(), oofem::StructuralPythonMaterial::giveIPValue(), oofem::TrabBoneEmbed::giveIPValue(), oofem::HydratingConcreteMat::giveIsotropicConductivity(), oofem::CemhydMat::giveIsotropicConductivity(), oofem::ConcreteFCM::giveNormalCrackingStress(), oofem::SteelRelaxMat::giveRealStressVector(), oofem::PlasticMaterial::giveRealStressVector(), oofem::CompoDamageMat::giveRealStressVector(), oofem::FCMMaterial::giveRealStressVector(), oofem::StructuralMaterial::giveRealStressVector_ShellStressControl(), oofem::StructuralMaterial::giveRealStressVector_StressControl(), oofem::NodalRecoveryModel::giveRegionRecordSize(), oofem::SolutionbasedShapeFunction::giveValueAtPoint(), oofem::FEInterpolation2d::global2local(), oofem::Homogenize::herveZaoui(), oofem::MPSDamMaterial::initDamaged(), oofem::IsotropicDamageMaterial1::initDamaged(), oofem::InterpolatingFuction::initializeFrom(), oofem::MacroLSpace::initializeFrom(), oofem::Particle::initializeFrom(), oofem::TwoFluidMaterial::initializeFrom(), oofem::TSplineInterpolation::initializeFrom(), oofem::SlaveNode::initializeFrom(), oofem::LinearEdgeLoad::initializeFrom(), oofem::SymmetryBarrier::initializeFrom(), oofem::IntElPoint::initializeFrom(), oofem::ConstantPressureLoad::initializeFrom(), oofem::Delamination::initializeFrom(), oofem::CohesiveSurface3d::initializeFrom(), oofem::TR_SHELL01::initializeFrom(), oofem::HydratingConcreteMat::initializeFrom(), oofem::PlaneStress2d::initializeFrom(), oofem::RigidArmNode::initializeFrom(), oofem::LinearConstraintBC::initializeFrom(), oofem::UserDefDirichletBC::initializeFrom(), oofem::Truss2d::initializeFrom(), oofem::StructuralPythonMaterial::initializeFrom(), oofem::DIIDynamic::initializeFrom(), oofem::IGAElement::initializeFrom(), oofem::IMLSolver::initializeFrom(), oofem::ConcreteFCM::initializeFrom(), oofem::RandomMaterialExtensionInterface::initializeFrom(), oofem::LayeredCrossSection::initializeFrom(), oofem::M1Material::initializeFrom(), oofem::FRCFCM::initializeFrom(), oofem::MazarsMaterial::initializeFrom(), oofem::RCSDNLMaterial::initializeFrom(), oofem::IGATSplineElement::initializeFrom(), oofem::ExpCZMaterial::initializeFrom(), oofem::IntMatBilinearCZElastic::initializeFrom(), oofem::BSplineInterpolation::initializeFrom(), oofem::NonLinearDynamic::initializeFrom(), oofem::OrthotropicLinearElasticMaterial::initializeFrom(), oofem::B3SolidMaterial::initializeFrom(), oofem::BondCEBMaterial::initializeFrom(), oofem::Beam2d::initializeFrom(), oofem::RankineMat::initializeFrom(), oofem::SparseNonLinearSystemNM::initializeFrom(), oofem::NonStationaryTransportProblem::initializeFrom(), oofem::NlIsoMoistureMaterial::initializeFrom(), oofem::StaggeredProblem::initializeFrom(), oofem::WeakPeriodicBoundaryCondition::initializeFrom(), oofem::GeneralBoundaryCondition::initializeFrom(), oofem::FiberedCrossSection::initializeFrom(), oofem::Beam3d::initializeFrom(), oofem::Load::initializeFrom(), oofem::Node::initializeFrom(), oofem::ErrorCheckingExportModule::initializeFrom(), oofem::LatticeTransportMaterial::initializeFrom(), oofem::IntMatBilinearCZJansson::initializeFrom(), oofem::IntMatBilinearCZFagerstrom::initializeFrom(), oofem::HydrationModel::initializeFrom(), oofem::DruckerPragerPlasticitySM::initializeFrom(), oofem::IsotropicDamageMaterial1::initializeFrom(), oofem::MPSMaterial::initializeFrom(), oofem::MDM::initializeFrom(), oofem::HydrationModelInterface::initializeFrom(), oofem::LatticeDamage2d::initializeFrom(), oofem::DustMaterial::initializeFrom(), oofem::ConcreteDPM2::initializeFrom(), oofem::InstanciateProblem(), oofem::SolutionbasedShapeFunction::loadProblem(), oofem::Q27Space::NodalAveragingRecoveryMI_computeNodalValue(), oofem::LWedge::NodalAveragingRecoveryMI_computeNodalValue(), oofem::QWedge::NodalAveragingRecoveryMI_computeNodalValue(), oofem::QSpace::NodalAveragingRecoveryMI_computeNodalValue(), oofem::QTRSpace::NodalAveragingRecoveryMI_computeNodalValue(), oofem::Truss3d::NodalAveragingRecoveryMI_computeNodalValue(), oofem::Wedge_ht::NodalAveragingRecoveryMI_computeNodalValue(), oofem::QWedge_ht::NodalAveragingRecoveryMI_computeNodalValue(), oofem::MPIBuffer::packArray(), oofem::PetscSolver::petsc_solve(), oofem::RigidArmNode::postInitialize(), oofem::qcNode::printOutputAt(), oofem::OOFEMTXTInputRecord::readMatrix(), oofem::OOFEMTXTInputRecord::readRange(), oofem::Tokenizer::readSimpleExpressionToken(), oofem::Tokenizer::readStringToken(), oofem::Tokenizer::readStructToken(), oofem::NodalAveragingRecoveryModel::recoverValues(), oofem::ZZNodalRecoveryModel::recoverValues(), oofem::SPRNodalRecoveryModel::recoverValues(), oofem::DofManager::removeDof(), oofem::QClinearStatic::setQCNodeType(), oofem::QClinearStatic::setRepNodesInVerticesOfInterpolationMesh(), oofem::MKLPardisoSolver::solve(), oofem::DynamicRelaxationSolver::solve(), oofem::PardisoProjectOrgSolver::solve(), oofem::InverseIteration::solve(), oofem::SubspaceIteration::solve(), oofem::StaggeredSolver::solve(), oofem::NRSolver::solve(), oofem::CylindricalALM::solve(), oofem::StructuralMaterialEvaluator::solveYourself(), oofem::FluidMaterialEvaluator::solveYourself(), oofem::IncrementalLinearStatic::solveYourselfAt(), oofem::SUPG::solveYourselfAt(), oofem::QClinearStatic::transformMeshToParticles(), oofem::QClinearStatic::updateNodeTypes(), oofem::ParticleTopologyDescription::writeVTKFile(), and oofem::DomainTransactionManager::~DomainTransactionManager().


This page is part of the OOFEM documentation. Copyright (c) 2011 Borek Patzak
Project e-mail: info@oofem.org
Generated at Tue Jan 2 2018 20:07:32 for OOFEM by doxygen 1.8.11 written by Dimitri van Heesch, © 1997-2011