OOFEM 3.0
Loading...
Searching...
No Matches
oofem::FEMComponent Class Referenceabstract

#include <femcmpnn.h>

Inheritance diagram for oofem::FEMComponent:
Collaboration diagram for oofem::FEMComponent:

Public Member Functions

 FEMComponent (int n, Domain *d)
virtual ~FEMComponent ()=default
 Virtual destructor.
virtual const char * giveClassName () const =0
virtual const char * giveInputRecordName () const =0
DomaingiveDomain () const
virtual void setDomain (Domain *d)
int giveNumber () const
void setNumber (int num)
virtual void updateLocalNumbering (EntityRenumberingFunctor &f)
virtual void initializeFrom (InputRecord &ir)
virtual void initializeFrom (InputRecord &ir, int priority)
virtual void initializeFinish ()
virtual void postInitialize ()
 Performs post initialization steps. Called after all components are created and initialized.
virtual void giveInputRecord (DynamicInputRecord &input)
virtual void saveContext (DataStream &stream, ContextMode mode)
virtual void restoreContext (DataStream &stream, ContextMode mode)
virtual int checkConsistency ()
virtual void printOutputAt (FILE *file, TimeStep *tStep)
virtual void printYourself ()
 Prints receiver state on stdout. Useful for debugging.
virtual InterfacegiveInterface (InterfaceType t)
std::string errorInfo (const char *func) const
 Returns string for prepending output (used by error reporting macros).

Protected Attributes

int number
 Component number.
Domaindomain
 Link to domain object, useful for communicating with other FEM components.

Detailed Description

The top abstract class of all classes constituting the finite element mesh. Defines the attributes and methods common to all components of mesh: elements, nodes, time steps, materials, loads and load-time functions. This class defines the two attributes common to all component classes ; 'number' is primarily used for reading data in the data file. 'domain' is used for communicating with other components (e.g., for an element to obtain its material), for accessing the linear system and the data file.

See also
error handles error reporting.
checkConsistency to ensure, whether internal data structures are consistent.

Definition at line 73 of file femcmpnn.h.

Constructor & Destructor Documentation

◆ FEMComponent()

◆ ~FEMComponent()

virtual oofem::FEMComponent::~FEMComponent ( )
virtualdefault

Virtual destructor.

Member Function Documentation

◆ checkConsistency()

int oofem::FEMComponent::checkConsistency ( void )
virtual

Allows programmer to test some internal data, before computation begins. For example, one may use this function, to ensure that element has material with required capabilities is assigned to element. This must be done after all mesh components are instanciated.

Returns
Nonzero if receiver is consistent.

Reimplemented in oofem::BinghamFluidMaterial2, oofem::BsplinePlaneStressElement, oofem::CBSElement, oofem::ConcreteFCMViscoElastic, oofem::Element, oofem::ExpCZMaterial, oofem::FE2FluidMaterial, oofem::FiberedCrossSection, oofem::FluidCrossSection, oofem::HangingNode, oofem::InteractionPFEMParticle, oofem::IntMatBilinearCZ, oofem::IntMatBilinearCZElastic, oofem::IntMatBilinearCZFagerstrom, oofem::IntMatBilinearCZFagerstromRate, oofem::IntMatBilinearCZJansson, oofem::LatticeCrossSection, oofem::LatticeDamageViscoelastic, oofem::LatticePlasticityDamageViscoelastic, oofem::LatticeViscoelastic, oofem::LayeredCrossSection, oofem::LineDistributedSpring, oofem::LumpedMassElement, oofem::Material, oofem::NewtonianFluidMaterial, oofem::NLStructuralElement, oofem::NodalSpringElement, oofem::Node, oofem::NonlinearFluidMaterial, oofem::NURBSPlaneStressElement, oofem::NURBSSpace3dElement, oofem::PFEMElement2d, oofem::PFEMElement, oofem::PFEMParticle, oofem::qcNode, oofem::Quad10_2D_SUPG, oofem::RigidArmNode, oofem::Shell7Base, oofem::Shell7BaseXFEM, oofem::SimpleCrossSection, oofem::SimpleTransportCrossSection, oofem::SimpleVitrificationMaterial, oofem::SolidShell, oofem::SpringElement, oofem::StructuralCrossSection, oofem::StructuralElement, oofem::StructuralInterfaceCrossSection, oofem::StructuralInterfaceElement, oofem::SUPGElement2, oofem::SUPGElement, oofem::TR1_2D_CBS, oofem::TR1_2D_PFEM, oofem::TR1_2D_SUPG, oofem::TR21_2D_SUPG, oofem::TransportElement, oofem::TrPlaneStress2dXFEM, and oofem::TwoFluidMaterial.

Definition at line 89 of file femcmpnn.C.

Referenced by oofem::ConcreteFCMViscoElastic::checkConsistency(), oofem::LatticePlasticityDamageViscoelastic::checkConsistency(), and oofem::LatticeViscoelastic::checkConsistency().

◆ errorInfo()

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

Returns string for prepending output (used by error reporting macros).

Definition at line 80 of file femcmpnn.C.

References giveClassName(), and giveNumber().

◆ giveClassName()

virtual const char * oofem::FEMComponent::giveClassName ( ) const
pure virtual
Returns
Class name of the receiver.

Implemented in oofem::AbaqusUserElement, oofem::AbaqusUserMaterial, oofem::AnisotropicDamageMaterial, oofem::AnisotropicLinearElasticMaterial, oofem::AnisotropicMassTransferMaterial, oofem::Axisymm3d, oofem::B3Material, oofem::B3SolidMaterial, oofem::BasicElement, oofem::BasicElementQuad, oofem::BazantNajjarMoistureTransferMaterial, oofem::Beam2d, oofem::Beam3d, oofem::BinghamFluidMaterial2, oofem::BlatzKoMaterial, oofem::BondCEBMaterial, oofem::BondLink3d, oofem::BondLink3dBoundary, oofem::BoundaryCondition, oofem::Brick1_hmt, oofem::Brick1_ht, oofem::Brick1_mt, oofem::BsplinePlaneStressElement, oofem::CalculatorFunction, oofem::CCTPlate3d, oofem::CCTPlate, oofem::CebFip78Material, oofem::CebFipSlip90Material, oofem::CemhydMat, oofem::ClonedDofManager, oofem::CohesiveInterfaceMaterial, oofem::CohesiveSurface3d, oofem::CombinedZZSIErrorEstimator, oofem::CombinedZZSIRemeshingCriteria, oofem::CompoDamageMat, oofem::Concrete2, oofem::Concrete3, oofem::ConcreteDPM2, oofem::ConcreteDPM, oofem::ConcreteFCM, oofem::ConcreteFCMViscoElastic, oofem::ConstantEdgeLoad, oofem::ConstantFunction, oofem::ConstantPressureLoad, oofem::ConstantSurfaceLoad, oofem::Crack, oofem::DeadWeight, oofem::DeformationTheoryMaterial, oofem::Delamination, oofem::DepositedHeatSource, oofem::DirectEI, oofem::DirectErrorIndicatorRC, oofem::DiscontinuousFunction, oofem::DKTPlate3d, oofem::DKTPlate, oofem::DofManager, oofem::DoublePowerLawMaterial, oofem::DruckerPragerCutMat, oofem::DruckerPragerPlasticitySM, oofem::DummyCrossSection, oofem::DummyMaterial, oofem::DustMaterial, oofem::Element, oofem::ElementDofManager, oofem::ElementSide, oofem::EmptyCS, oofem::EnrichmentFunction, oofem::Eurocode2CreepMaterial, oofem::ExpCZMaterial, oofem::ExternalTemperatureFieldLoad, oofem::FCMMaterial, oofem::FE2FluidMaterial, oofem::FiberedCrossSection, oofem::FluidCrossSection, oofem::FRCFCMNL, oofem::FreeConstantSurfaceLoad, oofem::GeneralSlaveNode, oofem::GeometryBasedEI, oofem::GravityPressure, oofem::HangingNode, oofem::HeavisideFunction, oofem::HeavisideTimeFunction, oofem::HeMoBazNajMaterial, oofem::HeMoKunzelMaterial, oofem::HeMoTKMaterial, oofem::Hexa21Stokes, oofem::HTSelement, oofem::HuertaErrorEstimator, oofem::HuertaRemeshingCriteria, oofem::HybridEI, oofem::HydratingConcreteMat, oofem::HydratingHeMoMaterial, oofem::HydratingIsoHeatMaterial, oofem::HydrationModel, oofem::HyperelasticMaterial1d, oofem::IDNLMaterial, oofem::Inclusion, oofem::InitialCondition, oofem::IntElLine1, oofem::IntElLine1IntPen, oofem::IntElLine1PF, oofem::IntElLine1PhF, oofem::IntElLine2, oofem::IntElLine2IntPen, oofem::InteractionBoundaryCondition, oofem::InteractionLoad, oofem::InteractionPFEMParticle, oofem::InterfaceElem1d, oofem::InterfaceElem2dLin, oofem::InterfaceElem2dQuad, oofem::InterfaceElement3dTrLin, oofem::InterpolatingFuction, oofem::IntMatBilinearCZ, oofem::IntMatBilinearCZElastic, oofem::IntMatBilinearCZFagerstrom, oofem::IntMatBilinearCZJansson, oofem::IntMatCoulombContact, oofem::IntMatDummyCZ, oofem::IntMatElastic, oofem::IntMatIsoDamage, oofem::IntMatIsoDamageTable, oofem::IntMatPhaseField, oofem::IsoInterfaceDamageMaterial, oofem::IsoInterfaceDamageMaterial_2, oofem::IsotropicAsymmetric1DMaterial, oofem::IsotropicDamageMaterial1, oofem::IsotropicDamageMaterial, oofem::IsotropicGradientDamageMaterial, oofem::IsotropicHeatTransferMaterial, oofem::IsotropicLinearElasticMaterial, oofem::IsotropicLinMoistureTransferMaterial, oofem::IsotropicMoistureTransferMaterial, oofem::J2Mat, oofem::J2MPlasticMaterial, oofem::J2plasticMaterial, oofem::KelvinChainMaterial, oofem::KelvinChainSolidMaterial, oofem::L1Element, oofem::L4Axisymm, oofem::LargeStrainMasterMaterial, oofem::LargeStrainMasterMaterialGrad, oofem::Lattice2d, oofem::Lattice2d_mt, oofem::Lattice2dBoundary, oofem::Lattice3d, oofem::Lattice3d_mt, oofem::Lattice3dBoundary, oofem::Lattice3dBoundaryTruss, oofem::LatticeBeam3d, oofem::LatticeBeam3dBoundary, oofem::LatticeBondPlasticity, oofem::LatticeCrossSection, oofem::LatticeDamage, oofem::LatticeDamageViscoelastic, oofem::LatticeDirichletCouplingNode, oofem::LatticeLinearElastic, oofem::LatticeLink3d, oofem::LatticeLink3dBoundary, oofem::LatticeNeumannCouplingNode, oofem::LatticePlasticityDamage, oofem::LatticePlasticityDamageViscoelastic, oofem::LatticeSlip, oofem::LatticeStructuralMaterial, oofem::LatticeTransportMaterial, oofem::LatticeViscoelastic, oofem::LayeredCrossSection, oofem::LEPlic, oofem::LevelSetPCS, oofem::LIBeam2d, oofem::LIBeam2dNL, oofem::LIBeam3d2, oofem::LIBeam3d, oofem::LIBeam3dBoundary, oofem::LIBeam3dBoundaryBeam, oofem::LIBeam3dBoundaryMembrane, oofem::LIBeam3dBoundaryPlate, oofem::LIBeam3dBoundaryTruss, oofem::LIBeam3dBoundaryVoigt, oofem::LIBeam3dNL2, oofem::LIBeam3dNL, oofem::Line1_hmt, oofem::Line1_ht, oofem::Line1_mt, oofem::Line2BoundaryElement, oofem::LinearConstraintBC, oofem::LinearEdgeLoad, oofem::LinearElasticMaterial, oofem::LineDistributedSpring, oofem::LinkSlip, oofem::LinQuad3DPlaneStress, oofem::ListBasedEI, oofem::LocalGaussianRandomFunction, oofem::LSpace, oofem::LSpaceBB, oofem::LTRSpace, oofem::LTRSpaceBoundary, oofem::LTRSpaceBoundaryBeam, oofem::LTRSpaceBoundaryMembrane, oofem::LTRSpaceBoundaryPlate, oofem::LTRSpaceBoundaryTruss, oofem::LTRSpaceBoundaryVoigt, oofem::LumpedMassElement, oofem::LWedge, oofem::M1Material, oofem::M4Material, oofem::MacroLSpace, oofem::Masonry02, oofem::MaxwellChainMaterial, oofem::MazarsMaterial, oofem::MazarsNLMaterial, oofem::MDM, oofem::MeshQualityErrorEstimator, oofem::MFrontUserMaterial, oofem::MicroMaterial, oofem::MicroplaneMaterial_Bazant, oofem::MisesMat, oofem::MisesMatGrad, oofem::MisesMatNl, oofem::MITC4Shell, oofem::MixedGradientPressureDirichlet, oofem::MixedGradientPressureNeumann, oofem::MixedGradientPressureWeakPeriodic, oofem::MooneyRivlinCompressibleMaterial, oofem::MooneyRivlinCompressibleMaterial, oofem::MPlasticMaterial2, oofem::MPlasticMaterial, oofem::MPSDamMaterial, oofem::MPSMaterial, oofem::NeumannMomentLoad, oofem::NewtonianFluidMaterial, oofem::NlIsoMoistureMaterial, oofem::NLStructuralElement, oofem::NodalLoad, oofem::NodalSpringElement, oofem::Node, oofem::NonlinearFluidMaterial, oofem::NonlinearMassTransferMaterial, oofem::NURBSPlaneStressElement, oofem::NURBSSpace3dElement, oofem::OgdenCompressibleMaterial, oofem::OrthotropicLinearElasticMaterial, oofem::Particle, oofem::PeakFunction, oofem::PerfectlyPlasticMaterial, oofem::PeriodicPiecewiseLinFunction, oofem::PFEMElement2d, oofem::PFEMElement, oofem::PFEMParticle, oofem::PiecewiseLinFunction, oofem::PlaneStress2d, oofem::PlaneStress2dXfem, oofem::PlaneStressGradDamage, oofem::PlaneStressPhF2d, oofem::PlasticMaterial, oofem::PointLoad, oofem::PolylineNonlocalBarrier, oofem::PrescribedDispSlipBCDirichletRC, oofem::PrescribedDispSlipBCNeumannRC, oofem::PrescribedDispSlipMultiple, oofem::PrescribedGenStrainShell7, oofem::PrescribedGenStrainShell7, oofem::PrescribedGradient, oofem::PrescribedGradientBCNeumann, oofem::PrescribedGradientBCPeriodic, oofem::PrescribedGradientBCWeak, oofem::PrescribedGradientBCWeakDirichlet, oofem::PrescribedGradientBCWeakPeriodic, oofem::PrescribedGradientMultiple, oofem::PrescribedMean, oofem::PulseFunction, oofem::PythonExpression, oofem::Q1Element, oofem::Q27Space, oofem::Q4Axisymm, oofem::Q9PlaneStress2d, oofem::QBrick1_hmt, oofem::QBrick1_ht, oofem::QBrick1_mt, oofem::qcNode, oofem::QDKTPlate, oofem::QPlaneStrain, oofem::QPlaneStrainGrad, oofem::QPlaneStrainGradDamage, oofem::QPlaneStress2d, oofem::QPlaneStress2dSlip, oofem::QPlaneStressGradDamage, oofem::QPlaneStressPhF2d, oofem::QQuad1_hmt, oofem::QQuad1_ht, oofem::QQuad1_mt, oofem::QSpace, oofem::QSpaceGradDamage, oofem::QTrPlaneStrain, oofem::QTrPlaneStrainGradDamage, oofem::QTrPlaneStrainP1, oofem::QTrPlaneStress2d, oofem::QTrPlaneStress2dSlip, oofem::QTrPlaneStress2dXFEM, oofem::QTrPlaneStressGradDamage, oofem::QTRSpace, oofem::QTRSpaceGradDamage, oofem::QTruss1d, oofem::QTruss1dGradDamage, oofem::Quad10_2D_SUPG, oofem::Quad1_hmt, oofem::Quad1_ht, oofem::Quad1_mt, oofem::Quad1Mindlin, oofem::Quad1MindlinShell3D, oofem::Quad1PlaneStrain, oofem::Quad1PlaneStrainGradDamage, oofem::Quad1PlaneStrainP1, oofem::Quad1PlateSubSoil, oofem::Quad2PlateSubSoil, oofem::QuadAxisym1_hmt, oofem::QuadAxisym1_ht, oofem::QuadAxisym1_mt, oofem::QWedge, oofem::QWedge_hmt, oofem::QWedge_ht, oofem::QWedge_mt, oofem::QWedgeGradDamage, oofem::RampFunction, oofem::RankineMat, oofem::RankineMatGrad, oofem::RankineMatNl, oofem::RankinePlasticMaterial, oofem::RCM2Material, oofem::RCSDEMaterial, oofem::RCSDMaterial, oofem::RCSDNLMaterial, oofem::Reinforcement, oofem::RerShell, oofem::RheoChainMaterial, oofem::RigidArmNode, oofem::RotatingBoundary, oofem::RVEStokesFlow, oofem::SADGBLine1, oofem::ScalarErrorIndicator, oofem::Set, oofem::Shell7Base, oofem::Shell7BaseXFEM, oofem::ShellCrack, oofem::SimoPisterMaterial, oofem::SimpleCrossSection, oofem::SimpleInterfaceMaterial, oofem::SimpleTransportCrossSection, oofem::SimpleVitrificationMaterial, oofem::SlaveNode, oofem::SolidShell, oofem::SolutionbasedShapeFunction, oofem::SpringElement, oofem::Steel1, oofem::SteelRelaxMat, oofem::StepFunction, oofem::StructuralContactElement, oofem::StructuralContactElement_LineLin, oofem::StructuralContactElement_QuadLin, oofem::StructuralContactElement_TrLin, oofem::StructuralEigenstrainLoad, oofem::StructuralElement, oofem::StructuralFE2Material, oofem::StructuralFEContactSurface, oofem::StructuralInterfaceCrossSection, oofem::StructuralInterfaceElement, oofem::StructuralInterfaceElementPhF, oofem::StructuralInterfaceMaterialPhF, oofem::StructuralMaterial, oofem::StructuralMaterialSettable, oofem::StructuralPenaltyContactBoundaryCondition, oofem::StructuralPythonMaterial, oofem::StructuralSlipFE2Material, oofem::StructuralTemperatureLoad, oofem::SurfaceTensionBoundaryCondition, oofem::SymmetryBarrier, oofem::Tet1_3D_SUPG, oofem::Tet1BubbleStokes, oofem::tet21ghostsolid, oofem::Tet21Stokes, oofem::Tetrah1_hmt, oofem::Tetrah1_ht, oofem::TF1, oofem::TMBrick11, oofem::TMSimpleMaterial, oofem::TR1_2D_CBS, oofem::TR1_2D_PFEM, oofem::TR1_2D_SUPG2, oofem::TR1_2D_SUPG2_AXI, oofem::TR1_2D_SUPG, oofem::TR1_2D_SUPG_AXI, oofem::Tr1_hmt, oofem::Tr1_ht, oofem::Tr1_mt, oofem::Tr1BubbleStokes, oofem::Tr1Darcy, oofem::TR21_2D_SUPG, oofem::Tr21Stokes, oofem::Tr2Shell7, oofem::Tr2Shell7XFEM, oofem::TR_SHELL01, oofem::TR_SHELL02, oofem::TR_SHELL11, oofem::Tr_Warp, oofem::TrabBone3D, oofem::TrabBoneEmbed, oofem::TrabBoneGrad3D, oofem::TrabBoneMaterial, oofem::TrabBoneNL3D, oofem::TrabBoneNL, oofem::TrabBoneNLEmbed, oofem::TractionPressureBC, oofem::TransportElement, oofem::TransportGradientDirichlet, oofem::TransportGradientNeumann, oofem::TransportGradientPeriodic, oofem::TransverseReinfConstraint, oofem::TrAxisym1_hmt, oofem::TrAxisym1_ht, oofem::TrAxisym1_mt, oofem::Tria1PlateSubSoil, oofem::Tria2PlateSubSoil, oofem::TrPlaneStrain, oofem::TrPlaneStress2d, oofem::TrPlaneStress2dXFEM, oofem::TrPlaneStressGradDamage, oofem::TrPlanestressRotAllman3d, oofem::TrPlanestressRotAllman, oofem::TrPlaneStrRot3d, oofem::TrPlaneStrRot, oofem::Truss1d, oofem::Truss1dGradDamage, oofem::Truss2d, oofem::Truss3d, oofem::Truss3dnl2, oofem::Truss3dnl, oofem::TSplinePlaneStressElement, oofem::TutorialMaterial, oofem::TwoFluidMaterial, oofem::TwoPhaseMaterial, oofem::UPSimpleMaterial, oofem::UserDefDirichletBC, oofem::UserDefinedTemperatureField, oofem::UsrDefBoundaryLoad, oofem::VariableCrossSection, oofem::WarpingCrossSection, oofem::WeakPeriodicBoundaryCondition, oofem::Wedge_hmt, oofem::Wedge_ht, oofem::Wedge_mt, oofem::WinklerMaterial, oofem::WinklerPasternakMaterial, oofem::ZZErrorEstimator, and oofem::ZZRemeshingCriteria.

Referenced by oofem::FiberedCrossSection::checkConsistency(), oofem::LatticeCrossSection::checkConsistency(), oofem::LayeredCrossSection::checkConsistency(), oofem::SimpleCrossSection::checkConsistency(), oofem::StructuralInterfaceCrossSection::checkConsistency(), errorInfo(), and oofem::PLCZdamageRadius::propagateInterface().

◆ giveDomain()

Domain * oofem::FEMComponent::giveDomain ( ) const
inline
Returns
Domain which receiver belongs to.

Definition at line 97 of file femcmpnn.h.

References domain.

Referenced by oofem::PrimaryField::__evaluateAt(), oofem::RandomMaterialExtensionInterface::_generateStatusVariables(), oofem::Set::addAllElements(), oofem::PrimaryField::applyBoundaryCondition(), oofem::PrimaryField::applyInitialCondition(), oofem::MixedGradientPressureNeumann::assemble(), oofem::MixedGradientPressureWeakPeriodic::assemble(), oofem::PrescribedGradientBCNeumann::assemble(), oofem::PrescribedMean::assemble(), oofem::SurfaceTensionBoundaryCondition::assemble(), oofem::TransportGradientNeumann::assemble(), oofem::TransverseReinfConstraint::assemble(), oofem::PrescribedDispSlipBCNeumannRC::assembleOnReinfStress(), oofem::PrescribedDispSlipBCNeumannRC::assembleOnStress(), oofem::PrescribedDispSlipBCNeumannRC::assembleOnTransferStress(), oofem::MixedGradientPressureNeumann::assembleVector(), oofem::MixedGradientPressureWeakPeriodic::assembleVector(), oofem::PrescribedGradientBCNeumann::assembleVector(), oofem::SurfaceTensionBoundaryCondition::assembleVector(), oofem::TransportGradientNeumann::assembleVector(), oofem::TransverseReinfConstraint::assembleVector(), oofem::PrescribedDispSlipBCNeumannRC::assembleVectorBStress(), oofem::PrescribedDispSlipBCNeumannRC::assembleVectorRStress(), oofem::PrescribedDispSlipBCNeumannRC::assembleVectorStress(), oofem::FiberedCrossSection::checkConsistency(), oofem::LatticeCrossSection::checkConsistency(), oofem::LayeredCrossSection::checkConsistency(), oofem::SimpleCrossSection::checkConsistency(), oofem::StructuralInterfaceCrossSection::checkConsistency(), oofem::SolutionbasedShapeFunction::computeBaseFunctionValueAt(), oofem::XfemElementInterface::ComputeBOrBHMatrix(), oofem::TransportGradientDirichlet::computeCoefficientMatrix(), oofem::SolutionbasedShapeFunction::computeDofTransformation(), oofem::PrescribedMean::computeDomainSize(), oofem::TransportGradientNeumann::computeEta(), oofem::Shell7BaseXFEM::computeFailureCriteriaQuantities(), oofem::PrescribedGenStrainShell7::computeField(), oofem::PrescribedGradient::computeField(), oofem::PrescribedGradientBCPeriodic::computeField(), oofem::PrescribedGradientMultiple::computeField(), oofem::TransportGradientDirichlet::computeField(), oofem::TransportGradientPeriodic::computeField(), oofem::MixedGradientPressureDirichlet::computeFields(), oofem::MixedGradientPressureNeumann::computeFields(), oofem::PlaneStress2dXfem::computeGaussPoints(), oofem::QTrPlaneStress2dXFEM::computeGaussPoints(), oofem::Tr2Shell7XFEM::computeGaussPoints(), oofem::TrPlaneStress2dXFEM::computeGaussPoints(), oofem::PrescribedDispSlipBCNeumannRC::computeInterfaceLength(), oofem::NlIsoMoistureMaterial::computeInternalSourceVector(), oofem::SurfaceTensionBoundaryCondition::computeLoadVectorFromElement(), oofem::FRCFCMNL::computeNonlocalStressInFibers(), oofem::PrescribedDispSlipBCNeumannRC::computeRebarDyad(), oofem::PrescribedDispSlipBCDirichletRC::computeReinfStress(), oofem::PrescribedDispSlipBCNeumannRC::computeReinfStress(), oofem::PrescribedDispSlipMultiple::computeReinfStress(), oofem::MacroLSpace::computeStiffnessMatrix(), oofem::MixedGradientPressureWeakPeriodic::computeStress(), oofem::PrescribedDispSlipBCDirichletRC::computeStress(), oofem::PrescribedDispSlipBCNeumannRC::computeStress(), oofem::PrescribedDispSlipMultiple::computeStress(), oofem::GradientDamageElement::computeStressVector_and_localDamageDrivingVariable(), oofem::GradDpElement::computeStressVectorAndLocalCumulatedStrain(), oofem::PrescribedDispSlipBCDirichletRC::computeTangent(), oofem::PrescribedGenStrainShell7::computeTangent(), oofem::PrescribedGradient::computeTangent(), oofem::PrescribedGradientBCNeumann::computeTangent(), oofem::PrescribedGradientBCPeriodic::computeTangent(), oofem::PrescribedGradientBCWeak::computeTangent(), oofem::TransportGradientDirichlet::computeTangent(), oofem::TransportGradientNeumann::computeTangent(), oofem::TransportGradientPeriodic::computeTangent(), oofem::SurfaceTensionBoundaryCondition::computeTangentFromElement(), oofem::MixedGradientPressureDirichlet::computeTangents(), oofem::MixedGradientPressureNeumann::computeTangents(), oofem::MixedGradientPressureWeakPeriodic::computeTangents(), oofem::PrescribedDispSlipBCDirichletRC::computeTransferStress(), oofem::PrescribedDispSlipBCNeumannRC::computeTransferStress(), oofem::PrescribedDispSlipMultiple::computeTransferStress(), oofem::TransportElement::computeVof(), oofem::PrescribedDispSlipBCNeumannRC::computeWeightMatrix(), oofem::NeumannMomentLoad::computeXbar(), oofem::TransportGradientDirichlet::computeXi(), oofem::MixedGradientPressureWeakPeriodic::constructMMatrix(), oofem::EnrichmentItem::createEnrichedDofs(), oofem::LargeStrainMasterMaterialGrad::CreateStatus(), oofem::PrescribedGradientBCWeak::damageExceedsTolerance(), oofem::MixedGradientPressureBC::domainSize(), oofem::PrescribedDispSlipBCDirichletRC::domainSize(), oofem::PrescribedDispSlipBCNeumannRC::domainSize(), oofem::PrescribedGenStrainShell7::domainSize(), oofem::PrescribedGradientBCWeak::domainSize(), oofem::TransportGradientDirichlet::domainSize(), oofem::TransportGradientNeumann::domainSize(), oofem::PlaneStress2dXfem::drawRawGeometry(), oofem::TrPlaneStress2dXFEM::drawRawGeometry(), oofem::PlaneStress2dXfem::drawScalar(), oofem::TR1_2D_PFEM::drawScalar(), oofem::TrPlaneStress2dXFEM::drawScalar(), oofem::Node::drawYourself(), oofem::DirectErrorIndicatorRC::estimateMeshDensities(), oofem::GeometryBasedEI::evaluateEnrFuncJumps(), oofem::DirectErrorIndicatorRC::exchangeDofManDensities(), oofem::DirectErrorIndicatorRC::exchangeDofManIndicatorVals(), oofem::PrescribedGradientBCWeak::findCrackBndIntersecCoord(), oofem::PrescribedGradientBCWeak::findHoleCoord(), oofem::Delamination::findInitiationFronts(), oofem::VTKExportModule::getDofManPrimaryVariable(), oofem::InitialCondition::give(), oofem::LayeredCrossSection::give(), oofem::VariableCrossSection::give(), oofem::PrescribedGradientBCWeak::giveBoundaries(), oofem::SADGBoundaryElement::giveCharacteristicMatrix(), oofem::SADGElement::giveCharacteristicMatrix(), oofem::SUPGElement::giveCharacteristicMatrix(), oofem::FEContactSurface::giveContactElement(), oofem::FEContactSurface::giveContactElement_InSet(), oofem::MITC4Shell::giveDirectorVectors(), oofem::AuxVelocityNumberingScheme::giveDofEquationNumber(), oofem::DirectErrorIndicatorRC::giveDofManDensity(), oofem::PlaneStress2dXfem::giveDofManDofIDMask(), oofem::QTrPlaneStress2dXFEM::giveDofManDofIDMask(), oofem::Shell7BaseXFEM::giveDofManDofIDMask(), oofem::TrPlaneStress2dXFEM::giveDofManDofIDMask(), oofem::DirectErrorIndicatorRC::giveDofManIndicator(), oofem::RheoChainMaterial::giveEndOfTimeOfInterest(), oofem::IntElPoint::giveEngTraction(), oofem::Function::giveFunctionParameter(), oofem::PlaneStress2dXfem::giveGeometryType(), oofem::QTrPlaneStress2dXFEM::giveGeometryType(), oofem::TrPlaneStress2dXFEM::giveGeometryType(), oofem::LayeredCrossSection::giveInterfaceMaterial(), oofem::StructuralInterfaceCrossSection::giveInterfaceMaterial(), oofem::PrescribedDispSlipMultiple::giveInternalDofManager(), oofem::PrescribedGradientMultiple::giveInternalDofManager(), oofem::AbaqusUserElement::giveInternalForcesVector(), oofem::PrescribedMean::giveInternalForcesVector(), oofem::Element::giveInternalStateAtNode(), oofem::Element::giveIPValue(), oofem::FiberedCrossSection::giveIPValue(), oofem::LayeredCrossSection::giveIPValue(), oofem::LatticeCrossSection::giveLatticeMaterial(), oofem::Shell7Base::giveLayerContributionToSR(), oofem::RheoChainMaterial::giveLinearElasticMaterial(), oofem::Beam3d::giveLocalCoordinateSystem(), oofem::LIBeam3d2::giveLocalCoordinateSystem(), oofem::LIBeam3dNL2::giveLocalCoordinateSystem(), oofem::LIBeam3dNL::giveLocalCoordinateSystem(), oofem::DirectErrorIndicatorRC::giveLocalDofManDensity(), oofem::DirectErrorIndicatorRC::giveLocalDofManIndicator(), oofem::MixedGradientPressureNeumann::giveLocationArrays(), oofem::MixedGradientPressureWeakPeriodic::giveLocationArrays(), oofem::PrescribedDispSlipBCNeumannRC::giveLocationArrays(), oofem::PrescribedGradientBCNeumann::giveLocationArrays(), oofem::SurfaceTensionBoundaryCondition::giveLocationArrays(), oofem::TransportGradientNeumann::giveLocationArrays(), oofem::TransverseReinfConstraint::giveLocationArrays(), oofem::FluidCrossSection::giveMaterial(), oofem::LatticeCrossSection::giveMaterial(), oofem::SimpleCrossSection::giveMaterial(), oofem::StructuralInterfaceCrossSection::giveMaterial(), oofem::PrescribedGradientBCPeriodic::giveNumberOfMasterDofs(), oofem::SolutionbasedShapeFunction::giveNumberOfMasterDofs(), oofem::TransportGradientPeriodic::giveNumberOfMasterDofs(), oofem::DofManager::givePartitionsConnectivitySize(), oofem::BoundaryLoad::giveProperty(), oofem::IsotropicHeatTransferMaterial::giveProperty(), oofem::StructuralFE2Material::giveRealStressVector_3d(), oofem::LIBeam3d::giveReferenceNode(), oofem::MisesMat::giveS(), oofem::IntElPoint::giveStiffnessMatrix_Eng(), oofem::SolutionbasedShapeFunction::init(), oofem::qcNode::initializeAsRepnode(), oofem::ConstantInterpolation::initializeCell(), oofem::QuadraticInterpolation::initializeCell(), oofem::CBSElement::initializeFinish(), oofem::DofManager::initializeFinish(), oofem::Element::initializeFinish(), oofem::GeneralSlaveNode::initializeFinish(), oofem::InterfaceElem1d::initializeFinish(), oofem::NodalSpringElement::initializeFinish(), oofem::Node::initializeFinish(), oofem::AbaqusUserElement::initializeFrom(), oofem::Beam2d::initializeFrom(), oofem::BondLink3d::initializeFrom(), oofem::BondLink3dBoundary::initializeFrom(), oofem::CBSElement::initializeFrom(), oofem::CohesiveSurface3d::initializeFrom(), oofem::Delamination::initializeFrom(), oofem::DofManager::initializeFrom(), oofem::Element::initializeFrom(), oofem::HangingNode::initializeFrom(), oofem::Inclusion::initializeFrom(), oofem::IntElLine1PhF::initializeFrom(), oofem::IntElLine2IntPen::initializeFrom(), oofem::IntElPoint::initializeFrom(), oofem::InteractionPFEMParticle::initializeFrom(), oofem::InterfaceElem1d::initializeFrom(), oofem::InterfaceElem2dLin::initializeFrom(), oofem::InterfaceElem2dQuad::initializeFrom(), oofem::Lattice2d::initializeFrom(), oofem::Lattice2d_mt::initializeFrom(), oofem::Lattice2dBoundary::initializeFrom(), oofem::Lattice3d::initializeFrom(), oofem::Lattice3d_mt::initializeFrom(), oofem::Lattice3dBoundary::initializeFrom(), oofem::Lattice3dBoundaryTruss::initializeFrom(), oofem::LatticeBeam3d::initializeFrom(), oofem::LatticeBeam3dBoundary::initializeFrom(), oofem::LatticeDirichletCouplingNode::initializeFrom(), oofem::LatticeLink3d::initializeFrom(), oofem::LatticeLink3dBoundary::initializeFrom(), oofem::LatticeNeumannCouplingNode::initializeFrom(), oofem::LIBeam3dBoundary::initializeFrom(), oofem::LIBeam3dNL::initializeFrom(), oofem::LineDistributedSpring::initializeFrom(), oofem::LSpace::initializeFrom(), oofem::LTRSpaceBoundary::initializeFrom(), oofem::LumpedMassElement::initializeFrom(), oofem::MITC4Shell::initializeFrom(), oofem::NodalSpringElement::initializeFrom(), oofem::Node::initializeFrom(), oofem::qcNode::initializeFrom(), oofem::QTrPlaneStress2dXFEM::initializeFrom(), oofem::Quad1Mindlin::initializeFrom(), oofem::Quad1MindlinShell3D::initializeFrom(), oofem::RigidArmNode::initializeFrom(), oofem::Set::initializeFrom(), oofem::Shell7Base::initializeFrom(), oofem::SlaveNode::initializeFrom(), oofem::SolidShell::initializeFrom(), oofem::SolutionbasedShapeFunction::initializeFrom(), oofem::SpringElement::initializeFrom(), oofem::Structural3DElement::initializeFrom(), oofem::StructuralPenaltyContactBoundaryCondition::initializeFrom(), oofem::SUPGElement::initializeFrom(), oofem::TR1_2D_CBS::initializeFrom(), oofem::TR1_2D_SUPG2::initializeFrom(), oofem::TR1_2D_SUPG2_AXI::initializeFrom(), oofem::TR1_2D_SUPG::initializeFrom(), oofem::TransportElement::initializeFrom(), oofem::TrPlaneStress2dXFEM::initializeFrom(), oofem::TrPlaneStrRot::initializeFrom(), oofem::Truss2d::initializeFrom(), oofem::Truss3dnl::initializeFrom(), oofem::Delamination::instanciateYourself(), oofem::GeometryBasedEI::instanciateYourself(), oofem::MixedGradientPressureNeumann::integrateDevTangent(), oofem::PrescribedGradientBCNeumann::integrateTangent(), oofem::PrescribedDispSlipBCNeumannRC::integrateTangentRStressConcrete(), oofem::PrescribedDispSlipBCNeumannRC::integrateTangentStress(), oofem::MixedGradientPressureWeakPeriodic::integrateTractionVelocityTangent(), oofem::MixedGradientPressureNeumann::integrateVolTangent(), oofem::HybridEI::interpGradLevelSet(), oofem::HybridEI::interpLevelSet(), oofem::HybridEI::interpLevelSetTangential(), oofem::DofManager::isLocal(), oofem::ParallelOrdering::isLocal(), oofem::TMLhsAssembler::matrixFromElement(), oofem::GnuplotExportModule::outputBoundaryCondition(), oofem::GnuplotExportModule::outputBoundaryCondition(), oofem::GnuplotExportModule::outputBoundaryCondition(), oofem::AbaqusUserElement::postInitialize(), oofem::Beam2d::postInitialize(), oofem::Beam3d::postInitialize(), oofem::CohesiveSurface3d::postInitialize(), oofem::Delamination::postInitialize(), oofem::GeometryBasedEI::postInitialize(), oofem::HangingNode::postInitialize(), oofem::IntElPoint::postInitialize(), oofem::Lattice2d_mt::postInitialize(), oofem::Lattice2dBoundary::postInitialize(), oofem::Lattice3dBoundary::postInitialize(), oofem::Lattice3dBoundaryTruss::postInitialize(), oofem::LatticeBeam3d::postInitialize(), oofem::LatticeBeam3dBoundary::postInitialize(), oofem::LatticeDirichletCouplingNode::postInitialize(), oofem::LatticeLink3d::postInitialize(), oofem::LatticeLink3dBoundary::postInitialize(), oofem::LIBeam3dBoundary::postInitialize(), oofem::LIBeam3dNL::postInitialize(), oofem::LineDistributedSpring::postInitialize(), oofem::LumpedMassElement::postInitialize(), oofem::Particle::postInitialize(), oofem::qcNode::postInitialize(), oofem::RigidArmNode::postInitialize(), oofem::Shell7BaseXFEM::postInitialize(), oofem::SlaveNode::postInitialize(), oofem::qcNode::postInitializeAsHangingNode(), oofem::ClonedDofManager::printOutputAt(), oofem::DofManager::printOutputAt(), oofem::qcNode::printOutputAt(), oofem::Delamination::propagateFronts(), oofem::GeometryBasedEI::propagateFronts(), oofem::ListBasedEI::propagateFronts(), oofem::RemeshingCriteria::RemeshingCriteria(), oofem::qcNode::setAsHanging(), oofem::SolutionbasedShapeFunction::setBoundaryConditionOnDof(), oofem::PrescribedDispSlipMultiple::setCenterCoordinate(), oofem::PrescribedGradientMultiple::setCenterCoordinate(), oofem::PrescribedDispSlipMultiple::setDispGradient(), oofem::SolutionbasedShapeFunction::setLoads(), oofem::PrescribedGradientMultiple::setPrescribedGradient(), oofem::PrescribedGradientMultiple::setPrescribedGradientVoigt(), oofem::PrescribedDispSlipMultiple::setSlipField(), oofem::PrescribedDispSlipMultiple::setSlipGradient(), oofem::PatchIntegrationRule::SetUpPointsOnTriangle(), oofem::PatchIntegrationRule::SetUpPointsOnWedge(), oofem::HuertaErrorEstimatorInterface::setupRefinedElementProblem1D(), oofem::HuertaErrorEstimatorInterface::setupRefinedElementProblem2D(), oofem::HuertaErrorEstimatorInterface::setupRefinedElementProblem3D(), oofem::EnrichmentItem::tipIsTouchingEI(), oofem::Tr_Warp::transformCoordinates(), oofem::PrescribedDispSlipBCDirichletRC::updateCoefficientMatrix(), oofem::PrescribedGenStrainShell7::updateCoefficientMatrix(), oofem::PrescribedGradient::updateCoefficientMatrix(), oofem::WeakPeriodicBoundaryCondition::updateDirection(), oofem::GeometryBasedEI::updateDofIdPool(), oofem::GeometryBasedEI::updateGeometry(), oofem::ListBasedEI::updateGeometry(), oofem::GeometryBasedEI::updateLevelSets(), oofem::GeometryBasedEI::updateNodeEnrMarker(), oofem::WeakPeriodicBoundaryCondition::updateSminmax(), oofem::TMResidualAssembler::vectorFromElement(), and oofem::XfemElementInterface::XfemElementInterface_createEnrNmatrixAt().

◆ giveInputRecord()

void oofem::FEMComponent::giveInputRecord ( DynamicInputRecord & input)
virtual

Setups the input record string of receiver.

Parameters
inputDynamic input record to be filled by receiver.

Reimplemented in oofem::AbaqusUserElement, oofem::AbaqusUserMaterial, oofem::AnisotropicDamageMaterial, oofem::AnisotropicLinearElasticMaterial, oofem::BinghamFluidMaterial2, oofem::BondCEBMaterial, oofem::BoundaryCondition, oofem::BoundaryLoad, oofem::CalculatorFunction, oofem::CBSElement, oofem::CebFipSlip90Material, oofem::CohesiveInterfaceMaterial, oofem::CompoDamageMat, oofem::ConstantFunction, oofem::ConstantPressureLoad, oofem::ConstantSurfaceLoad, oofem::CrossSection, oofem::DofManager, oofem::DummyCrossSection, oofem::Element, oofem::EnrichmentFunction, oofem::EnrichmentItem, oofem::FE2FluidMaterial, oofem::FluidCrossSection, oofem::FreeConstantSurfaceLoad, oofem::GeneralBoundaryCondition, oofem::HeavisideTimeFunction, oofem::IDNLMaterial, oofem::InteractionLoad, oofem::IntMatBilinearCZ, oofem::IntMatBilinearCZElastic, oofem::IntMatBilinearCZFagerstrom, oofem::IntMatBilinearCZFagerstromRate, oofem::IntMatCoulombContact, oofem::IntMatDummyCZ, oofem::IntMatElastic, oofem::IntMatIsoDamage, oofem::IntMatIsoDamageTable, oofem::IntMatPhaseField, oofem::IsoInterfaceDamageMaterial, oofem::IsoInterfaceDamageMaterial_2, oofem::IsotropicAsymmetric1DMaterial, oofem::IsotropicDamageMaterial1, oofem::IsotropicDamageMaterial, oofem::IsotropicLinearElasticMaterial, oofem::J2plasticMaterial, oofem::LayeredCrossSection, oofem::LEPlic, oofem::LevelSetPCS, oofem::LinearEdgeLoad, oofem::LinearElasticMaterial, oofem::Load, oofem::Material, oofem::MDM, oofem::MFrontUserMaterial, oofem::MicroplaneMaterial, oofem::MisesMatNl, oofem::MixedGradientPressureDirichlet, oofem::MixedGradientPressureNeumann, oofem::MixedGradientPressureWeakPeriodic, oofem::NewtonianFluidMaterial, oofem::NLStructuralElement, oofem::NodalLoad, oofem::Node, oofem::NonlinearFluidMaterial, oofem::OrthotropicLinearElasticMaterial, oofem::PeriodicPiecewiseLinFunction, oofem::PiecewiseLinFunction, oofem::PlaneStress2dXfem, oofem::PointLoad, oofem::PrescribedDispSlipBCDirichletRC, oofem::PrescribedDispSlipBCNeumannRC, oofem::PrescribedDispSlipMultiple, oofem::PrescribedGenStrainShell7, oofem::PrescribedGenStrainShell7, oofem::PrescribedGradient, oofem::PrescribedGradientBCNeumann, oofem::PrescribedGradientBCPeriodic, oofem::PrescribedGradientBCWeak, oofem::PrescribedGradientMultiple, oofem::PythonExpression, oofem::QTrPlaneStress2dXFEM, oofem::Quad10_2D_SUPG, oofem::RankineMatNl, oofem::RotatingBoundary, oofem::Set, oofem::SimpleCrossSection, oofem::SimpleInterfaceMaterial, oofem::SimpleTransportCrossSection, oofem::SimpleVitrificationMaterial, oofem::StepFunction, oofem::StructuralElement, oofem::StructuralFE2Material, oofem::StructuralInterfaceElement, oofem::StructuralInterfaceMaterial, oofem::StructuralMaterial, oofem::StructuralPythonMaterial, oofem::StructuralSlipFE2Material, oofem::SUPGElement2, oofem::SUPGElement, oofem::TMSimpleMaterial, oofem::TR1_2D_CBS, oofem::TR1_2D_SUPG2, oofem::TR1_2D_SUPG2_AXI, oofem::TR1_2D_SUPG, oofem::TrabBoneNL3D, oofem::TrabBoneNL, oofem::TrabBoneNLEmbed, oofem::TransportGradientDirichlet, oofem::TransportGradientNeumann, oofem::TransportGradientPeriodic, oofem::TransverseReinfConstraint, oofem::TrPlaneStress2dXFEM, oofem::TutorialMaterial, oofem::TwoFluidMaterial, oofem::UPSimpleMaterial, oofem::UserDefDirichletBC, oofem::UsrDefBoundaryLoad, oofem::VariableCrossSection, oofem::WinklerMaterial, and oofem::WinklerPasternakMaterial.

Definition at line 73 of file femcmpnn.C.

References giveInputRecordName(), giveNumber(), and oofem::DynamicInputRecord::setRecordKeywordField().

Referenced by oofem::DynamicInputRecord::DynamicInputRecord().

◆ giveInputRecordName()

virtual const char * oofem::FEMComponent::giveInputRecordName ( ) const
pure virtual
Returns
Input record name of the receiver.

Implemented in oofem::AbaqusUserElement, oofem::AbaqusUserMaterial, oofem::AnisotropicDamageMaterial, oofem::AnisotropicLinearElasticMaterial, oofem::AnisotropicMassTransferMaterial, oofem::Axisymm3d, oofem::B3Material, oofem::B3SolidMaterial, oofem::BasicElement, oofem::BasicElementQuad, oofem::BazantNajjarMoistureTransferMaterial, oofem::Beam2d, oofem::Beam3d, oofem::BinghamFluidMaterial2, oofem::BlatzKoMaterial, oofem::BondCEBMaterial, oofem::BondLink3d, oofem::BondLink3dBoundary, oofem::BoundaryCondition, oofem::Brick1_hmt, oofem::Brick1_ht, oofem::Brick1_mt, oofem::BsplinePlaneStressElement, oofem::CalculatorFunction, oofem::CCTPlate3d, oofem::CCTPlate, oofem::CebFip78Material, oofem::CebFipSlip90Material, oofem::CemhydMat, oofem::ClonedDofManager, oofem::CohesiveInterfaceMaterial, oofem::CohesiveSurface3d, oofem::CombinedZZSIErrorEstimator, oofem::CombinedZZSIRemeshingCriteria, oofem::CompoDamageMat, oofem::Concrete2, oofem::Concrete3, oofem::ConcreteDPM2, oofem::ConcreteDPM, oofem::ConcreteFCM, oofem::ConcreteFCMViscoElastic, oofem::ConstantEdgeLoad, oofem::ConstantFunction, oofem::ConstantPressureLoad, oofem::ConstantSurfaceLoad, oofem::Crack, oofem::DeadWeight, oofem::Delamination, oofem::DepositedHeatSource, oofem::DirectEI, oofem::DirectErrorIndicatorRC, oofem::DiscontinuousFunction, oofem::DKTPlate3d, oofem::DKTPlate, oofem::DofManager, oofem::DoublePowerLawMaterial, oofem::DruckerPragerCutMat, oofem::DruckerPragerPlasticitySM, oofem::DummyCrossSection, oofem::DummyMaterial, oofem::DustMaterial, oofem::ElementDofManager, oofem::ElementSide, oofem::EmptyCS, oofem::Eurocode2CreepMaterial, oofem::ExternalTemperatureFieldLoad, oofem::FE2FluidMaterial, oofem::FiberedCrossSection, oofem::FluidCrossSection, oofem::FRCFCMNL, oofem::FreeConstantSurfaceLoad, oofem::GeneralSlaveNode, oofem::GeometryBasedEI, oofem::GravityPressure, oofem::HangingNode, oofem::HeavisideFunction, oofem::HeavisideTimeFunction, oofem::HeMoBazNajMaterial, oofem::HeMoKunzelMaterial, oofem::HeMoTKMaterial, oofem::Hexa21Stokes, oofem::HTSelement, oofem::HuertaErrorEstimator, oofem::HuertaRemeshingCriteria, oofem::HybridEI, oofem::HydratingHeMoMaterial, oofem::HydratingIsoHeatMaterial, oofem::HydrationModel, oofem::HyperelasticMaterial1d, oofem::IDNLMaterial, oofem::Inclusion, oofem::InitialCondition, oofem::IntElLine1, oofem::IntElLine1IntPen, oofem::IntElLine1PF, oofem::IntElLine1PhF, oofem::IntElLine2, oofem::IntElLine2IntPen, oofem::IntElPoint, oofem::IntElSurfQuad1, oofem::IntElSurfTr1, oofem::InteractionBoundaryCondition, oofem::InteractionLoad, oofem::InteractionPFEMParticle, oofem::InterfaceElem1d, oofem::InterfaceElem2dLin, oofem::InterfaceElem2dQuad, oofem::InterfaceElement3dTrLin, oofem::InterpolatingFuction, oofem::IntMatBilinearCZ, oofem::IntMatBilinearCZElastic, oofem::IntMatBilinearCZFagerstrom, oofem::IntMatBilinearCZJansson, oofem::IntMatCoulombContact, oofem::IntMatDummyCZ, oofem::IntMatElastic, oofem::IntMatIsoDamage, oofem::IntMatIsoDamageTable, oofem::IntMatPhaseField, oofem::IsoInterfaceDamageMaterial, oofem::IsoInterfaceDamageMaterial_2, oofem::IsotropicAsymmetric1DMaterial, oofem::IsotropicDamageMaterial1, oofem::IsotropicGradientDamageMaterial, oofem::IsotropicHeatTransferMaterial, oofem::IsotropicLinearElasticMaterial, oofem::IsotropicLinMoistureTransferMaterial, oofem::J2Mat, oofem::J2MPlasticMaterial, oofem::J2plasticMaterial, oofem::L1Element, oofem::L4Axisymm, oofem::LargeStrainMasterMaterial, oofem::Lattice2d, oofem::Lattice2d_mt, oofem::Lattice2dBoundary, oofem::Lattice3d, oofem::Lattice3d_mt, oofem::Lattice3dBoundary, oofem::Lattice3dBoundaryTruss, oofem::LatticeBeam3d, oofem::LatticeBeam3dBoundary, oofem::LatticeBondPlasticity, oofem::LatticeCrossSection, oofem::LatticeDamage, oofem::LatticeDamageViscoelastic, oofem::LatticeLinearElastic, oofem::LatticeLink3d, oofem::LatticeLink3dBoundary, oofem::LatticePlasticityDamage, oofem::LatticePlasticityDamageViscoelastic, oofem::LatticeSlip, oofem::LatticeTransportMaterial, oofem::LatticeViscoelastic, oofem::LayeredCrossSection, oofem::LIBeam2d, oofem::LIBeam2dNL, oofem::LIBeam3d2, oofem::LIBeam3d, oofem::LIBeam3dBoundary, oofem::LIBeam3dBoundaryBeam, oofem::LIBeam3dBoundaryMembrane, oofem::LIBeam3dBoundaryPlate, oofem::LIBeam3dBoundaryTruss, oofem::LIBeam3dBoundaryVoigt, oofem::LIBeam3dNL2, oofem::LIBeam3dNL, oofem::Line1_hmt, oofem::Line1_ht, oofem::Line1_mt, oofem::Line2BoundaryElement, oofem::LinearConstraintBC, oofem::LinearEdgeLoad, oofem::LineDistributedSpring, oofem::LinkSlip, oofem::LinQuad3DPlaneStress, oofem::ListBasedEI, oofem::LocalGaussianRandomFunction, oofem::LSpace, oofem::LSpaceBB, oofem::LTRSpace, oofem::LTRSpaceBoundary, oofem::LTRSpaceBoundaryBeam, oofem::LTRSpaceBoundaryMembrane, oofem::LTRSpaceBoundaryPlate, oofem::LTRSpaceBoundaryTruss, oofem::LTRSpaceBoundaryVoigt, oofem::LumpedMassElement, oofem::LWedge, oofem::M1Material, oofem::M4Material, oofem::MacroLSpace, oofem::Masonry02, oofem::MaterialInterface, oofem::MazarsMaterial, oofem::MDM, oofem::MeshQualityErrorEstimator, oofem::MFrontUserMaterial, oofem::MicroMaterial, oofem::MisesMat, oofem::MisesMatGrad, oofem::MisesMatNl, oofem::MITC4Shell, oofem::MixedGradientPressureDirichlet, oofem::MixedGradientPressureNeumann, oofem::MixedGradientPressureWeakPeriodic, oofem::MooneyRivlinCompressibleMaterial, oofem::MooneyRivlinCompressibleMaterial, oofem::MPSDamMaterial, oofem::MPSMaterial, oofem::NeumannMomentLoad, oofem::NewtonianFluidMaterial, oofem::NlIsoMoistureMaterial, oofem::NodalLoad, oofem::NodalSpringElement, oofem::Node, oofem::NonlinearFluidMaterial, oofem::NonlinearMassTransferMaterial, oofem::NURBSPlaneStressElement, oofem::NURBSSpace3dElement, oofem::OgdenCompressibleMaterial, oofem::OrthotropicLinearElasticMaterial, oofem::Particle, oofem::PeakFunction, oofem::PeriodicPiecewiseLinFunction, oofem::PFEMParticle, oofem::PiecewiseLinFunction, oofem::PlaneStress2d, oofem::PlaneStress2dXfem, oofem::PlaneStressGradDamage, oofem::PlaneStressPhF2d, oofem::PointLoad, oofem::PoissonElement, oofem::PolylineNonlocalBarrier, oofem::PrescribedDispSlipBCDirichletRC, oofem::PrescribedDispSlipBCNeumannRC, oofem::PrescribedDispSlipMultiple, oofem::PrescribedGenStrainShell7, oofem::PrescribedGenStrainShell7, oofem::PrescribedGradient, oofem::PrescribedGradientBCNeumann, oofem::PrescribedGradientBCPeriodic, oofem::PrescribedGradientBCWeak, oofem::PrescribedGradientBCWeakDirichlet, oofem::PrescribedGradientBCWeakPeriodic, oofem::PrescribedGradientMultiple, oofem::PrescribedMean, oofem::PulseFunction, oofem::PythonExpression, oofem::Q1Element, oofem::Q27Space, oofem::Q4Axisymm, oofem::Q9PlaneStress2d, oofem::QBrick1_hmt, oofem::QBrick1_ht, oofem::QBrick1_mt, oofem::qcNode, oofem::QDKTPlate, oofem::QPlaneStrain, oofem::QPlaneStrainGrad, oofem::QPlaneStrainGradDamage, oofem::QPlaneStress2d, oofem::QPlaneStress2dSlip, oofem::QPlaneStressGradDamage, oofem::QPlaneStressPhF2d, oofem::QQuad1_hmt, oofem::QQuad1_ht, oofem::QQuad1_mt, oofem::QSpace, oofem::QSpaceGradDamage, oofem::QTrPlaneStrain, oofem::QTrPlaneStrainP1, oofem::QTrPlaneStress2d, oofem::QTrPlaneStress2dSlip, oofem::QTrPlaneStress2dXFEM, oofem::QTrPlaneStressGradDamage, oofem::QTRSpace, oofem::QTRSpaceGradDamage, oofem::QTruss1d, oofem::QTruss1dGradDamage, oofem::Quad10_2D_SUPG, oofem::Quad1_hmt, oofem::Quad1_ht, oofem::Quad1_mt, oofem::Quad1Mindlin, oofem::Quad1MindlinShell3D, oofem::Quad1PlaneStrain, oofem::Quad1PlaneStrainGradDamage, oofem::Quad1PlaneStrainP1, oofem::Quad1PlateSubSoil, oofem::Quad2PlateSubSoil, oofem::QWedge, oofem::QWedge_hmt, oofem::QWedge_ht, oofem::QWedge_mt, oofem::QWedgeGradDamage, oofem::RampFunction, oofem::RankineMat, oofem::RankineMatGrad, oofem::RankineMatNl, oofem::RankinePlasticMaterial, oofem::RCSDEMaterial, oofem::RCSDMaterial, oofem::Reinforcement, oofem::RerShell, oofem::RigidArmNode, oofem::RotatingBoundary, oofem::RVEStokesFlow, oofem::SADGBLine1, oofem::ScalarErrorIndicator, oofem::Set, oofem::ShellCrack, oofem::SimoPisterMaterial, oofem::SimpleCrossSection, oofem::SimpleInterfaceMaterial, oofem::SimpleTransportCrossSection, oofem::SimpleVitrificationMaterial, oofem::SlaveNode, oofem::SolidShell, oofem::SolutionbasedShapeFunction, oofem::SpringElement, oofem::Steel1, oofem::SteelRelaxMat, oofem::StepFunction, oofem::StructuralContactElement_LineLin, oofem::StructuralContactElement_QuadLin, oofem::StructuralContactElement_TrLin, oofem::StructuralEigenstrainLoad, oofem::StructuralFE2Material, oofem::StructuralFEContactSurface, oofem::StructuralInterfaceCrossSection, oofem::StructuralMaterialSettable, oofem::StructuralPenaltyContactBoundaryCondition, oofem::StructuralPythonMaterial, oofem::StructuralSlipFE2Material, oofem::StructuralTemperatureLoad, oofem::SurfaceTensionBoundaryCondition, oofem::SymmetryBarrier, oofem::Tet1_3D_SUPG, oofem::Tet1BubbleStokes, oofem::tet21ghostsolid, oofem::Tet21Stokes, oofem::Tetrah1_hmt, oofem::Tetrah1_ht, oofem::TF1, oofem::TMBrick11, oofem::TMSimpleMaterial, oofem::TR1_2D_CBS, oofem::TR1_2D_PFEM, oofem::TR1_2D_SUPG2, oofem::TR1_2D_SUPG2_AXI, oofem::TR1_2D_SUPG, oofem::TR1_2D_SUPG_AXI, oofem::Tr1_hmt, oofem::Tr1_ht, oofem::Tr1_mt, oofem::Tr1BubbleStokes, oofem::Tr1Darcy, oofem::TR21_2D_SUPG, oofem::Tr21Stokes, oofem::Tr2Shell7, oofem::Tr2Shell7XFEM, oofem::TR_SHELL01, oofem::TR_SHELL02, oofem::TR_SHELL11, oofem::Tr_Warp, oofem::TrabBone3D, oofem::TrabBoneEmbed, oofem::TrabBoneGrad3D, oofem::TrabBoneMaterial, oofem::TrabBoneNL3D, oofem::TrabBoneNL, oofem::TrabBoneNLEmbed, oofem::TractionPressureBC, oofem::TransportGradientDirichlet, oofem::TransportGradientNeumann, oofem::TransportGradientPeriodic, oofem::TransverseReinfConstraint, oofem::TrAxisym1_ht, oofem::Tria1PlateSubSoil, oofem::Tria2PlateSubSoil, oofem::TrPlaneStrain, oofem::TrPlaneStress2d, oofem::TrPlaneStress2dXFEM, oofem::TrPlaneStressGradDamage, oofem::TrPlanestressRotAllman3d, oofem::TrPlanestressRotAllman, oofem::TrPlaneStrRot3d, oofem::TrPlaneStrRot, oofem::Truss1d, oofem::Truss1dGradDamage, oofem::Truss2d, oofem::Truss3d, oofem::Truss3dnl2, oofem::Truss3dnl, oofem::TSplinePlaneStressElement, oofem::TutorialMaterial, oofem::TwoFluidMaterial, oofem::TwoPhaseMaterial, oofem::UPSimpleMaterial, oofem::UPTetra21, oofem::UserDefDirichletBC, oofem::UserDefinedTemperatureField, oofem::UsrDefBoundaryLoad, oofem::VariableCrossSection, oofem::WarpingCrossSection, oofem::WeakPeriodicBoundaryCondition, oofem::Wedge_hmt, oofem::Wedge_ht, oofem::Wedge_mt, oofem::WinklerMaterial, oofem::WinklerPasternakMaterial, oofem::ZZErrorEstimator, and oofem::ZZRemeshingCriteria.

Referenced by giveInputRecord(), oofem::LoadBalancer::packMigratingData(), oofem::NonlocalMaterialWTP::packRemoteElements(), oofem::Subdivision::packRemoteElements(), and oofem::XfemManager::saveContext().

◆ giveInterface()

virtual Interface * oofem::FEMComponent::giveInterface ( InterfaceType t)
inlinevirtual

Interface requesting service.

See also
InterfaceType
Returns
Requested interface if implemented, otherwise NULL.

Reimplemented in oofem::Axisymm3d, oofem::Beam2d, oofem::Beam3d, oofem::Brick1_ht, oofem::CCTPlate, oofem::DKTPlate, oofem::FRCFCMNL, oofem::Hexa21Stokes, oofem::IDNLMaterial, oofem::IntElLine1, oofem::InterfaceElem2dQuad, oofem::IsotropicDamageMaterial1, oofem::IsotropicGradientDamageMaterial, oofem::IsotropicLinearElasticMaterial, oofem::L4Axisymm, oofem::LargeStrainMasterMaterialGrad, oofem::LatticeLinearElastic, oofem::LatticeSlip, oofem::LIBeam2d, oofem::LIBeam2dNL, oofem::LIBeam3d2, oofem::LIBeam3d, oofem::LIBeam3dNL, oofem::Line1_ht, oofem::Line2BoundaryElement, oofem::LineDistributedSpring, oofem::LinkSlip, oofem::LinQuad3DPlaneStress, oofem::LSpace, oofem::LTRSpace, oofem::LTRSpaceBoundary, oofem::LWedge, oofem::MazarsNLMaterial, oofem::MDM, oofem::MisesMatGrad, oofem::MisesMatNl, oofem::MITC4Shell, oofem::PFEMElement2d, oofem::PlaneStress2d, oofem::PlaneStress2dXfem, oofem::Q27Space, oofem::Q4Axisymm, oofem::Q9PlaneStress2d, oofem::QBrick1_ht, oofem::QDKTPlate, oofem::QPlaneStrain, oofem::QPlaneStress2d, oofem::QQuad1_ht, oofem::QSpace, oofem::QTrPlaneStrain, oofem::QTrPlaneStress2d, oofem::QTrPlaneStress2dXFEM, oofem::QTRSpace, oofem::Quad10_2D_SUPG, oofem::Quad1_ht, oofem::Quad1Mindlin, oofem::Quad1MindlinShell3D, oofem::Quad1PlaneStrain, oofem::Quad1PlateSubSoil, oofem::QWedge, oofem::QWedge_ht, oofem::RankineMatGrad, oofem::RankineMatNl, oofem::RCSDNLMaterial, oofem::RerShell, oofem::SADGBLine1, oofem::Shell7Base, oofem::Shell7BaseXFEM, oofem::StructuralInterfaceElement, oofem::Tet1_3D_SUPG, oofem::Tet1BubbleStokes, oofem::tet21ghostsolid, oofem::Tet21Stokes, oofem::Tetrah1_ht, oofem::TMBrick11, oofem::TR1_2D_CBS, oofem::TR1_2D_PFEM, oofem::TR1_2D_SUPG2, oofem::TR1_2D_SUPG, oofem::Tr1_ht, oofem::Tr1BubbleStokes, oofem::Tr1Darcy, oofem::TR21_2D_SUPG, oofem::Tr21Stokes, oofem::TR_SHELL01, oofem::TR_SHELL02, oofem::TR_SHELL11, oofem::Tr_Warp, oofem::TrabBoneGrad3D, oofem::TrabBoneNL3D, oofem::TrabBoneNL, oofem::TrabBoneNLEmbed, oofem::Tria1PlateSubSoil, oofem::TrPlaneStrain, oofem::TrPlaneStress2d, oofem::TrPlaneStress2dXFEM, oofem::TrPlanestressRotAllman, oofem::Truss1d, oofem::Truss3d, and oofem::Wedge_ht.

Definition at line 181 of file femcmpnn.h.

Referenced by oofem::PrimaryField::__evaluateAt(), oofem::Element::adaptiveMap(), oofem::FailureCriteria::computeFailureCriteriaQuantities(), oofem::SPRNodalRecoveryModel::computePatch(), oofem::SPRNodalRecoveryModel::determinePatchAssemblyPoints(), oofem::SPRNodalRecoveryModel::determinePatchType(), oofem::LEPlic::doInterfaceReconstruction(), oofem::ZZErrorEstimator::estimateError(), oofem::LevelSetPCS::evalElemFContribution(), oofem::LevelSetPCS::evalElemfContribution(), oofem::VTKXMLExportModule::exportCompositeElement(), oofem::VTKXMLExportModule::exportCompositeElement(), oofem::LEPlic::findCellLineConstant(), oofem::WinklerMaterial::give3dBeamSubSoilStiffMtrx(), oofem::DummySpatialLocalizer::giveElementClosestToPoint(), oofem::OctreeSpatialLocalizer::giveElementClosestToPointWithinOctant(), oofem::OctreeSpatialLocalizer::giveElementContainingPoint(), oofem::OctreeSpatialLocalizer::giveElementContainingPoint(), oofem::ZZErrorEstimator::giveElementError(), oofem::LEPlic::giveElementMaterialMixture(), oofem::LevelSetPCS::giveElementMaterialMixture(), oofem::NonlocalMaterialWTP::giveElementNonlocalDepArry(), oofem::LargeStrainMasterMaterialGrad::giveFirstPKStressVectorGrad(), oofem::tet21ghostsolid::giveInterface(), oofem::SimpleCrossSection::giveMaterialInterface(), oofem::LEPlic::giveMaterialMixtureAt(), oofem::LevelSetPCS::giveMaterialMixtureAt(), oofem::HydrationModel::giveStatus(), oofem::OctreeSpatialLocalizer::initElementDataStructure(), oofem::SPRNodalRecoveryModel::initPatch(), oofem::LEPlicElementInterface::isBoundary(), oofem::LevelSetPCS::pcs_stage1(), oofem::NodalAveragingRecoveryModel::recoverValues(), oofem::ZZNodalRecoveryModel::recoverValues(), oofem::HuertaErrorEstimator::solveRefinedElementProblem(), oofem::HuertaErrorEstimator::solveRefinedPatchProblem(), oofem::HuertaErrorEstimator::solveRefinedWholeProblem(), and oofem::LevelSetPCS::updatePosition().

◆ giveNumber()

int oofem::FEMComponent::giveNumber ( ) const
inline
Returns
Component number of receiver.

Definition at line 104 of file femcmpnn.h.

References number.

Referenced by oofem::MMALeastSquareProjection::__init(), oofem::MMAShapeFunctProjection::__mapVariable(), oofem::Quasicontinuum::applyApproach2(), oofem::Quasicontinuum::applyApproach3(), oofem::NonlocalMaterialExtensionInterface::buildNonlocalPointTable(), oofem::HangingNode::checkConsistency(), oofem::Material::checkConsistency(), oofem::CompoDamageMat::checkSnapBack(), oofem::MPlasticMaterial2::closestPointReturn(), oofem::MPlasticMaterial::closestPointReturn(), oofem::Tr_Warp::computeBmatrixAt(), oofem::Shell7BaseXFEM::computeCohesiveTangent(), oofem::MPSDamMaterial::computeDamageForCohesiveCrack(), oofem::IsotropicDamageMaterial1::computeDamageParamForCohesiveCrack(), oofem::PrescribedGradientBCPeriodic::computeDofTransformation(), oofem::SolutionbasedShapeFunction::computeDofTransformation(), oofem::TransportGradientPeriodic::computeDofTransformation(), oofem::Tr_Warp::computeEdgeLoadVectorAt(), oofem::Shell7BaseXFEM::computeFailureCriteriaQuantities(), oofem::PrescribedGenStrainShell7::computeField(), oofem::PrescribedGradient::computeField(), oofem::TransportGradientDirichlet::computeField(), oofem::MixedGradientPressureDirichlet::computeFields(), oofem::TR1_2D_CBS::computeMyVolume(), oofem::TR1_2D_SUPG2::computeMyVolume(), oofem::TR1_2D_SUPG2_AXI::computeMyVolume(), oofem::TR1_2D_SUPG::computeMyVolume(), oofem::FRCFCMNL::computeNonlocalStressInFibers(), oofem::FRCFCMNL::computeNonlocalStressInFibersInUncracked(), oofem::MacroLSpace::computeStiffnessMatrix(), oofem::PrescribedDispSlipBCDirichletRC::computeStress(), oofem::StructuralMaterial::computeStressIndependentStrainVector(), oofem::StructuralMaterial::computeStressIndependentStrainVector_3d(), oofem::FRCFCM::computeTempDamage(), oofem::TransportGradientDirichlet::computeXi(), oofem::DGProblem::constructBoundaryEntities(), oofem::FreemInterface::createInput(), oofem::T3DInterface::createInput(), oofem::MPlasticMaterial2::cuttingPlaneReturn(), oofem::MPlasticMaterial::cuttingPlaneReturn(), oofem::SPRNodalRecoveryModel::determinePatchAssemblyPoints(), oofem::Shell7BaseXFEM::discComputeBulkTangentMatrix(), oofem::DofManExportModule::doOutput(), oofem::MatlabExportModule::doOutputIntegrationPointFields(), oofem::Element::drawAnnotation(), oofem::Node::drawYourself(), errorInfo(), oofem::HuertaRemeshingCriteria::estimateMeshDensities(), oofem::DofManValueField::evaluateAt(), oofem::SmoothedNodalInternalVariableField::evaluateAt(), oofem::GeometryBasedEI::evaluateEnrFuncInNode(), oofem::VTKExportModule::exportPrimVarAs(), oofem::HuertaErrorEstimator::extractVectorFrom(), oofem::LEPlic::findCellLineConstant(), oofem::PrescribedGradientBCWeak::findHoleCoord(), oofem::PrescribedGradientBCPeriodic::findSlaveToMasterMap(), oofem::TransportGradientPeriodic::findSlaveToMasterMap(), oofem::TR1_2D_CBS::formMaterialVolumePoly(), oofem::TR1_2D_SUPG2::formMaterialVolumePoly(), oofem::TR1_2D_SUPG2_AXI::formMaterialVolumePoly(), oofem::TR1_2D_SUPG::formMaterialVolumePoly(), oofem::TR1_2D_CBS::formMyVolumePoly(), oofem::TR1_2D_SUPG2::formMyVolumePoly(), oofem::TR1_2D_SUPG2_AXI::formMyVolumePoly(), oofem::TR1_2D_SUPG::formMyVolumePoly(), oofem::TR1_2D_CBS::formVolumeInterfacePoly(), oofem::TR1_2D_SUPG2::formVolumeInterfacePoly(), oofem::TR1_2D_SUPG2_AXI::formVolumeInterfacePoly(), oofem::TR1_2D_SUPG::formVolumeInterfacePoly(), oofem::VTKBaseExportModule::getCellVariableFromIS(), oofem::VTKExportModule::getDofManPrimaryVariable(), oofem::VTKBaseExportModule::getNodalVariableFromIS(), oofem::VTKBaseExportModule::getNodalVariableFromPrimaryField(), oofem::VTKXMLXFemExportModule::getNodalVariableFromXFEMST(), oofem::TransportGradientDirichlet::give(), oofem::VariableCrossSection::give(), oofem::VTKBaseExportModule::giveCellType(), oofem::Material::giveCharacteristicValue(), oofem::OctreeSpatialLocalizer::giveClosestIP(), oofem::OctreeSpatialLocalizer::giveClosestIPWithinOctant(), oofem::Shell7BaseXFEM::giveCZExportData(), oofem::VTKXMLXFemExportModule::giveDataHeaders(), oofem::MITC4Shell::giveDirectorVectors(), oofem::VTKBaseExportModule::giveElementCell(), oofem::VTKExportModule::giveElementCell(), oofem::TR1_2D_CBS::giveElementCenter(), oofem::TR1_2D_SUPG2::giveElementCenter(), oofem::TR1_2D_SUPG2_AXI::giveElementCenter(), oofem::TR1_2D_SUPG::giveElementCenter(), oofem::OctreeSpatialLocalizer::giveElementContainingPoint(), oofem::HuertaErrorEstimator::giveElementError(), oofem::ZZErrorEstimator::giveElementError(), oofem::ConnectivityTable::giveElementNeighbourList(), oofem::VariableCrossSection::giveExpression(), oofem::AbaqusUserMaterial::giveFirstPKStressVector_3d(), oofem::Function::giveFunctionParameter(), giveInputRecord(), oofem::Set::giveInputRecord(), oofem::MacroLSpace::giveInternalForcesVector(), oofem::Element::giveInternalStateAtNode(), oofem::CrossSection::giveIPValue(), oofem::Element::giveIPValue(), oofem::LatticeCrossSection::giveIPValue(), oofem::Material::giveIPValue(), oofem::Quad10_2D_SUPG::giveIPValue(), oofem::SimpleCrossSection::giveIPValue(), oofem::StructuralInterfaceCrossSection::giveIPValue(), oofem::StructuralMaterial::giveIPValue(), oofem::TR1_2D_SUPG::giveIPValue(), oofem::LatticePlasticityDamageViscoelastic::giveLatticeStress3d(), oofem::RheoChainMaterial::giveLinearElasticMaterial(), oofem::PrescribedGradientBCPeriodic::giveMasterDof(), oofem::TransportGradientPeriodic::giveMasterDof(), oofem::CompoDamageMat::giveRealStressVector(), oofem::MDM::giveRealStressVector(), oofem::AbaqusUserMaterial::giveRealStressVector_3d(), oofem::Shell7BaseXFEM::giveShellExportData(), oofem::MisesMat::giveTemperature(), oofem::SimpleCrossSection::giveTemperatureVector(), oofem::TwoFluidMaterial::giveTempVOF(), oofem::PrescribedGradientBCPeriodic::giveUnknown(), oofem::PrescribedGradientBCPeriodic::giveUnknown(), oofem::PrescribedGradientBCPeriodic::giveUnknown(), oofem::TransportGradientPeriodic::giveUnknown(), oofem::TransportGradientPeriodic::giveUnknown(), oofem::TransportGradientPeriodic::giveUnknown(), oofem::DruckerPragerPlasticitySM::giveVertexAlgorithmicStiffMatrix(), oofem::MPMSymbolicTerm::initializeCell(), oofem::Quasicontinuum::initializeConnectivityTableForInterpolationElements(), oofem::HydratingHeMoMaterial::initializeFrom(), oofem::HydratingIsoHeatMaterial::initializeFrom(), oofem::Node::initializeFrom(), oofem::OrthotropicLinearElasticMaterial::initializeFrom(), oofem::SUPGElement::initializeFrom(), oofem::SymmetryBarrier::initializeFrom(), oofem::TrPlaneStress2dXFEM::initializeFrom(), oofem::SolutionbasedShapeFunction::initializeSurfaceData(), oofem::ListBasedEI::initiateFronts(), oofem::NodalRecoveryModel::initRegionNodeNumbering(), oofem::QuasicontinuumVTKXMLExportModule::initRegionNodeNumbering(), oofem::VTKBaseExportModule::initRegionNodeNumbering(), oofem::VTKXMLLatticeExportModule::initRegionNodeNumbering(), oofem::VTKXMLPeriodicExportModule::initRegionNodeNumbering(), oofem::ConnectivityTable::instanciateConnectivityTable(), oofem::Delamination::instanciateYourself(), oofem::QClinearStatic::isElementActivated(), oofem::FreeConstantSurfaceLoad::isImposed(), oofem::TR21_2D_SUPG::LS_PCS_computeVOFFractions(), oofem::MMAShapeFunctProjection::mapVariable(), oofem::TMLhsAssembler::matrixFromElement(), oofem::LoadBalancer::migrateLoad(), oofem::IsotropicDamageMaterial1::MMI_map(), oofem::MDM::MMI_map(), oofem::Material::modifyProperty(), oofem::QClinearStatic::nodeInFullSolvedDomainTest(), oofem::GnuplotExportModule::outputBoundaryCondition(), oofem::GnuplotExportModule::outputBoundaryCondition(), oofem::GnuplotExportModule::outputBoundaryCondition(), oofem::GnuplotExportModule::outputXFEM(), oofem::DGProblem::postInitialize(), oofem::HangingNode::postInitialize(), oofem::IntElLine1::postInitialize(), oofem::WeakPeriodicBoundaryCondition::postInitialize(), oofem::qcNode::postInitializeAsHangingNode(), oofem::Beam2d::printOutputAt(), oofem::Beam3d::printOutputAt(), oofem::CCTPlate3d::printOutputAt(), oofem::CemhydMatStatus::printOutputAt(), oofem::ClonedDofManager::printOutputAt(), oofem::DKTPlate3d::printOutputAt(), oofem::DofManager::printOutputAt(), oofem::Element::printOutputAt(), oofem::LatticeDirichletCouplingNode::printOutputAt(), oofem::LineDistributedSpring::printOutputAt(), oofem::LinQuad3DPlaneStress::printOutputAt(), oofem::NodalSpringElement::printOutputAt(), oofem::PFEMElement::printOutputAt(), oofem::qcNode::printOutputAt(), oofem::SpringElement::printOutputAt(), oofem::TR_SHELL01::printOutputAt(), oofem::TR_SHELL02::printOutputAt(), oofem::TR_SHELL11::printOutputAt(), oofem::TrPlanestressRotAllman3d::printOutputAt(), oofem::TrPlaneStrRot3d::printOutputAt(), oofem::Delamination::propagateFronts(), oofem::PLCZdamageRadius::propagateInterface(), oofem::NodalAveragingRecoveryModel::recoverValues(), oofem::ZZNodalRecoveryModel::recoverValues(), oofem::RefinedMesh::refineMeshGlobally(), oofem::HuertaErrorEstimatorInterface::setupRefinedElementProblem1D(), oofem::HuertaErrorEstimatorInterface::setupRefinedElementProblem2D(), oofem::HuertaErrorEstimatorInterface::setupRefinedElementProblem3D(), oofem::VTKXMLLatticeExportModule::setupVTKPiece(), oofem::VTKXMLPeriodicExportModule::setupVTKPiece(), oofem::FreemInterface::smoothNodalDensities(), oofem::HuertaErrorEstimator::solveRefinedPatchProblem(), oofem::Axisymm3d::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::Brick1_ht::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::CCTPlate::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::DKTPlate::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::L4Axisymm::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::LineDistributedSpring::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::LSpace::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::LTRSpace::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::LWedge::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::MITC4Shell::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::PlaneStress2d::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::Q27Space::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::QBrick1_ht::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::QDKTPlate::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::QQuad1_ht::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::QSpace::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::QTrPlaneStrain::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::QTrPlaneStress2d::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::QTRSpace::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::Quad1Mindlin::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::Quad1MindlinShell3D::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::Quad1PlaneStrain::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::Quad1PlateSubSoil::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::Quad2PlateSubSoil::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::QWedge::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::QWedge_ht::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::TR1_2D_CBS::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::TR1_2D_SUPG2::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::TR1_2D_SUPG2_AXI::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::TR1_2D_SUPG::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::TR_SHELL11::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::Tria1PlateSubSoil::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::Tria2PlateSubSoil::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::TrPlaneStrain::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::TrPlaneStress2d::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::Wedge_ht::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::CCTPlate::SPRNodalRecoveryMI_giveSPRAssemblyPoints(), oofem::DKTPlate::SPRNodalRecoveryMI_giveSPRAssemblyPoints(), oofem::MITC4Shell::SPRNodalRecoveryMI_giveSPRAssemblyPoints(), oofem::QDKTPlate::SPRNodalRecoveryMI_giveSPRAssemblyPoints(), oofem::Quad1Mindlin::SPRNodalRecoveryMI_giveSPRAssemblyPoints(), oofem::Quad1MindlinShell3D::SPRNodalRecoveryMI_giveSPRAssemblyPoints(), oofem::T3DInterface::t3d_2_OOFEM(), oofem::oofegGraphicContext::testElementGraphicActivity(), oofem::QClinearStatic::transformMeshToParticles(), oofem::HydratingHeMoMaterial::updateInternalState(), oofem::HydratingIsoHeatMaterial::updateInternalState(), oofem::ListBasedEI::updateNodeEnrMarker(), oofem::TMResidualAssembler::vectorFromElement(), oofem::VTKXMLXFemExportModule::writeXFEMVars(), oofem::Shell7Base::ZZNodalRecoveryMI_ComputeEstimatedInterpolationMtrx(), and oofem::Tr_Warp::ZZNodalRecoveryMI_computeNNMatrix().

◆ initializeFinish()

virtual void oofem::FEMComponent::initializeFinish ( )
inlinevirtual

Finishes the initialization. Note that initializeFrom may be called multiple times. The initializeFinish typycally performs the input parameter checking (if compulsory parameters set, etc.) After initializeFinish, DOFs and other components may be created.

Reimplemented in oofem::CBSElement, oofem::DofManager, oofem::Element, oofem::GeneralSlaveNode, oofem::IGAElement, oofem::IGATSplineElement, oofem::InterfaceElem1d, oofem::LIBeam2d, oofem::NodalSpringElement, and oofem::Node.

Definition at line 136 of file femcmpnn.h.

◆ initializeFrom() [1/2]

void oofem::FEMComponent::initializeFrom ( InputRecord & ir)
virtual

Initializes receiver according to object description stored in input record. This function is called immediately after creating object using constructor. Input record can be imagined as data record in component database belonging to receiver. Receiver may use value-name extracting functions to extract particular field from record. Note that initializeFrom may be called mutiple times.

See also
IR_GIVE_FIELD
IR_GIVE_OPTIONAL_FIELD
Parameters
irInput record to initialize from.
priorityPriority of the input record. This is used to determine the order of initialization

Reimplemented in oofem::AbaqusUserMaterial, oofem::ActiveBoundaryCondition, oofem::AnisotropicDamageMaterial, oofem::AnisotropicLinearElasticMaterial, oofem::AnisotropicMassTransferMaterial, oofem::B3Material, oofem::B3SolidMaterial, oofem::BazantNajjarMoistureTransferMaterial, oofem::BinghamFluidMaterial2, oofem::BlatzKoMaterial, oofem::BondCEBMaterial, oofem::BoundaryCondition, oofem::BoundaryLoad, oofem::CalculatorFunction, oofem::CebFip78Material, oofem::CebFipSlip90Material, oofem::CemhydMat, oofem::CohesiveInterfaceMaterial, oofem::CombinedZZSIErrorEstimator, oofem::CombinedZZSIRemeshingCriteria, oofem::CompoDamageMat, oofem::Concrete2, oofem::Concrete3, oofem::ConcreteDPM2, oofem::ConcreteDPM, oofem::ConcreteFCM, oofem::ConcreteFCMViscoElastic, oofem::ConstantEdgeLoad, oofem::ConstantFunction, oofem::ConstantPressureLoad, oofem::ConstantSurfaceLoad, oofem::Crack, oofem::CrossSection, oofem::Delamination, oofem::DepositedHeatSource, oofem::DirectErrorIndicatorRC, oofem::DofManager, oofem::DoublePowerLawMaterial, oofem::DruckerPragerCutMat, oofem::DruckerPragerPlasticitySM, oofem::DummyCrossSection, oofem::DummyMaterial, oofem::DustMaterial, oofem::EnrichmentFunction, oofem::EnrichmentItem, oofem::ErrorEstimator, oofem::Eurocode2CreepMaterial, oofem::ExpCZMaterial, oofem::ExternalTemperatureFieldLoad, oofem::FCMMaterial, oofem::FE2FluidMaterial, oofem::FEContactSurface, oofem::FiberedCrossSection, oofem::FluidCrossSection, oofem::FRCFCM, oofem::FRCFCMNL, oofem::FreeConstantSurfaceLoad, oofem::GeneralBoundaryCondition, oofem::GravityPressure, oofem::HeavisideTimeFunction, oofem::HeMoBazNajMaterial, oofem::HeMoKunzelMaterial, oofem::HeMoTKMaterial, oofem::HuertaErrorEstimator, oofem::HuertaRemeshingCriteria, oofem::HydratingConcreteMat, oofem::HydratingHeMoMaterial, oofem::HydratingIsoHeatMaterial, oofem::HydrationModel, oofem::HyperelasticMaterial1d, oofem::IDNLMaterial, oofem::Inclusion, oofem::InitialCondition, oofem::IntElLine1PF, oofem::InteractionLoad, oofem::InterpolatingFuction, oofem::IntMatBilinearCZ, oofem::IntMatBilinearCZElastic, oofem::IntMatBilinearCZFagerstrom, oofem::IntMatBilinearCZFagerstromRate, oofem::IntMatBilinearCZJansson, oofem::IntMatCoulombContact, oofem::IntMatDummyCZ, oofem::IntMatElastic, oofem::IntMatIsoDamage, oofem::IntMatIsoDamageTable, oofem::IntMatPhaseField, oofem::IsoInterfaceDamageMaterial, oofem::IsoInterfaceDamageMaterial_2, oofem::IsotropicAsymmetric1DMaterial, oofem::IsotropicDamageMaterial1, oofem::IsotropicDamageMaterial, oofem::IsotropicGradientDamageMaterial, oofem::IsotropicHeatTransferMaterial, oofem::IsotropicLinearElasticMaterial, oofem::IsotropicLinMoistureTransferMaterial, oofem::IsotropicMoistureTransferMaterial, oofem::J2Mat, oofem::J2MPlasticMaterial, oofem::J2plasticMaterial, oofem::KelvinChainMaterial, oofem::KelvinChainSolidMaterial, oofem::LargeStrainMasterMaterial, oofem::LargeStrainMasterMaterialGrad, oofem::LatticeBondPlasticity, oofem::LatticeCrossSection, oofem::LatticeDamage, oofem::LatticeDamageViscoelastic, oofem::LatticeLinearElastic, oofem::LatticePlasticityDamage, oofem::LatticePlasticityDamageViscoelastic, oofem::LatticeSlip, oofem::LatticeTransportMaterial, oofem::LatticeViscoelastic, oofem::LayeredCrossSection, oofem::LEPlic, oofem::LevelSetPCS, oofem::LinearConstraintBC, oofem::LinearEdgeLoad, oofem::LinearElasticMaterial, oofem::LinkSlip, oofem::Load, oofem::LocalGaussianRandomFunction, oofem::M1Material, oofem::M4Material, oofem::Masonry02, oofem::Material, oofem::MaxwellChainMaterial, oofem::MazarsMaterial, oofem::MazarsNLMaterial, oofem::MDM, oofem::MeshQualityErrorEstimator, oofem::MFrontUserMaterial, oofem::MicroMaterial, oofem::MicroplaneMaterial, oofem::MisesMat, oofem::MisesMatGrad, oofem::MisesMatNl, oofem::MixedGradientPressureBC, oofem::MixedGradientPressureDirichlet, oofem::MixedGradientPressureNeumann, oofem::MixedGradientPressureWeakPeriodic, oofem::MooneyRivlinCompressibleMaterial, oofem::MooneyRivlinCompressibleMaterial, oofem::MPSDamMaterial, oofem::MPSMaterial, oofem::NeumannMomentLoad, oofem::NewtonianFluidMaterial, oofem::NlIsoMoistureMaterial, oofem::NodalLoad, oofem::Node, oofem::NonlinearFluidMaterial, oofem::NonlinearMassTransferMaterial, oofem::OgdenCompressibleMaterial, oofem::OrthotropicLinearElasticMaterial, oofem::PeakFunction, oofem::PerfectlyPlasticMaterial, oofem::PeriodicPiecewiseLinFunction, oofem::PiecewiseLinFunction, oofem::PointLoad, oofem::PolylineNonlocalBarrier, oofem::PrescribedDispSlipBCDirichletRC, oofem::PrescribedDispSlipBCNeumannRC, oofem::PrescribedDispSlipMultiple, oofem::PrescribedGenStrainShell7, oofem::PrescribedGenStrainShell7, oofem::PrescribedGradient, oofem::PrescribedGradientBCNeumann, oofem::PrescribedGradientBCPeriodic, oofem::PrescribedGradientBCWeak, oofem::PrescribedGradientBCWeakDirichlet, oofem::PrescribedGradientBCWeakPeriodic, oofem::PrescribedGradientMultiple, oofem::PrescribedMean, oofem::PulseFunction, oofem::PythonExpression, oofem::RankineMat, oofem::RankineMatGrad, oofem::RankineMatNl, oofem::RankinePlasticMaterial, oofem::RCM2Material, oofem::RCSDEMaterial, oofem::RCSDMaterial, oofem::RCSDNLMaterial, oofem::Reinforcement, oofem::RheoChainMaterial, oofem::RotatingBoundary, oofem::RVEStokesFlow, oofem::ScalarErrorIndicator, oofem::Set, oofem::ShellCrack, oofem::SimoPisterMaterial, oofem::SimpleCrossSection, oofem::SimpleInterfaceMaterial, oofem::SimpleTransportCrossSection, oofem::SimpleVitrificationMaterial, oofem::SolidShell, oofem::SolutionbasedShapeFunction, oofem::Steel1, oofem::SteelRelaxMat, oofem::StepFunction, oofem::StructuralFE2Material, oofem::StructuralInterfaceCrossSection, oofem::StructuralInterfaceMaterial, oofem::StructuralMaterial, oofem::StructuralMaterialSettable, oofem::StructuralPenaltyContactBoundaryCondition, oofem::StructuralPythonMaterial, oofem::StructuralSlipFE2Material, oofem::SurfaceTensionBoundaryCondition, oofem::SymmetryBarrier, oofem::TF1, oofem::TMSimpleMaterial, oofem::TrabBone3D, oofem::TrabBoneEmbed, oofem::TrabBoneGrad3D, oofem::TrabBoneMaterial, oofem::TrabBoneNL3D, oofem::TrabBoneNL, oofem::TrabBoneNLEmbed, oofem::TransportGradientDirichlet, oofem::TransportGradientNeumann, oofem::TransportGradientPeriodic, oofem::TransverseReinfConstraint, oofem::TutorialMaterial, oofem::TwoFluidMaterial, oofem::TwoPhaseMaterial, oofem::UPSimpleMaterial, oofem::UserDefDirichletBC, oofem::UserDefinedTemperatureField, oofem::UsrDefBoundaryLoad, oofem::VariableCrossSection, oofem::WarpingCrossSection, oofem::WeakPeriodicBoundaryCondition, oofem::WinklerMaterial, oofem::WinklerPasternakMaterial, oofem::ZZErrorEstimator, and oofem::ZZRemeshingCriteria.

Definition at line 85 of file femcmpnn.C.

◆ initializeFrom() [2/2]

virtual void oofem::FEMComponent::initializeFrom ( InputRecord & ir,
int priority )
inlinevirtual

Reimplemented in oofem::AbaqusUserElement, oofem::Axisymm3d, oofem::Beam2d, oofem::Beam3d, oofem::BondLink3d, oofem::BondLink3dBoundary, oofem::Brick1_ht, oofem::BsplinePlaneStressElement, oofem::CBSElement, oofem::CCTPlate, oofem::CohesiveSurface3d, oofem::DKTPlate, oofem::DofManager, oofem::Element, oofem::GeneralSlaveNode, oofem::HangingNode, oofem::IGAElement, oofem::IGATSplineElement, oofem::IntElLine1, oofem::IntElLine1PhF, oofem::IntElLine2, oofem::IntElLine2IntPen, oofem::IntElPoint, oofem::InteractionPFEMParticle, oofem::InterfaceElem1d, oofem::InterfaceElem2dLin, oofem::InterfaceElem2dQuad, oofem::L4Axisymm, oofem::Lattice2d, oofem::Lattice2d_mt, oofem::Lattice2dBoundary, oofem::Lattice3d, oofem::Lattice3d_mt, oofem::Lattice3dBoundary, oofem::Lattice3dBoundaryTruss, oofem::LatticeBeam3d, oofem::LatticeBeam3dBoundary, oofem::LatticeDirichletCouplingNode, oofem::LatticeLink3d, oofem::LatticeLink3dBoundary, oofem::LatticeNeumannCouplingNode, oofem::LIBeam2d, oofem::LIBeam2dNL, oofem::LIBeam3d2, oofem::LIBeam3d, oofem::LIBeam3dBoundary, oofem::LIBeam3dNL2, oofem::LIBeam3dNL, oofem::Line1_ht, oofem::LineDistributedSpring, oofem::LSpace, oofem::LTRSpaceBoundary, oofem::LTRSpaceBoundaryBeam, oofem::LumpedMassElement, oofem::LWedge, oofem::MacroLSpace, oofem::MITC4Shell, oofem::NLStructuralElement, oofem::NodalSpringElement, oofem::Node, oofem::NURBSPlaneStressElement, oofem::NURBSSpace3dElement, oofem::Particle, oofem::PFEMElement2d, oofem::PFEMElement, oofem::PlaneStress2d, oofem::PlaneStress2dXfem, oofem::PlaneStressGradDamage, oofem::Q27Space, oofem::Q4Axisymm, oofem::QBrick1_ht, oofem::qcNode, oofem::QDKTPlate, oofem::QPlaneStrainGrad, oofem::QPlaneStrainGradDamage, oofem::QPlaneStressGradDamage, oofem::QQuad1_ht, oofem::QSpace, oofem::QSpaceGradDamage, oofem::QTrPlaneStrainGradDamage, oofem::QTrPlaneStress2dXFEM, oofem::QTrPlaneStressGradDamage, oofem::QTRSpace, oofem::QTRSpaceGradDamage, oofem::QTruss1dGradDamage, oofem::Quad10_2D_SUPG, oofem::Quad1_ht, oofem::Quad1Mindlin, oofem::Quad1MindlinShell3D, oofem::QWedge, oofem::QWedge_ht, oofem::QWedgeGradDamage, oofem::RerShell, oofem::RigidArmNode, oofem::SADGBLine1, oofem::Shell7Base, oofem::Shell7BaseXFEM, oofem::SlaveNode, oofem::SpringElement, oofem::Structural2DElement, oofem::Structural3DElement, oofem::SUPGElement2, oofem::SUPGElement, oofem::Tetrah1_ht, oofem::TR1_2D_CBS, oofem::TR1_2D_PFEM, oofem::TR1_2D_SUPG2, oofem::TR1_2D_SUPG2_AXI, oofem::TR1_2D_SUPG, oofem::Tr1_ht, oofem::Tr1Darcy, oofem::TR_SHELL01, oofem::TR_SHELL02, oofem::TR_SHELL11, oofem::Tr_Warp, oofem::TransportElement, oofem::TrPlaneStress2dXFEM, oofem::TrPlaneStressGradDamage, oofem::TrPlaneStrRot, oofem::Truss1dGradDamage, oofem::Truss2d, oofem::Truss3d, oofem::Truss3dnl, oofem::TSplinePlaneStressElement, and oofem::Wedge_ht.

Definition at line 131 of file femcmpnn.h.

References initializeFrom().

Referenced by initializeFrom().

◆ postInitialize()

virtual void oofem::FEMComponent::postInitialize ( )
inlinevirtual

Performs post initialization steps. Called after all components are created and initialized.

Reimplemented in oofem::AbaqusUserElement, oofem::Axisymm3d, oofem::Beam2d, oofem::Beam3d, oofem::BondLink3d, oofem::CohesiveSurface3d, oofem::ContactBoundaryCondition, oofem::ContactSurface, oofem::Delamination, oofem::DofManager, oofem::Element, oofem::FEContactSurface, oofem::GeneralSlaveNode, oofem::GeometryBasedEI, oofem::HangingNode, oofem::HTSelement, oofem::IntElLine1, oofem::IntElPoint, oofem::L4Axisymm, oofem::Lattice2d_mt, oofem::Lattice2dBoundary, oofem::Lattice3d, oofem::Lattice3d_mt, oofem::Lattice3dBoundary, oofem::Lattice3dBoundaryTruss, oofem::LatticeBeam3d, oofem::LatticeBeam3dBoundary, oofem::LatticeDirichletCouplingNode, oofem::LatticeLink3d, oofem::LatticeLink3dBoundary, oofem::LatticeNeumannCouplingNode, oofem::LIBeam3d2, oofem::LIBeam3d, oofem::LIBeam3dBoundary, oofem::LIBeam3dNL2, oofem::LIBeam3dNL, oofem::LineDistributedSpring, oofem::LTRSpaceBoundary, oofem::LumpedMassElement, oofem::MacroLSpace, oofem::MITC4Shell, oofem::NodalSpringElement, oofem::Particle, oofem::PlaneStress2d, oofem::PlaneStress2dXfem, oofem::PlaneStressGradDamage, oofem::PrescribedGradientBCPeriodic, oofem::PrescribedGradientBCWeak, oofem::PrescribedGradientBCWeakDirichlet, oofem::PrescribedGradientBCWeakPeriodic, oofem::qcNode, oofem::QPlaneStressGradDamage, oofem::QTrPlaneStrainP1, oofem::QTrPlaneStress2dXFEM, oofem::Quad1PlaneStrain, oofem::Quad1PlaneStrainGradDamage, oofem::Quad1PlaneStrainP1, oofem::RigidArmNode, oofem::Shell7Base, oofem::Shell7BaseXFEM, oofem::SlaveNode, oofem::SolidShell, oofem::Structural2DElement, oofem::StructuralPenaltyContactBoundaryCondition, oofem::TR1_2D_SUPG2, oofem::TR_SHELL01, oofem::TR_SHELL02, oofem::Tr_Warp, oofem::TransportElement, oofem::TransportGradientDirichlet, oofem::TransportGradientNeumann, oofem::TransportGradientPeriodic, oofem::TrPlaneStrain, oofem::TrPlaneStress2dXFEM, oofem::TrPlaneStressGradDamage, oofem::TrPlaneStrRot, oofem::Truss1dGradDamage, oofem::Truss2d, oofem::Truss3dnl2, and oofem::WeakPeriodicBoundaryCondition.

Definition at line 138 of file femcmpnn.h.

◆ printOutputAt()

◆ printYourself()

◆ restoreContext()

void oofem::FEMComponent::restoreContext ( DataStream & stream,
ContextMode mode )
virtual

Restores the receiver state previously written in stream.

See also
saveContext
Parameters
streamInput stream.
modeDetermines amount of info available in stream (state, definition, ...).
Exceptions
throwsan ContextIOERR exception if error encountered.

Reimplemented in oofem::BondLink3d, oofem::BondLink3dBoundary, oofem::BoundaryCondition, oofem::BoundaryLoad, oofem::ConcreteDPM2, oofem::ConcreteDPM, oofem::ConstantFunction, oofem::CrossSection, oofem::DofManager, oofem::Element, oofem::Function, oofem::GeneralBoundaryCondition, oofem::HuertaErrorEstimator, oofem::IsotropicAsymmetric1DMaterial, oofem::IsotropicDamageMaterial1, oofem::IsotropicDamageMaterial, oofem::IsotropicLinearElasticMaterial, oofem::Lattice2d, oofem::Lattice2dBoundary, oofem::Lattice3d, oofem::Lattice3dBoundary, oofem::Lattice3dBoundaryTruss, oofem::LatticeBeam3dBoundary, oofem::LatticeLink3d, oofem::LatticeLink3dBoundary, oofem::LevelSetPCS, oofem::LIBeam3d2, oofem::LIBeam3dNL2, oofem::LinearConstraintBC, oofem::Load, oofem::Material, oofem::NodalLoad, oofem::Node, oofem::PiecewiseLinFunction, oofem::Quad10_2D_SUPG, oofem::Set, oofem::SimpleCrossSection, oofem::StepFunction, oofem::TR1_2D_CBS, oofem::TR1_2D_PFEM, oofem::TR1_2D_SUPG2, oofem::TR1_2D_SUPG, oofem::TR21_2D_SUPG, oofem::TR_SHELL01, oofem::TR_SHELL02, and oofem::UsrDefBoundaryLoad.

Definition at line 62 of file femcmpnn.C.

References oofem::CIO_IOERR, CM_Definition, number, oofem::DataStream::read(), and THROW_CIOERR.

Referenced by oofem::ConcreteDPM2::restoreContext(), oofem::ConcreteDPM::restoreContext(), oofem::IsotropicDamageMaterial::restoreContext(), and oofem::XfemManager::restoreContext().

◆ saveContext()

void oofem::FEMComponent::saveContext ( DataStream & stream,
ContextMode mode )
virtual

Stores receiver state to output stream.

Parameters
streamOutput stream.
modeDetermines amount of info required in stream (state, definition, ...).
Exceptions
throwsan ContextIOERR exception if error encountered.

Reimplemented in oofem::BondLink3d, oofem::BondLink3dBoundary, oofem::BoundaryCondition, oofem::BoundaryLoad, oofem::ConcreteDPM2, oofem::ConcreteDPM, oofem::ConstantFunction, oofem::CrossSection, oofem::DofManager, oofem::Element, oofem::Function, oofem::GeneralBoundaryCondition, oofem::HuertaErrorEstimator, oofem::IsotropicAsymmetric1DMaterial, oofem::IsotropicDamageMaterial1, oofem::IsotropicDamageMaterial, oofem::IsotropicLinearElasticMaterial, oofem::Lattice2d, oofem::Lattice2dBoundary, oofem::Lattice3d, oofem::Lattice3dBoundary, oofem::Lattice3dBoundaryTruss, oofem::LatticeBeam3dBoundary, oofem::LatticeLink3d, oofem::LatticeLink3dBoundary, oofem::LevelSetPCS, oofem::LIBeam3d2, oofem::LIBeam3dNL2, oofem::LinearConstraintBC, oofem::Load, oofem::Material, oofem::NodalLoad, oofem::Node, oofem::PiecewiseLinFunction, oofem::Quad10_2D_SUPG, oofem::Set, oofem::SimpleCrossSection, oofem::StepFunction, oofem::TR1_2D_CBS, oofem::TR1_2D_PFEM, oofem::TR1_2D_SUPG2, oofem::TR1_2D_SUPG, oofem::TR21_2D_SUPG, oofem::TR_SHELL01, oofem::TR_SHELL02, and oofem::UsrDefBoundaryLoad.

Definition at line 51 of file femcmpnn.C.

References oofem::CIO_IOERR, CM_Definition, number, THROW_CIOERR, and oofem::DataStream::write().

Referenced by oofem::ConcreteDPM2::saveContext(), oofem::ConcreteDPM::saveContext(), and oofem::IsotropicDamageMaterial::saveContext().

◆ setDomain()

virtual void oofem::FEMComponent::setDomain ( Domain * d)
inlinevirtual

Sets associated Domain

Parameters
dNew domain which receiver should belong to.

Reimplemented in oofem::CombinedZZSIErrorEstimator, oofem::CombinedZZSIRemeshingCriteria, oofem::DirectErrorIndicatorRC, and oofem::ErrorEstimator.

Definition at line 102 of file femcmpnn.h.

◆ setNumber()

void oofem::FEMComponent::setNumber ( int num)
inline

Sets number of receiver.

Parameters
numNew number of receiver.

Definition at line 109 of file femcmpnn.h.

◆ updateLocalNumbering()

virtual void oofem::FEMComponent::updateLocalNumbering ( EntityRenumberingFunctor & f)
inlinevirtual

Local renumbering support. For some tasks (parallel load balancing, for example) it is necessary to renumber the entities. The various FEM components (such as nodes or elements) typically contain links to other entities in terms of their local numbers, etc. This service allows to update these relations to reflect updated numbering. The renumbering function is passed, which is supposed to return an updated number of specified entity type based on old number.

Reimplemented in oofem::Beam3d, oofem::DofManager, oofem::Element, oofem::GeneralSlaveNode, oofem::RigidArmNode, oofem::Set, oofem::SlaveNode, oofem::TR_SHELL01, and oofem::TR_SHELL02.

Definition at line 117 of file femcmpnn.h.

Member Data Documentation

◆ domain

Domain* oofem::FEMComponent::domain
protected

Link to domain object, useful for communicating with other FEM components.

Definition at line 79 of file femcmpnn.h.

Referenced by oofem::TR1_2D_SUPG2::_giveMaterial(), oofem::TR1_2D_SUPG2_AXI::_giveMaterial(), oofem::LinearConstraintBC::assemble(), oofem::PrescribedGradientBCWeak::assemble(), oofem::WeakPeriodicBoundaryCondition::assemble(), oofem::PrescribedGradientBCWeak::assembleExtraDisplock(), oofem::PrescribedGradientBCWeak::assembleGPContrib(), oofem::PrescribedGradientBCWeak::assembleTangentGPContributionNew(), oofem::LinearConstraintBC::assembleVector(), oofem::PrescribedGradientBCWeak::assembleVector(), oofem::HuertaErrorEstimator::buildRefinedMesh(), oofem::PolylineNonlocalBarrier::calculateMinimumDistanceFromBoundary(), oofem::BinghamFluidMaterial2::checkConsistency(), oofem::ConcreteFCMViscoElastic::checkConsistency(), oofem::FluidCrossSection::checkConsistency(), oofem::HangingNode::checkConsistency(), oofem::LatticeDamageViscoelastic::checkConsistency(), oofem::LatticePlasticityDamageViscoelastic::checkConsistency(), oofem::LatticeViscoelastic::checkConsistency(), oofem::NewtonianFluidMaterial::checkConsistency(), oofem::Node::checkConsistency(), oofem::NonlinearFluidMaterial::checkConsistency(), oofem::qcNode::checkConsistency(), oofem::SimpleTransportCrossSection::checkConsistency(), oofem::PrescribedGradientBCWeak::compute_x_times_N_1(), oofem::PrescribedGradientBCWeak::compute_x_times_N_2(), oofem::MPSMaterial::computeAutogenousShrinkageDefinedByTF(), oofem::WeakPeriodicBoundaryCondition::computeBaseFunctionValue(), oofem::SUPGElement::computeBCLhsPressureTerm_MB(), oofem::TR1_2D_SUPG_AXI::computeBCLhsPressureTerm_MB(), oofem::SUPGElement::computeBCLhsPressureTerm_MC(), oofem::SUPGElement::computeBCLhsTerm_MB(), oofem::TR1_2D_SUPG_AXI::computeBCLhsTerm_MB(), oofem::SUPGElement2::computeBCRhsTerm_MB(), oofem::TR1_2D_SUPG2::computeBCRhsTerm_MB(), oofem::TR1_2D_SUPG2_AXI::computeBCRhsTerm_MB(), oofem::TR1_2D_SUPG::computeBCRhsTerm_MB(), oofem::TR1_2D_SUPG_AXI::computeBCRhsTerm_MB(), oofem::SUPGElement2::computeBCRhsTerm_MC(), oofem::TR1_2D_SUPG2_AXI::computeBCRhsTerm_MC(), oofem::TR1_2D_SUPG::computeBCRhsTerm_MC(), oofem::TR1_2D_SUPG_AXI::computeBCRhsTerm_MC(), oofem::TransportElement::computeBCSubMtrxAt(), oofem::TransportElement::computeBCSubVectorAt(), oofem::Beam2d::computeBmatrixAt(), oofem::Beam3d::computeBmatrixAt(), oofem::LIBeam3d2::computeBmatrixAt(), oofem::TransportElement::computeBoundaryEdgeLoadVector(), oofem::TransportElement::computeBoundarySurfaceLoadVector(), oofem::Shell7Base::computeBulkTangentMatrix(), oofem::TransportGradientDirichlet::computeCoefficientMatrix(), oofem::LatticeTransportMaterial::computeConductivity(), oofem::TR1_2D_CBS::computeConvectionTermsI(), oofem::Shell7Base::computeConvectiveMassForce(), oofem::TR1_2D_SUPG::computeCriticalLEPlicTimeStep(), oofem::LEPlic::computeCriticalTimeStep(), oofem::Tet1_3D_SUPG::computeCriticalTimeStep(), oofem::TR1_2D_CBS::computeCriticalTimeStep(), oofem::TR1_2D_PFEM::computeCriticalTimeStep(), oofem::TR1_2D_CBS::computeDensityRhsPressureTerms(), oofem::TR1_2D_CBS::computeDensityRhsVelocityTerms(), oofem::SUPGElement2::computeDiffusionDerivativeTerm_MB(), oofem::TR1_2D_SUPG2::computeDiffusionDerivativeTerm_MB(), oofem::TR1_2D_SUPG2_AXI::computeDiffusionDerivativeTerm_MB(), oofem::TR1_2D_SUPG::computeDiffusionDerivativeTerm_MB(), oofem::TR1_2D_SUPG_AXI::computeDiffusionDerivativeTerm_MB(), oofem::TR1_2D_SUPG2_AXI::computeDiffusionDerivativeTerm_MC(), oofem::TR1_2D_SUPG_AXI::computeDiffusionDerivativeTerm_MC(), oofem::SUPGElement2::computeDiffusionTerm_MB(), oofem::TR1_2D_SUPG2::computeDiffusionTerm_MB(), oofem::TR1_2D_SUPG2_AXI::computeDiffusionTerm_MB(), oofem::TR1_2D_SUPG::computeDiffusionTerm_MB(), oofem::TR1_2D_SUPG_AXI::computeDiffusionTerm_MB(), oofem::TR1_2D_SUPG2_AXI::computeDiffusionTerm_MC(), oofem::TR1_2D_SUPG_AXI::computeDiffusionTerm_MC(), oofem::TR1_2D_CBS::computeDiffusionTermsI(), oofem::PrescribedGradientBCPeriodic::computeDofTransformation(), oofem::TransportGradientPeriodic::computeDofTransformation(), oofem::TransportElement::computeEdgeBCSubVectorAt(), oofem::TransportGradientNeumann::computeEta(), oofem::Hexa21Stokes::computeExternalForcesVector(), oofem::Tet1BubbleStokes::computeExternalForcesVector(), oofem::Tet21Stokes::computeExternalForcesVector(), oofem::Tr1BubbleStokes::computeExternalForcesVector(), oofem::Tr1Darcy::computeExternalForcesVector(), oofem::Tr21Stokes::computeExternalForcesVector(), oofem::PrescribedGenStrainShell7::computeField(), oofem::PrescribedGradient::computeField(), oofem::PrescribedGradientBCPeriodic::computeField(), oofem::PrescribedGradientBCWeak::computeField(), oofem::TransportGradientDirichlet::computeField(), oofem::TransportGradientPeriodic::computeField(), oofem::MixedGradientPressureDirichlet::computeFields(), oofem::LIBeam3d2::computeGtoLRotationMatrix(), oofem::Lattice2d_mt::computeInternalSourceRhsVectorAt(), oofem::Lattice3d_mt::computeInternalSourceRhsVectorAt(), oofem::PrescribedGradientBCWeak::computeIntForceGPContrib(), oofem::LatticeNeumannCouplingNode::computeLoadCouplingContribution(), oofem::LSpace::computeLoadLSToLRotationMatrix(), oofem::Q27Space::computeLoadLSToLRotationMatrix(), oofem::QSpace::computeLoadLSToLRotationMatrix(), oofem::LatticeNeumannCouplingNode::computeLoadVectorAt(), oofem::BeamBaseElement::computeLocalForceLoadVector(), oofem::IntElPoint::computeLocalSlipDir(), oofem::InterfaceElem1d::computeLocalSlipDir(), oofem::Shell7Base::computeMassMatrix(), oofem::Shell7Base::computeMassMatrixNum(), oofem::Shell7BaseXFEM::computeMassMatrixNum(), oofem::Beam2d::computeNmatrixAt(), oofem::Beam3d::computeNmatrixAt(), oofem::NeumannMomentLoad::computeNormal(), oofem::ConcreteFCMViscoElastic::computeOverallElasticShearModulus(), oofem::ConcreteFCMViscoElastic::computeOverallElasticStiffness(), oofem::TR1_2D_CBS::computePrescribedTractionPressure(), oofem::WeakPeriodicBoundaryCondition::computeProjectionCoefficient(), oofem::MPSMaterial::computePsiE(), oofem::PrescribedDispSlipBCDirichletRC::computeReinfStress(), oofem::StructuralElement::computeResultingIPEigenstrainAt(), oofem::StructuralElement::computeResultingIPTemperatureAt(), oofem::Shell7Base::computeSectionalForces(), oofem::B3Material::computeShrinkageStrainVector(), oofem::NLStructuralElement::computeStiffnessMatrix(), oofem::Shell7Base::computeStiffnessMatrix(), oofem::Shell7BaseXFEM::computeStiffnessMatrix(), oofem::GradientDamageElement::computeStiffnessMatrix_du(), oofem::GradDpElement::computeStiffnessMatrix_ku(), oofem::GradientDamageElement::computeStiffnessMatrix_ud(), oofem::GradDpElement::computeStiffnessMatrix_uk(), oofem::GradDpElement::computeStiffnessMatrix_uu(), oofem::GradientDamageElement::computeStiffnessMatrix_uu(), oofem::NLStructuralElement::computeStiffnessMatrix_withIRulesAsSubcells(), oofem::MixedGradientPressureWeakPeriodic::computeStress(), oofem::PrescribedDispSlipBCDirichletRC::computeStress(), oofem::ConcreteFCMViscoElastic::computeStressIndependentStrainVector(), oofem::StructuralMaterial::computeStressIndependentStrainVector(), oofem::StructuralMaterial::computeStressIndependentStrainVector_3d(), oofem::Beam3d::computeSubSoilStiffnessMatrix(), oofem::TransportElement::computeSurfaceBCSubVectorAt(), oofem::PrescribedDispSlipBCDirichletRC::computeTangent(), oofem::PrescribedGenStrainShell7::computeTangent(), oofem::PrescribedGradient::computeTangent(), oofem::PrescribedGradientBCNeumann::computeTangent(), oofem::PrescribedGradientBCPeriodic::computeTangent(), oofem::PrescribedGradientBCWeak::computeTangent(), oofem::TransportGradientDirichlet::computeTangent(), oofem::TransportGradientNeumann::computeTangent(), oofem::TransportGradientPeriodic::computeTangent(), oofem::MixedGradientPressureDirichlet::computeTangents(), oofem::MixedGradientPressureNeumann::computeTangents(), oofem::MixedGradientPressureWeakPeriodic::computeTangents(), oofem::PrescribedDispSlipBCDirichletRC::computeTransferStress(), oofem::LatticeDirichletCouplingNode::computeUnknownCouplingContribution(), oofem::DepositedHeatSource::computeValueAt(), oofem::DepositedHeatSource::computeValueAt(), oofem::InteractionLoad::computeValueAt(), oofem::UsrDefBoundaryLoad::computeValueAt(), oofem::TransportGradientDirichlet::computeXi(), oofem::FiberedCrossSection::createMaterialStatus(), oofem::LayeredCrossSection::createMaterialStatus(), oofem::SimpleCrossSection::createMaterialStatus(), oofem::FE2FluidMaterial::CreateStatus(), oofem::LargeStrainMasterMaterial::CreateStatus(), oofem::LatticeBondPlasticity::CreateStatus(), oofem::LatticePlasticityDamage::CreateStatus(), oofem::LatticePlasticityDamageViscoelastic::CreateStatus(), oofem::RVEStokesFlow::CreateStatus(), oofem::StructuralFE2Material::CreateStatus(), oofem::StructuralSlipFE2Material::CreateStatus(), oofem::PrescribedGradientBCWeak::createTractionMesh(), oofem::Shell7BaseXFEM::discComputeSectionalForces(), oofem::LEPlic::doCellDLS(), oofem::LEPlic::doInterfaceReconstruction(), oofem::LEPlic::doInterfaceRemapping(), oofem::LEPlic::doLagrangianPhase(), oofem::MixedGradientPressureBC::domainSize(), oofem::TransportGradientDirichlet::domainSize(), oofem::TransportGradientNeumann::domainSize(), oofem::PFEMParticle::drawScalar(), oofem::LSpace::drawTriad(), oofem::Node::drawYourself(), oofem::HuertaErrorEstimator::estimateError(), oofem::ZZErrorEstimator::estimateError(), oofem::HuertaRemeshingCriteria::estimateMeshDensities(), oofem::ZZRemeshingCriteria::estimateMeshDensities(), oofem::DummyCrossSection::estimatePackSize(), oofem::FluidCrossSection::estimatePackSize(), oofem::SimpleTransportCrossSection::estimatePackSize(), oofem::LevelSetPCS::evalElemFContribution(), oofem::LevelSetPCS::evalElemfContribution(), oofem::PeriodicPiecewiseLinFunction::evaluateAtTime(), oofem::PeriodicPiecewiseLinFunction::evaluateVelocityAtTime(), oofem::DirectErrorIndicatorRC::exchangeDofManDensities(), oofem::DirectErrorIndicatorRC::exchangeDofManIndicatorVals(), FEMComponent(), oofem::LEPlic::findCellLineConstant(), oofem::PrescribedGradientBCWeak::findCrackBndIntersecCoord(), oofem::PrescribedGradientBCWeak::findHoleCoord(), oofem::PrescribedGradientBCPeriodic::findSlaveToMasterMap(), oofem::TransportGradientPeriodic::findSlaveToMasterMap(), oofem::LevelSetPCS::FMMReinitialization(), oofem::InitialCondition::give(), oofem::LayeredCrossSection::give(), oofem::PrescribedDispSlipBCDirichletRC::give(), oofem::TractionPressureBC::give(), oofem::RheoChainMaterial::give1dStressStiffMtrx(), oofem::LayeredCrossSection::give2dBeamStiffMtrx(), oofem::LatticeDamageViscoelastic::give2dLatticeStiffnessMatrix(), oofem::LatticeViscoelastic::give2dLatticeStiffnessMatrix(), oofem::LayeredCrossSection::give2dPlateStiffMtrx(), oofem::FiberedCrossSection::give3dBeamStiffMtrx(), oofem::LargeStrainMasterMaterialGrad::give3dGprime(), oofem::LargeStrainMasterMaterialGrad::give3dKappaMatrix(), oofem::LatticeDamageViscoelastic::give3dLatticeStiffnessMatrix(), oofem::LatticePlasticityDamageViscoelastic::give3dLatticeStiffnessMatrix(), oofem::LatticeViscoelastic::give3dLatticeStiffnessMatrix(), oofem::RheoChainMaterial::give3dMaterialStiffnessMatrix(), oofem::LargeStrainMasterMaterial::give3dMaterialStiffnessMatrix_dPdF(), oofem::LayeredCrossSection::give3dShellStiffMtrx(), oofem::GeometryBasedEI::giveBoundingSphere(), oofem::LayeredCrossSection::giveCharMaterialStiffnessMatrix(), oofem::LayeredCrossSection::giveCharMaterialStiffnessMatrix_dPdF(), oofem::PlaneStress2dXfem::giveCompositeExportData(), oofem::QTrPlaneStress2dXFEM::giveCompositeExportData(), oofem::TrPlaneStress2dXFEM::giveCompositeExportData(), oofem::Element::giveCrossSection(), oofem::FluidCrossSection::giveDensity(), oofem::Element::giveDofManager(), oofem::CombinedZZSIRemeshingCriteria::giveDofManDensity(), oofem::HuertaRemeshingCriteria::giveDofManDensity(), oofem::ZZRemeshingCriteria::giveDofManDensity(), oofem::IntElPoint::giveDofManDofIDMask(), oofem::QTrPlaneStress2dXFEM::giveDofManDofIDMask(), oofem::TrPlaneStress2dXFEM::giveDofManDofIDMask(), giveDomain(), oofem::WeakPeriodicBoundaryCondition::giveEdgeNormal(), oofem::LEPlic::giveElementMaterialMixture(), oofem::LevelSetPCS::giveElementMaterialMixture(), oofem::ConcreteFCMViscoElastic::giveEquivalentTime(), oofem::LatticePlasticityDamageViscoelastic::giveEquivalentTime(), oofem::WeakPeriodicBoundaryCondition::giveExternalForcesVector(), oofem::LayeredCrossSection::giveFirstPKStress_3d(), oofem::LargeStrainMasterMaterial::giveFirstPKStressVector_3d(), oofem::LargeStrainMasterMaterialGrad::giveFirstPKStressVectorGrad(), oofem::FluidCrossSection::giveFluidMaterial(), oofem::InteractionPFEMParticle::giveFluidStructureMasterProblem(), oofem::LayeredCrossSection::giveGeneralizedStress_Beam2d(), oofem::FiberedCrossSection::giveGeneralizedStress_Beam3d(), oofem::LayeredCrossSection::giveGeneralizedStress_MembraneRot(), oofem::LayeredCrossSection::giveGeneralizedStress_Plate(), oofem::LayeredCrossSection::giveGeneralizedStress_Shell(), oofem::LayeredCrossSection::giveGeneralizedStress_ShellRot(), oofem::B3SolidMaterial::giveHumidity(), oofem::MPSMaterial::giveHumidity(), oofem::B3SolidMaterial::giveHumidityIncrement(), oofem::NLStructuralElement::giveInternalForcesVector(), oofem::WeakPeriodicBoundaryCondition::giveInternalForcesVector(), oofem::GradientDamageElement::giveInternalForcesVector_u(), oofem::NLStructuralElement::giveInternalForcesVector_withIRulesAsSubcells(), oofem::Beam3d::giveInternalForcesVectorAtPoint(), oofem::ConcreteFCMViscoElastic::giveIPValue(), oofem::FluidCrossSection::giveIPValue(), oofem::LargeStrainMasterMaterial::giveIPValue(), oofem::LatticeDamageViscoelastic::giveIPValue(), oofem::LatticePlasticityDamageViscoelastic::giveIPValue(), oofem::LatticeViscoelastic::giveIPValue(), oofem::LayeredCrossSection::giveIPValue(), oofem::Quad10_2D_SUPG::giveIPValue(), oofem::SimpleTransportCrossSection::giveIPValue(), oofem::StructuralMaterial::giveIPValue(), oofem::TR1_2D_SUPG::giveIPValue(), oofem::LatticeDamage::giveLatticeStress3d(), oofem::LatticeDamageViscoelastic::giveLatticeStress3d(), oofem::LatticeLinearElastic::giveLatticeStress3d(), oofem::LatticePlasticityDamageViscoelastic::giveLatticeStress3d(), oofem::LatticeViscoelastic::giveLatticeStress3d(), oofem::GradDpElement::giveLocalInternalForcesVector(), oofem::LinearConstraintBC::giveLocArray(), oofem::PrescribedGradientBCPeriodic::giveMasterDof(), oofem::TransportGradientPeriodic::giveMasterDof(), oofem::DummyCrossSection::giveMaterial(), oofem::Element::giveMaterial(), oofem::FiberedCrossSection::giveMaterial(), oofem::LayeredCrossSection::giveMaterial(), oofem::SimpleTransportCrossSection::giveMaterial(), oofem::SimpleTransportCrossSection::giveMaterial(), oofem::TransportElement::giveMaterial(), oofem::TwoFluidMaterial::giveMaterial(), oofem::TwoPhaseMaterial::giveMaterial(), oofem::LEPlic::giveMaterialMixtureAt(), oofem::LevelSetPCS::giveMaterialMixtureAt(), oofem::LEPlic::giveNodalScalarRepresentation(), oofem::Element::giveNode(), oofem::Set::giveNodeList(), oofem::PrescribedDispSlipBCDirichletRC::giveOnSteel(), oofem::RheoChainMaterial::givePlaneStrainStiffMtrx(), oofem::RheoChainMaterial::givePlaneStressStiffMtrx(), oofem::BoundaryLoad::giveProperty(), oofem::LayeredCrossSection::giveRealStress_3d(), oofem::LayeredCrossSection::giveRealStress_PlaneStress(), oofem::ConcreteFCMViscoElastic::giveRealStressVector(), oofem::RheoChainMaterial::giveRealStressVector(), oofem::Element::giveSide(), oofem::LayeredCrossSection::giveStiffnessMatrix_3d(), oofem::LayeredCrossSection::giveStiffnessMatrix_dPdF_3d(), oofem::LayeredCrossSection::giveStiffnessMatrix_PlaneStress(), oofem::MisesMat::giveTemperature(), oofem::MPSMaterial::giveTemperature(), oofem::NlIsoMoistureMaterial::giveTemperature(), oofem::SimpleCrossSection::giveTemperatureVector(), oofem::TwoFluidMaterial::giveTempVOF(), oofem::GeneralBoundaryCondition::giveTimeFunction(), oofem::Shell7Base::giveTractionBC(), oofem::PrescribedGradientBCPeriodic::giveUnknown(), oofem::PrescribedGradientBCPeriodic::giveUnknown(), oofem::PrescribedGradientBCPeriodic::giveUnknown(), oofem::TransportGradientPeriodic::giveUnknown(), oofem::TransportGradientPeriodic::giveUnknown(), oofem::TransportGradientPeriodic::giveUnknown(), oofem::MeshQualityErrorEstimator::giveValue(), oofem::IsotropicDamageMaterial1::initDamaged(), oofem::LevelSetPCS::initialize(), oofem::DofManager::initializeFinish(), oofem::IGAElement::initializeFinish(), oofem::IGATSplineElement::initializeFinish(), oofem::InterfaceElem1d::initializeFinish(), oofem::Beam3d::initializeFrom(), oofem::DirectErrorIndicatorRC::initializeFrom(), oofem::GeneralSlaveNode::initializeFrom(), oofem::IGAElement::initializeFrom(), oofem::IGATSplineElement::initializeFrom(), oofem::IntElLine1::initializeFrom(), oofem::IntElLine2::initializeFrom(), oofem::LatticeDamageViscoelastic::initializeFrom(), oofem::LatticePlasticityDamageViscoelastic::initializeFrom(), oofem::LatticeViscoelastic::initializeFrom(), oofem::LIBeam2d::initializeFrom(), oofem::LIBeam3d2::initializeFrom(), oofem::LIBeam3d::initializeFrom(), oofem::LIBeam3dNL2::initializeFrom(), oofem::MacroLSpace::initializeFrom(), oofem::MixedGradientPressureDirichlet::initializeFrom(), oofem::MixedGradientPressureWeakPeriodic::initializeFrom(), oofem::NLStructuralElement::initializeFrom(), oofem::Node::initializeFrom(), oofem::Particle::initializeFrom(), oofem::PrescribedMean::initializeFrom(), oofem::Q4Axisymm::initializeFrom(), oofem::SolutionbasedShapeFunction::initializeFrom(), oofem::Structural2DElement::initializeFrom(), oofem::SolutionbasedShapeFunction::initializeSurfaceData(), oofem::PrescribedGradientBCNeumann::integrateTangent(), oofem::Element::isActivated(), oofem::PolylineNonlocalBarrier::isActivated(), oofem::DummyCrossSection::isCharacteristicMtrxSymmetric(), oofem::FiberedCrossSection::isCharacteristicMtrxSymmetric(), oofem::FluidCrossSection::isCharacteristicMtrxSymmetric(), oofem::LayeredCrossSection::isCharacteristicMtrxSymmetric(), oofem::SimpleCrossSection::isCharacteristicMtrxSymmetric(), oofem::SimpleTransportCrossSection::isCharacteristicMtrxSymmetric(), oofem::FreeConstantSurfaceLoad::isImposed(), oofem::GeneralBoundaryCondition::isImposed(), oofem::LinearConstraintBC::LinearConstraintBC(), oofem::SolutionbasedShapeFunction::loadProblem(), oofem::MixedGradientPressureWeakPeriodic::MixedGradientPressureWeakPeriodic(), oofem::Shell7BaseXFEM::OLDcomputeStiffnessMatrix(), oofem::DummyCrossSection::packUnknowns(), oofem::FluidCrossSection::packUnknowns(), oofem::SimpleTransportCrossSection::packUnknowns(), oofem::LevelSetPCS::pcs_stage1(), oofem::Beam3d::postInitialize(), oofem::BondLink3d::postInitialize(), oofem::FEContactSurface::postInitialize(), oofem::HangingNode::postInitialize(), oofem::IntElLine1::postInitialize(), oofem::LatticeNeumannCouplingNode::postInitialize(), oofem::LIBeam3d2::postInitialize(), oofem::LIBeam3d::postInitialize(), oofem::LIBeam3dNL2::postInitialize(), oofem::LTRSpaceBoundary::postInitialize(), oofem::MacroLSpace::postInitialize(), oofem::RigidArmNode::postInitialize(), oofem::StructuralPenaltyContactBoundaryCondition::postInitialize(), oofem::WeakPeriodicBoundaryCondition::postInitialize(), oofem::qcNode::postInitializeAsHangingNode(), oofem::PrescribedMean::PrescribedMean(), oofem::GeometryBasedEI::propagateFronts(), oofem::LevelSetPCS::redistance(), oofem::PrescribedGradientBCWeak::removeSegOverHoles(), oofem::FiberedCrossSection::restoreIPContext(), oofem::LayeredCrossSection::restoreIPContext(), oofem::HuertaErrorEstimator::saveContext(), oofem::FiberedCrossSection::saveIPContext(), oofem::LayeredCrossSection::saveIPContext(), oofem::IntElPoint::setCoordMode(), oofem::InterfaceElem1d::setCoordMode(), oofem::MixedGradientPressureNeumann::setPrescribedDeviatoricGradientFromVoigt(), oofem::StructuralPenaltyContactBoundaryCondition::setupContactSearchAlgorithm(), oofem::HuertaErrorEstimator::setupRefinedProblemEpilog1(), oofem::HuertaErrorEstimator::setupRefinedProblemEpilog2(), oofem::HuertaErrorEstimator::setupRefinedProblemProlog(), oofem::HuertaErrorEstimator::solveRefinedElementProblem(), oofem::HuertaErrorEstimator::solveRefinedPatchProblem(), oofem::HuertaErrorEstimator::solveRefinedWholeProblem(), oofem::DummyCrossSection::unpackAndUpdateUnknowns(), oofem::FluidCrossSection::unpackAndUpdateUnknowns(), oofem::SimpleTransportCrossSection::unpackAndUpdateUnknowns(), oofem::DirectErrorIndicatorRC::unpackSharedDofManLocalDensities(), oofem::DirectErrorIndicatorRC::unpackSharedDofManLocalIndicatorVals(), oofem::PrescribedDispSlipBCDirichletRC::updateCoefficientMatrix(), oofem::PrescribedGenStrainShell7::updateCoefficientMatrix(), oofem::PrescribedGradient::updateCoefficientMatrix(), oofem::WeakPeriodicBoundaryCondition::updateDirection(), oofem::GeometryBasedEI::updateLevelSets(), oofem::GeometryBasedEI::updateNodeEnrMarker(), oofem::LevelSetPCS::updatePosition(), oofem::WeakPeriodicBoundaryCondition::updateSminmax(), oofem::Tet1_3D_SUPG::updateStabilizationCoeffs(), oofem::TR1_2D_SUPG2::updateStabilizationCoeffs(), oofem::TR1_2D_SUPG2_AXI::updateStabilizationCoeffs(), oofem::TR1_2D_SUPG::updateStabilizationCoeffs(), oofem::TR1_2D_SUPG_AXI::updateStabilizationCoeffs(), oofem::Node::updateYourself(), oofem::WeakPeriodicBoundaryCondition::WeakPeriodicBoundaryCondition(), and oofem::GeometryBasedEI::writeVtkDebug().

◆ number

int oofem::FEMComponent::number
protected

Component number.

Definition at line 77 of file femcmpnn.h.

Referenced by oofem::TR1_2D_SUPG2::computeAdvectionTerm_MB(), oofem::BeamBaseElement::computeLocalForceLoadVector(), oofem::StructuralElement::computeResultingIPEigenstrainAt(), oofem::StructuralElement::computeResultingIPTemperatureAt(), FEMComponent(), oofem::Beam2d::giveInternalDofManager(), oofem::Beam3d::giveInternalDofManager(), oofem::Element::giveInternalDofManager(), oofem::Beam2d::giveInternalDofManDofIDMask(), oofem::Beam3d::giveInternalDofManDofIDMask(), oofem::Beam3d::giveInternalForcesVectorAtPoint(), giveNumber(), oofem::Set::hasElement(), oofem::CBSElement::initializeFinish(), oofem::DofManager::initializeFinish(), oofem::Element::initializeFinish(), oofem::GeneralSlaveNode::initializeFinish(), oofem::IGAElement::initializeFinish(), oofem::IGATSplineElement::initializeFinish(), oofem::NodalSpringElement::initializeFinish(), oofem::Node::initializeFinish(), oofem::AbaqusUserElement::initializeFrom(), oofem::Beam2d::initializeFrom(), oofem::Beam3d::initializeFrom(), oofem::BondLink3d::initializeFrom(), oofem::BondLink3dBoundary::initializeFrom(), oofem::CBSElement::initializeFrom(), oofem::CohesiveSurface3d::initializeFrom(), oofem::DofManager::initializeFrom(), oofem::Element::initializeFrom(), oofem::GeneralSlaveNode::initializeFrom(), oofem::HangingNode::initializeFrom(), oofem::IGAElement::initializeFrom(), oofem::IGATSplineElement::initializeFrom(), oofem::IntElLine1::initializeFrom(), oofem::IntElLine1PhF::initializeFrom(), oofem::IntElLine2::initializeFrom(), oofem::IntElLine2IntPen::initializeFrom(), oofem::IntElPoint::initializeFrom(), oofem::InteractionPFEMParticle::initializeFrom(), oofem::InterfaceElem1d::initializeFrom(), oofem::InterfaceElem2dLin::initializeFrom(), oofem::InterfaceElem2dQuad::initializeFrom(), oofem::Lattice2d::initializeFrom(), oofem::Lattice2d_mt::initializeFrom(), oofem::Lattice2dBoundary::initializeFrom(), oofem::Lattice3d::initializeFrom(), oofem::Lattice3d_mt::initializeFrom(), oofem::Lattice3dBoundary::initializeFrom(), oofem::Lattice3dBoundaryTruss::initializeFrom(), oofem::LatticeBeam3d::initializeFrom(), oofem::LatticeBeam3dBoundary::initializeFrom(), oofem::LatticeDirichletCouplingNode::initializeFrom(), oofem::LatticeLink3d::initializeFrom(), oofem::LatticeLink3dBoundary::initializeFrom(), oofem::LatticeNeumannCouplingNode::initializeFrom(), oofem::LIBeam2d::initializeFrom(), oofem::LIBeam3d2::initializeFrom(), oofem::LIBeam3d::initializeFrom(), oofem::LIBeam3dBoundary::initializeFrom(), oofem::LIBeam3dNL2::initializeFrom(), oofem::LIBeam3dNL::initializeFrom(), oofem::LineDistributedSpring::initializeFrom(), oofem::LSpace::initializeFrom(), oofem::LTRSpaceBoundary::initializeFrom(), oofem::LumpedMassElement::initializeFrom(), oofem::MacroLSpace::initializeFrom(), oofem::MITC4Shell::initializeFrom(), oofem::NLStructuralElement::initializeFrom(), oofem::NodalSpringElement::initializeFrom(), oofem::Node::initializeFrom(), oofem::Particle::initializeFrom(), oofem::Q4Axisymm::initializeFrom(), oofem::qcNode::initializeFrom(), oofem::QTrPlaneStress2dXFEM::initializeFrom(), oofem::Quad1Mindlin::initializeFrom(), oofem::Quad1MindlinShell3D::initializeFrom(), oofem::RigidArmNode::initializeFrom(), oofem::Shell7Base::initializeFrom(), oofem::SlaveNode::initializeFrom(), oofem::SolidShell::initializeFrom(), oofem::SpringElement::initializeFrom(), oofem::Structural2DElement::initializeFrom(), oofem::Structural3DElement::initializeFrom(), oofem::SUPGElement::initializeFrom(), oofem::TR1_2D_CBS::initializeFrom(), oofem::TR1_2D_SUPG2::initializeFrom(), oofem::TR1_2D_SUPG2_AXI::initializeFrom(), oofem::TR1_2D_SUPG::initializeFrom(), oofem::TransportElement::initializeFrom(), oofem::TrPlaneStrRot::initializeFrom(), oofem::Truss2d::initializeFrom(), oofem::Truss3dnl::initializeFrom(), oofem::AbaqusUserElement::postInitialize(), oofem::Beam2d::postInitialize(), oofem::Beam3d::postInitialize(), oofem::BondLink3d::postInitialize(), oofem::CohesiveSurface3d::postInitialize(), oofem::IntElPoint::postInitialize(), oofem::Lattice2d_mt::postInitialize(), oofem::Lattice2dBoundary::postInitialize(), oofem::Lattice3dBoundary::postInitialize(), oofem::Lattice3dBoundaryTruss::postInitialize(), oofem::LatticeBeam3d::postInitialize(), oofem::LatticeBeam3dBoundary::postInitialize(), oofem::LatticeDirichletCouplingNode::postInitialize(), oofem::LatticeLink3d::postInitialize(), oofem::LatticeLink3dBoundary::postInitialize(), oofem::LatticeNeumannCouplingNode::postInitialize(), oofem::LIBeam3d2::postInitialize(), oofem::LIBeam3d::postInitialize(), oofem::LIBeam3dBoundary::postInitialize(), oofem::LIBeam3dNL2::postInitialize(), oofem::LIBeam3dNL::postInitialize(), oofem::LineDistributedSpring::postInitialize(), oofem::LTRSpaceBoundary::postInitialize(), oofem::LumpedMassElement::postInitialize(), oofem::MacroLSpace::postInitialize(), oofem::Particle::postInitialize(), oofem::RigidArmNode::postInitialize(), oofem::SlaveNode::postInitialize(), oofem::B3Material::predictParametersFrom(), oofem::B3SolidMaterial::predictParametersFrom(), oofem::MPSMaterial::predictParametersFrom(), oofem::MITC4Shell::printOutputAt(), oofem::PFEMElement::printOutputAt(), oofem::RerShell::printOutputAt(), oofem::DofManager::printYourself(), oofem::ElementDofManager::printYourself(), oofem::ElementSide::printYourself(), oofem::InitialCondition::printYourself(), oofem::LatticeDirichletCouplingNode::printYourself(), oofem::LatticeNeumannCouplingNode::printYourself(), oofem::Node::printYourself(), oofem::GeometryBasedEI::propagateFronts(), restoreContext(), saveContext(), and oofem::GeometryBasedEI::writeVtkDebug().


The documentation for this class was generated from the following files:

This page is part of the OOFEM-3.0 documentation. Copyright Copyright (C) 1994-2025 Borek Patzak Bořek Patzák
Project e-mail: oofem@fsv.cvut.cz
Generated at for OOFEM by doxygen 1.15.0 written by Dimitri van Heesch, © 1997-2011