OOFEM  2.4
OOFEM.org - Object Oriented Finite Element Solver
oofem::FEMComponent Class Referenceabstract

The top abstract class of all classes constituting the finite element mesh. More...

#include <femcmpnn.h>

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

Public Member Functions

 FEMComponent (int n, Domain *d)
 Regular constructor, creates component with given number and belonging to given domain. More...
 
virtual ~FEMComponent ()
 Virtual destructor. More...
 
virtual const char * giveClassName () const =0
 
virtual const char * giveInputRecordName () const =0
 
DomaingiveDomain () const
 
virtual void setDomain (Domain *d)
 Sets associated Domain. More...
 
int giveNumber () const
 
void setNumber (int num)
 Sets number of receiver. More...
 
virtual void updateLocalNumbering (EntityRenumberingFunctor &f)
 Local renumbering support. More...
 
virtual IRResultType initializeFrom (InputRecord *ir)
 Initializes receiver according to object description stored in input record. More...
 
virtual void giveInputRecord (DynamicInputRecord &input)
 Setups the input record string of receiver. More...
 
virtual contextIOResultType saveContext (DataStream &stream, ContextMode mode, void *obj=NULL)
 Stores receiver state to output stream. More...
 
virtual contextIOResultType restoreContext (DataStream &stream, ContextMode mode, void *obj=NULL)
 Restores the receiver state previously written in stream. More...
 
virtual int checkConsistency ()
 Allows programmer to test some internal data, before computation begins. More...
 
virtual void printOutputAt (FILE *file, TimeStep *tStep)
 Prints output of receiver to stream, for given time step. More...
 
virtual void printYourself ()
 Prints receiver state on stdout. Useful for debugging. More...
 
virtual InterfacegiveInterface (InterfaceType t)
 Interface requesting service. More...
 
std::string errorInfo (const char *func) const
 Returns string for prepending output (used by error reporting macros). More...
 

Protected Attributes

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

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 76 of file femcmpnn.h.

Constructor & Destructor Documentation

oofem::FEMComponent::FEMComponent ( int  n,
Domain d 
)
inline

Regular constructor, creates component with given number and belonging to given domain.

Parameters
nComponent number in particular domain. For instance, can represent node number in particular domain.
dDomain to which component belongs to.

Definition at line 91 of file femcmpnn.h.

virtual oofem::FEMComponent::~FEMComponent ( )
inlinevirtual

Virtual destructor.

Definition at line 93 of file femcmpnn.h.

Member Function Documentation

int oofem::FEMComponent::checkConsistency ( )
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::Element, oofem::StructuralCrossSection, oofem::StructuralElement, oofem::Material, oofem::NLStructuralElement, oofem::SUPGElement, oofem::LayeredCrossSection, oofem::NURBSSpace3dElement, oofem::FiberedCrossSection, oofem::Node, oofem::IntMatBilinearCZFagerstrom, oofem::IntMatBilinearCZJansson, oofem::Shell7BaseXFEM, oofem::SimpleCrossSection, oofem::FE2FluidMaterial, oofem::BinghamFluidMaterial2, oofem::StructuralInterfaceElement, oofem::TR1_2D_SUPG, oofem::StructuralInterfaceCrossSection, oofem::NonlinearFluidMaterial, oofem::TransportElement, oofem::TR1_2D_PFEM, oofem::ExpCZMaterial, oofem::IntMatBilinearCZ, oofem::TR1_2D_CBS, oofem::IntMatBilinearCZElastic, oofem::NURBSPlaneStressElement, oofem::CBSElement, oofem::SpringElement, oofem::RigidArmNode, oofem::SolidShell, oofem::SUPGElement2, oofem::LineDistributedSpring, oofem::qcNode, oofem::NodalSpringElement, oofem::PFEMElement, oofem::HangingNode, oofem::PFEMElement2d, oofem::IntMatBilinearCZFagerstromRate, oofem::TwoFluidMaterial, oofem::LumpedMassElement, oofem::SimpleVitrificationMaterial, oofem::Quad10_2D_SUPG, oofem::NewtonianFluidMaterial, oofem::SimpleTransportCrossSection, oofem::PFEMParticle, oofem::TR21_2D_SUPG, oofem::Shell7Base, oofem::InteractionPFEMParticle, oofem::FluidCrossSection, oofem::TrPlaneStress2dXFEM, and oofem::BsplinePlaneStressElement.

Definition at line 94 of file femcmpnn.C.

Referenced by oofem::FluidCrossSection::checkConsistency(), oofem::SimpleTransportCrossSection::checkConsistency(), oofem::Node::checkConsistency(), oofem::Material::checkConsistency(), oofem::NonlinearFluidMaterial::giveInputRecordName(), oofem::BinghamFluidMaterial2::giveInputRecordName(), oofem::ExpCZMaterial::hasNonLinearBehaviour(), and oofem::FE2FluidMaterial::~FE2FluidMaterial().

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

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

Definition at line 84 of file femcmpnn.C.

References giveClassName(), and giveNumber().

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

Implemented in oofem::Element, oofem::ConcreteDPM2, oofem::ConcreteDPM, oofem::DustMaterial, oofem::HuertaRemeshingCriteria, oofem::RankineMatStatus, oofem::LatticeDamage2d, oofem::StructuralElement, oofem::MDM, oofem::HydrationModel, oofem::MPSMaterial, oofem::IsotropicDamageMaterial1, oofem::LatticeDamage2dStatus, oofem::MPSDamMaterial, oofem::DruckerPragerPlasticitySM, oofem::MisesMatStatus, oofem::TrabBone3D, oofem::LayeredCrossSection, oofem::RheoChainMaterial, oofem::NLStructuralElement, oofem::SteelRelaxMatStatus, oofem::ZZRemeshingCriteria, oofem::AnisotropicDamageMaterial, oofem::Concrete2, oofem::NURBSSpace3dElement, oofem::AbaqusUserElement, oofem::FCMMaterial, oofem::AbaqusUserMaterialStatus, oofem::MPlasticMaterial2, oofem::LEPlic, oofem::IsotropicDamageMaterial, oofem::RCM2Material, oofem::RampFunction, oofem::LatticeTransportMaterial, oofem::IntMatBilinearCZFagerstrom, oofem::IntMatBilinearCZJansson, oofem::MPSMaterialStatus, oofem::WeakPeriodicBoundaryCondition, oofem::ConcreteDPM2Status, oofem::Eurocode2CreepMaterial, oofem::FCMMaterialStatus, oofem::Node, oofem::TSplinePlaneStressElement, oofem::Shell7BaseXFEM, oofem::SteelRelaxMat, oofem::LevelSetPCS, oofem::PrescribedGradientBCWeak, oofem::HuertaErrorEstimator, oofem::MixedGradientPressureDirichlet, oofem::FiberedCrossSection, oofem::Beam3d, oofem::CemhydMatStatus, oofem::FE2FluidMaterial, oofem::Set, oofem::MixedGradientPressureNeumann, oofem::AbaqusUserMaterial, oofem::MPlasticMaterial, oofem::AnisotropicDamageMaterialStatus, oofem::RankineMat, oofem::PerfectlyPlasticMaterial, oofem::NlIsoMoistureMaterial, oofem::ConcreteDPMStatus, oofem::StructuralInterfaceElementPhF, oofem::RCM2MaterialStatus, oofem::StructuralPythonMaterialStatus, oofem::IsoInterfaceDamageMaterial_2, oofem::MPSDamMaterialStatus, oofem::TrabBone3DStatus, oofem::SimpleCrossSection, oofem::StructuralInterfaceMaterialStatus, oofem::InitialCondition, oofem::SolutionbasedShapeFunction, oofem::TrabBoneMaterial, oofem::CompoDamageMat, oofem::IsotropicDamageMaterialStatus, oofem::StructuralMaterialStatus, oofem::StructuralInterfaceCrossSection, oofem::MITC4Shell, oofem::PrescribedGenStrainShell7, oofem::Concrete2MaterialStatus, oofem::IsoInterfaceDamageMaterial, oofem::HydrationModelStatus, oofem::MixedGradientPressureWeakPeriodic, oofem::StructuralInterfaceMaterial, oofem::LargeStrainMasterMaterialStatus, oofem::StructuralMaterial, oofem::StructuralFE2Material, oofem::Beam2d, oofem::StructuralInterfaceElement, oofem::MPlasticMaterial2Status, oofem::BinghamFluidMaterial2, oofem::MDMStatus, oofem::HeMoKunzelMaterial, oofem::HeavisideFunction, oofem::PlasticMaterial, oofem::OrthotropicLinearElasticMaterial, oofem::B3SolidMaterial, oofem::BondCEBMaterial, oofem::TransportGradientDirichlet, oofem::PrescribedGenStrainShell7, oofem::DKTPlate, oofem::RCSDMaterial, oofem::MPlasticMaterialStatus, oofem::RCSDEMaterial, oofem::StructuralPythonMaterial, oofem::EnrichmentItem, oofem::ZZErrorEstimator, oofem::IsotropicDamageMaterial1Status, oofem::RVEStokesFlow, oofem::BoundaryCondition, oofem::TrabBoneEmbed, oofem::NURBSPlaneStressElement, oofem::TutorialMaterialStatus, oofem::VariableCrossSection, oofem::QDKTPlate, oofem::CebFipSlip90Material, oofem::RCSDNLMaterial, oofem::Brick1_mt, oofem::TR1_2D_SUPG, oofem::RheoChainMaterialStatus, oofem::QWedge_mt, oofem::NonlinearFluidMaterial, oofem::IntMatBilinearCZElastic, oofem::M4Material, oofem::Wedge_mt, oofem::TR1_2D_SUPG2, oofem::IDNLMaterial, oofem::MazarsMaterial, oofem::ExpCZMaterial, oofem::IntMatBilinearCZ, oofem::HeMoTKMaterial, oofem::FE2FluidMaterialStatus, oofem::CompoDamageMatStatus, oofem::LinearConstraintBC, oofem::DirectErrorIndicatorRC, oofem::RerShell, oofem::DruckerPragerCutMat, oofem::M1Material, oofem::DKTPlate3d, oofem::SpringElement, oofem::MazarsNLMaterial, oofem::DustMaterialStatus, oofem::PrescribedGradient, oofem::CombinedZZSIRemeshingCriteria, oofem::FRCFCMNL, oofem::Masonry02, oofem::SimpleInterfaceMaterial, oofem::Quad1_mt, oofem::Tr1_hmt, oofem::TwoFluidMaterialStatus, oofem::CCTPlate3d, oofem::IDGMaterialStatus, oofem::IsotropicLinearElasticMaterial, oofem::TransportGradientPeriodic, oofem::DiscontinuousFunction, oofem::ConcreteFCM, oofem::IntMatBilinearCZFagerstromStatus, oofem::MisesMat, oofem::LIBeam3d2, oofem::Brick1_hmt, oofem::PythonExpression, oofem::IntMatBilinearCZJanssonStatus, oofem::HeMoBazNajMaterial, oofem::QWedge_hmt, oofem::TR1_2D_PFEM, oofem::RigidArmNode, oofem::CCTPlate, oofem::Wedge_hmt, oofem::Lattice2d, oofem::TrabBoneMaterialStatus, oofem::B3Material, oofem::PolylineNonlocalBarrier, oofem::qcNode, oofem::UserDefDirichletBC, oofem::TrPlaneStrRot3d, oofem::PrescribedGradientBCPeriodic, oofem::Quad1MindlinShell3D, oofem::Tr2Shell7, oofem::MisesMatNl, oofem::PrescribedMean, oofem::NodalSpringElement, oofem::DruckerPragerPlasticitySMStatus, oofem::MicroMaterial, oofem::Lattice2d_mt, oofem::TR1_2D_CBS, oofem::Truss2d, oofem::LinQuad3DPlaneStress, oofem::MooneyRivlinMaterial, oofem::PlasticMaterialStatus, oofem::RCSDMaterialStatus, oofem::CemhydMat, oofem::PFEMElement, oofem::RCSDEMaterialStatus, oofem::HydratingIsoHeatMaterial, oofem::PFEMParticle, oofem::TrPlaneStrain, oofem::RankineMatNl, oofem::Truss1d, oofem::TrabBoneNLEmbed, oofem::PointLoad, oofem::LinearElasticMaterial, oofem::Quad1_hmt, oofem::Tetrah1_hmt, oofem::Tr1_mt, oofem::Tr2Shell7XFEM, oofem::FRCFCMStatus, oofem::RankineMatGrad, oofem::LatticeTransportMaterialStatus, oofem::QBrick1_hmt, oofem::BinghamFluidMaterial2Status, oofem::Tet1BubbleStokes, oofem::TR1_2D_SUPG2_AXI, oofem::MeshQualityErrorEstimator, oofem::LSpace, oofem::Truss3d, oofem::Quad1PlaneStrain, oofem::PlaneStress2d, oofem::TrabBoneNL3D, oofem::SimpleVitrificationMaterial, oofem::IntMatPhaseField, oofem::IsoInterfaceDamageMaterialStatus_2, oofem::NodalLoad, oofem::LIBeam3dNL, oofem::LumpedMassElement, oofem::TrPlanestressRotAllman3d, oofem::TrabBoneNL, oofem::IntMatIsoDamageStatus, oofem::PerfectlyPlasticMaterialStatus, oofem::TR1_2D_SUPG_AXI, oofem::Tr1BubbleStokes, oofem::HangingNode, oofem::NeumannMomentLoad, oofem::Axisymm3d, oofem::TrabBoneGrad3D, oofem::IsoInterfaceDamageMaterialStatus, oofem::CalculatorFunction, oofem::tet21ghostsolid, oofem::UserDefinedTemperatureField, oofem::StructuralFE2MaterialStatus, oofem::TransportGradientNeumann, oofem::Tr21Stokes, oofem::FRCFCMNLStatus, oofem::MisesMatGrad, oofem::LIBeam3dNL2, oofem::InterfaceElem1d, oofem::TrPlaneStress2d, oofem::IsotropicHeatTransferMaterial, oofem::ConstantSurfaceLoad, oofem::IntegrationPointStatus, oofem::QTRSpace, oofem::LIBeam3d, oofem::TrPlanestressRotAllman, oofem::TR_SHELL01, oofem::ConstantPressureLoad, oofem::Eurocode2CreepMaterialStatus, oofem::QuadAxisym1_mt, oofem::InteractionPFEMParticle, oofem::Tet21Stokes, oofem::LIBeam2d, oofem::TR_SHELL02, oofem::ForeignTemperatureFieldLoad, oofem::HydratingConcreteMat, oofem::NonlinearMassTransferMaterial, oofem::EnrichmentFunction, oofem::Quad1Mindlin, oofem::TrabBoneEmbedStatus, oofem::WinklerMaterial, oofem::RVEStokesFlowMaterialStatus, oofem::SimpleTransportCrossSection, oofem::TransportMaterialStatus, oofem::Hexa21Stokes, oofem::LinearEdgeLoad, oofem::Reinforcement, oofem::SurfaceTensionBoundaryCondition, oofem::RotatingBoundary, oofem::LIBeam2dNL, oofem::InterfaceElem2dQuad, oofem::Shell7Base, oofem::BondCEBMaterialStatus, oofem::CohesiveInterfaceMaterial, oofem::LargeStrainMasterMaterial, oofem::NonlinearFluidMaterialStatus, oofem::QSpace, oofem::QWedge, oofem::BsplinePlaneStressElement, oofem::CohesiveSurface3d, oofem::SolidShell, oofem::SymmetryBarrier, oofem::BazantNajjarMoistureTransferMaterial, oofem::Tr1Darcy, oofem::FluidCrossSection, oofem::PrescribedGradientBCNeumann, oofem::InterfaceElem2dLin, oofem::IntElLine1, oofem::TrPlaneStrRot, oofem::IDNLMaterialStatus, oofem::CebFipSlip90MaterialStatus, oofem::LargeStrainMasterMaterialGrad, oofem::WinklerPasternakMaterial, oofem::Delamination, oofem::TwoFluidMaterial, oofem::PeriodicPiecewiseLinFunction, oofem::SlaveNode, oofem::LWedge, oofem::InterfaceElement3dTrLin, oofem::AnisotropicLinearElasticMaterial, oofem::MazarsMaterialStatus, oofem::RCSDNLMaterialStatus, oofem::MaxwellChainMaterial, oofem::PFEMElement2d, oofem::QTrPlaneStrain, oofem::HydratingHeMoMaterial, oofem::NewtonianFluidMaterial, oofem::InteractionLoad, oofem::LTRSpace, oofem::ScalarErrorIndicator, oofem::IntMatBilinearCZStatus, oofem::IntMatPhaseFieldStatus, oofem::KelvinChainSolidMaterial, oofem::AnisotropicMassTransferMaterial, oofem::GravityPressure, oofem::Q27Space, oofem::BasicElement, oofem::CombinedZZSIErrorEstimator, oofem::ConcreteFCMStatus, oofem::B3SolidMaterialStatus, oofem::Line2BoundaryElement, oofem::ConstantFunction, oofem::LineDistributedSpring, oofem::QTrPlaneStress2d, oofem::Quad1PlateSubSoil, oofem::Tria1PlateSubSoil, oofem::IntElLine1PF, oofem::QuadAxisym1_hmt, oofem::QTruss1d, oofem::HyperElasticMaterial, oofem::MicroMaterialStatus, oofem::MisesMatNlStatus, oofem::KelvinChainMaterial, oofem::IntElLine1PhF, oofem::TrabBoneNLEmbedStatus, oofem::MazarsNLMaterialStatus, oofem::LatticeMaterialStatus, oofem::TutorialMaterial, oofem::InteractionBoundaryCondition, oofem::ElementSide, oofem::HeavisideTimeFunction, oofem::LocalGaussianRandomFunction, oofem::TrPlaneStress2dXFEM, oofem::Concrete3, oofem::QWedge_ht, oofem::ConstantEdgeLoad, oofem::DeadWeight, oofem::ElementDofManager, oofem::TrabBoneNL3DStatus, oofem::StructuralInterfaceMaterialPhF, oofem::Particle, oofem::Wedge_ht, oofem::Quad10_2D_SUPG, oofem::Q4Axisymm, oofem::QTrPlaneStress2dXFEM, oofem::SimpleInterfaceMaterialStatus, oofem::MicroplaneMaterial_Bazant, oofem::J2plasticMaterial, oofem::TR21_2D_SUPG, oofem::BasicElementQuad, oofem::Quad2PlateSubSoil, oofem::IntMatBilinearCZElasticStatus, oofem::J2Mat, oofem::J2MPlasticMaterial, oofem::CebFip78Material, oofem::StructuralMaterialSettable, oofem::InterpolatingFuction, oofem::PeakFunction, oofem::L4Axisymm, oofem::TrabBoneNLStatus, oofem::ExpCZMaterialStatus, oofem::RankineMatNlStatus, oofem::StructuralEigenstrainLoad, oofem::TF1, oofem::M1MaterialStatus, oofem::RankineMatGradStatus, oofem::Brick1_ht, oofem::IsotropicLinMoistureTransferMaterial, oofem::IsotropicMoistureTransferMaterial, oofem::QBrick1_ht, oofem::PiecewiseLinFunction, oofem::WarpingCrossSection, oofem::IntElLine2, oofem::M4MaterialStatus, oofem::GeometryBasedEI, oofem::Inclusion, oofem::MacroLSpace, oofem::HTSelement, oofem::Tr_Warp, oofem::TrabBoneGrad3DStatus, oofem::IDGMaterial, oofem::RankinePlasticMaterial, oofem::DoublePowerLawMaterial, oofem::Tetrah1_ht, oofem::Tr1_ht, oofem::QSpaceGrad, oofem::PlaneStressPhF2d, oofem::PlaneStress2dXfem, oofem::QPlaneStress2d, oofem::Quad1_ht, oofem::QTRSpaceGrad, oofem::QWedgeGrad, oofem::Q9PlaneStress2d, oofem::QPlaneStressPhF2d, oofem::MisesMatGradStatus, oofem::EmptyCS, oofem::QPlaneStrain, oofem::StructuralTemperatureLoad, oofem::IntMatElastic, oofem::TractionPressureBC, oofem::IntMatDummyCZ, oofem::Steel1, oofem::ShellCrack, oofem::HydratingTransportMaterialStatus, oofem::HybridEI, oofem::ListBasedEI, oofem::QTruss1dGrad, oofem::Tet1_3D_SUPG, oofem::DirectEI, oofem::KelvinChainMaterialStatus, oofem::KelvinChainSolidMaterialStatus, oofem::MaxwellChainMaterialStatus, oofem::Crack, oofem::QPlaneStrainGrad, oofem::QPlaneStressGrad, oofem::QTrPlaneStressGrad, oofem::QuadAxisym1_ht, oofem::DummyMaterial, oofem::IntElLine2IntPen, oofem::QTrPlaneStrainGrad, oofem::LSpaceBB, oofem::IntElLine1IntPen, oofem::TrAxisym1_ht, oofem::DeformationTheoryMaterial, oofem::PrescribedGradientBCWeakDirichlet, and oofem::PrescribedGradientBCWeakPeriodic.

Referenced by oofem::StructuralInterfaceCrossSection::checkConsistency(), oofem::SimpleCrossSection::checkConsistency(), oofem::FiberedCrossSection::checkConsistency(), oofem::LayeredCrossSection::checkConsistency(), errorInfo(), oofem::DofManager::printOutputAt(), oofem::MasterDof::printYourself(), and oofem::Dof::printYourself().

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

Definition at line 100 of file femcmpnn.h.

Referenced by oofem::PrimaryField::__evaluateAt(), oofem::RandomMaterialExtensionInterface::_generateStatusVariables(), oofem::Set::addAllElements(), oofem::DofDistributedPrimaryField::applyBoundaryCondition(), oofem::PrimaryField::applyBoundaryCondition(), oofem::DofDistributedPrimaryField::applyInitialCondition(), oofem::PrimaryField::applyInitialCondition(), oofem::ActiveDof::askNewEquationNumber(), oofem::MasterDof::askNewEquationNumber(), oofem::SurfaceTensionBoundaryCondition::assemble(), oofem::PrescribedGradientBCNeumann::assemble(), oofem::PrescribedMean::assemble(), oofem::TransportGradientNeumann::assemble(), oofem::MixedGradientPressureWeakPeriodic::assemble(), oofem::MixedGradientPressureNeumann::assemble(), oofem::PrescribedGradientBCNeumann::assembleVector(), oofem::SurfaceTensionBoundaryCondition::assembleVector(), oofem::TransportGradientNeumann::assembleVector(), oofem::MixedGradientPressureWeakPeriodic::assembleVector(), oofem::MixedGradientPressureNeumann::assembleVector(), oofem::StructuralInterfaceCrossSection::checkConsistency(), oofem::SimpleCrossSection::checkConsistency(), oofem::FiberedCrossSection::checkConsistency(), oofem::SolutionbasedShapeFunction::computeBaseFunctionValueAt(), oofem::XfemElementInterface::ComputeBOrBHMatrix(), oofem::TransportGradientDirichlet::computeCoefficientMatrix(), oofem::LatticeTransportMaterial::computeConductivity(), oofem::SolutionbasedShapeFunction::computeDofTransformation(), oofem::PrescribedMean::computeDomainSize(), oofem::TransportGradientNeumann::computeEta(), oofem::Shell7BaseXFEM::computeFailureCriteriaQuantities(), oofem::PrescribedGradientBCPeriodic::computeField(), oofem::TransportGradientPeriodic::computeField(), oofem::PrescribedGradient::computeField(), oofem::PrescribedGenStrainShell7::computeField(), oofem::TransportGradientDirichlet::computeField(), oofem::MixedGradientPressureDirichlet::computeFields(), oofem::MixedGradientPressureNeumann::computeFields(), oofem::PlaneStress2dXfem::computeGaussPoints(), oofem::QTrPlaneStress2dXFEM::computeGaussPoints(), oofem::Tr2Shell7XFEM::computeGaussPoints(), oofem::TrPlaneStress2dXFEM::computeGaussPoints(), oofem::TR21_2D_SUPG::computeIntersection(), oofem::SurfaceTensionBoundaryCondition::computeLoadVectorFromElement(), oofem::XfemElementInterface::computeNCohesive(), oofem::FRCFCMNL::computeNonlocalStressInFibers(), oofem::MacroLSpace::computeStiffnessMatrix(), oofem::MixedGradientPressureWeakPeriodic::computeStress(), oofem::GradDpElement::computeStressVectorAndLocalCumulatedStrain(), oofem::PrescribedGradientBCNeumann::computeTangent(), oofem::PrescribedGradientBCPeriodic::computeTangent(), oofem::TransportGradientNeumann::computeTangent(), oofem::TransportGradientPeriodic::computeTangent(), oofem::PrescribedGradient::computeTangent(), oofem::PrescribedGenStrainShell7::computeTangent(), oofem::TransportGradientDirichlet::computeTangent(), oofem::PrescribedGradientBCWeak::computeTangent(), oofem::SurfaceTensionBoundaryCondition::computeTangentFromElement(), oofem::MixedGradientPressureWeakPeriodic::computeTangents(), oofem::MixedGradientPressureDirichlet::computeTangents(), oofem::MixedGradientPressureNeumann::computeTangents(), oofem::NeumannMomentLoad::computeXbar(), oofem::TransportGradientDirichlet::computeXi(), oofem::MixedGradientPressureWeakPeriodic::constructMMatrix(), oofem::EnrichmentItem::createEnrichedDofs(), oofem::RankinePlasticMaterial::CreateStatus(), oofem::J2MPlasticMaterial::CreateStatus(), oofem::HyperElasticMaterial::CreateStatus(), oofem::J2plasticMaterial::CreateStatus(), oofem::J2Mat::CreateStatus(), oofem::TutorialMaterial::CreateStatus(), oofem::NewtonianFluidMaterial::CreateStatus(), oofem::LargeStrainMasterMaterialGrad::CreateStatus(), oofem::StructuralMaterialSettable::CreateStatus(), oofem::TwoFluidMaterial::CreateStatus(), oofem::KelvinChainMaterial::CreateStatus(), oofem::KelvinChainSolidMaterial::CreateStatus(), oofem::LargeStrainMasterMaterial::CreateStatus(), oofem::WinklerPasternakMaterial::CreateStatus(), oofem::AnisotropicLinearElasticMaterial::CreateStatus(), oofem::LinearElasticMaterial::CreateStatus(), oofem::MaxwellChainMaterial::CreateStatus(), oofem::WinklerMaterial::CreateStatus(), oofem::MooneyRivlinMaterial::CreateStatus(), oofem::MicroMaterial::CreateStatus(), oofem::StructuralPythonMaterial::CreateStatus(), oofem::DruckerPragerCutMat::CreateStatus(), oofem::MisesMat::CreateStatus(), oofem::RVEStokesFlow::CreateStatus(), oofem::Masonry02::CreateStatus(), oofem::NonlinearFluidMaterial::CreateStatus(), oofem::TrabBoneEmbed::CreateStatus(), oofem::B3SolidMaterial::CreateStatus(), oofem::BinghamFluidMaterial2::CreateStatus(), oofem::AbaqusUserMaterial::CreateStatus(), oofem::StructuralFE2Material::CreateStatus(), oofem::TrabBoneMaterial::CreateStatus(), oofem::FE2FluidMaterial::CreateStatus(), oofem::PlasticMaterial::CreateStatus(), oofem::RankineMat::CreateStatus(), oofem::PerfectlyPlasticMaterial::CreateStatus(), oofem::SteelRelaxMat::CreateStatus(), oofem::Eurocode2CreepMaterial::CreateStatus(), oofem::Concrete2::CreateStatus(), oofem::MPlasticMaterial::CreateStatus(), oofem::TrabBone3D::CreateStatus(), oofem::MPlasticMaterial2::CreateStatus(), oofem::HydrationModel::CreateStatus(), oofem::MPSMaterial::CreateStatus(), oofem::MPSDamMaterial::CreateStatus(), oofem::RheoChainMaterial::CreateStatus(), oofem::MDM::CreateStatus(), oofem::DruckerPragerPlasticitySM::CreateStatus(), oofem::DustMaterial::CreateStatus(), oofem::ConcreteDPM::CreateStatus(), oofem::ConcreteDPM2::CreateStatus(), oofem::PrescribedGradientBCWeak::damageExceedsTolerance(), oofem::TransportGradientNeumann::domainSize(), oofem::MixedGradientPressureBC::domainSize(), oofem::TransportGradientDirichlet::domainSize(), oofem::PrescribedGenStrainShell7::domainSize(), oofem::PlaneStress2dXfem::drawRawGeometry(), oofem::TrPlaneStress2dXFEM::drawRawGeometry(), oofem::PlaneStress2dXfem::drawScalar(), oofem::TrPlaneStress2dXFEM::drawScalar(), oofem::TR1_2D_PFEM::drawScalar(), oofem::Node::drawYourself(), oofem::DirectErrorIndicatorRC::estimateMeshDensities(), oofem::GeometryBasedEI::evaluateEnrFuncJumps(), oofem::PrescribedGenStrainShell7::evaluateHigherOrderContribution(), oofem::DirectErrorIndicatorRC::exchangeDofManDensities(), oofem::DirectErrorIndicatorRC::exchangeDofManIndicatorVals(), oofem::PrescribedGradientBCWeak::findCrackBndIntersecCoord(), oofem::PrescribedGradientBCWeak::findHoleCoord(), oofem::Delamination::findInitiationFronts(), oofem::VTKExportModule::getDofManPrimaryVariable(), oofem::IsotropicHeatTransferMaterial::give(), oofem::VariableCrossSection::give(), oofem::MisesMat::give(), oofem::ActiveDof::giveActiveBoundaryCondition(), oofem::MasterDof::giveBc(), oofem::PrescribedGradientBCWeak::giveBoundaries(), oofem::SUPGElement::giveCharacteristicMatrix(), oofem::MITC4Shell::giveDirectorVectors(), oofem::AuxVelocityNumberingScheme::giveDofEquationNumber(), oofem::DirectErrorIndicatorRC::giveDofManDensity(), oofem::PlaneStress2dXfem::giveDofManDofIDMask(), oofem::QTrPlaneStress2dXFEM::giveDofManDofIDMask(), oofem::TrPlaneStress2dXFEM::giveDofManDofIDMask(), oofem::Shell7BaseXFEM::giveDofManDofIDMask(), oofem::DirectErrorIndicatorRC::giveDofManIndicator(), oofem::RheoChainMaterial::giveEndOfTimeOfInterest(), oofem::IntElPoint::giveEngTraction(), oofem::Function::giveFunctionParameter(), oofem::PlaneStress2dXfem::giveGeometryType(), oofem::QTrPlaneStress2dXFEM::giveGeometryType(), oofem::TrPlaneStress2dXFEM::giveGeometryType(), oofem::MasterDof::giveIc(), oofem::StructuralInterfaceCrossSection::giveInterfaceMaterial(), oofem::LayeredCrossSection::giveInterfaceMaterial(), oofem::PrescribedMean::giveInternalForcesVector(), oofem::AbaqusUserElement::giveInternalForcesVector(), oofem::Element::giveInternalStateAtNode(), oofem::FiberedCrossSection::giveIPValue(), oofem::Element::giveIPValue(), oofem::Shell7Base::giveLayerContributionToSR(), oofem::RheoChainMaterial::giveLinearElasticMaterial(), oofem::LIBeam3d::giveLocalCoordinateSystem(), oofem::LIBeam3d2::giveLocalCoordinateSystem(), oofem::Beam3d::giveLocalCoordinateSystem(), oofem::LIBeam3dNL::giveLocalCoordinateSystem(), oofem::LIBeam3dNL2::giveLocalCoordinateSystem(), oofem::DirectErrorIndicatorRC::giveLocalDofManDensity(), oofem::DirectErrorIndicatorRC::giveLocalDofManIndicator(), oofem::PrescribedGradientBCNeumann::giveLocationArrays(), oofem::SurfaceTensionBoundaryCondition::giveLocationArrays(), oofem::TransportGradientNeumann::giveLocationArrays(), oofem::MixedGradientPressureWeakPeriodic::giveLocationArrays(), oofem::MixedGradientPressureNeumann::giveLocationArrays(), oofem::SimpleSlaveDof::giveMasterDof(), oofem::SlaveDof::giveMasterDof(), oofem::FluidCrossSection::giveMaterial(), oofem::StructuralInterfaceCrossSection::giveMaterial(), oofem::SimpleCrossSection::giveMaterial(), oofem::PrescribedGradientBCPeriodic::giveNumberOfMasterDofs(), oofem::TransportGradientPeriodic::giveNumberOfMasterDofs(), oofem::SolutionbasedShapeFunction::giveNumberOfMasterDofs(), oofem::DofManager::givePartitionsConnectivitySize(), oofem::BoundaryLoad::giveProperty(), oofem::LatticeDamage2d::giveRealStressVector(), oofem::IntElPoint::giveStiffnessMatrix_Eng(), oofem::XfemStructuralElementInterface::giveSubtriangulationCompositeExportData(), oofem::MasterDof::giveUnknown(), oofem::MasterDof::giveUnknownsDictionaryValue(), oofem::MasterDof::hasBc(), oofem::SolutionbasedShapeFunction::init(), oofem::qcNode::initializeAsRepnode(), oofem::XfemStructuralElementInterface::initializeCZMaterial(), oofem::PhaseFieldElement::initializeFrom(), oofem::Inclusion::initializeFrom(), oofem::Delamination::initializeFrom(), oofem::Set::initializeFrom(), oofem::qcNode::initializeFrom(), oofem::SolutionbasedShapeFunction::initializeFrom(), oofem::Beam2d::initializeFrom(), oofem::Beam3d::initializeFrom(), oofem::MDM::initializeFrom(), oofem::StructuralInterfaceMaterialStatus::initTempStatus(), oofem::GeometryBasedEI::instanciateYourself(), oofem::Delamination::instanciateYourself(), oofem::MixedGradientPressureNeumann::integrateDevTangent(), oofem::PrescribedGradientBCNeumann::integrateTangent(), oofem::MixedGradientPressureWeakPeriodic::integrateTractionVelocityTangent(), oofem::MixedGradientPressureNeumann::integrateVolTangent(), oofem::HybridEI::interpGradLevelSet(), oofem::HybridEI::interpLevelSet(), oofem::HybridEI::interpLevelSetTangential(), oofem::LEPlicElementInterface::isBoundary(), oofem::ParallelOrdering::isLocal(), oofem::DofManager::isLocal(), oofem::GnuplotExportModule::outputBoundaryCondition(), oofem::XfemElementInterface::partitionEdgeSegment(), oofem::Shell7BaseXFEM::postInitialize(), oofem::HangingNode::postInitialize(), oofem::qcNode::postInitializeAsHangingNode(), oofem::qcNode::printOutputAt(), oofem::DofManager::printOutputAt(), oofem::ListBasedEI::propagateFronts(), oofem::GeometryBasedEI::propagateFronts(), oofem::Delamination::propagateFronts(), oofem::MasterDof::restoreContext(), oofem::SimpleSlaveDof::saveContext(), oofem::SlaveDof::saveContext(), oofem::MasterDof::saveContext(), oofem::qcNode::setAsHanging(), oofem::SolutionbasedShapeFunction::setBoundaryConditionOnDof(), oofem::SolutionbasedShapeFunction::setLoads(), oofem::PatchIntegrationRule::SetUpPointsOnTriangle(), oofem::PatchIntegrationRule::SetUpPointsOnWedge(), oofem::HuertaErrorEstimatorInterface::setupRefinedElementProblem1D(), oofem::HuertaErrorEstimatorInterface::setupRefinedElementProblem2D(), oofem::HuertaErrorEstimatorInterface::setupRefinedElementProblem3D(), oofem::EnrichmentItem::tipIsTouchingEI(), oofem::Tr_Warp::transformCoordinates(), oofem::PrescribedGradient::updateCoefficientMatrix(), oofem::PrescribedGenStrainShell7::updateCoefficientMatrix(), oofem::WeakPeriodicBoundaryCondition::updateDirection(), oofem::GeometryBasedEI::updateDofIdPool(), oofem::ListBasedEI::updateGeometry(), oofem::GeometryBasedEI::updateGeometry(), oofem::GeometryBasedEI::updateLevelSets(), oofem::GeometryBasedEI::updateNodeEnrMarker(), oofem::WeakPeriodicBoundaryCondition::updateSminmax(), oofem::MasterDof::updateUnknownsDictionary(), oofem::XfemStructuralElementInterface::useNonStdCz(), oofem::XfemStructuralElementInterface::XfemElementInterface_computeConstitutiveMatrixAt(), oofem::XfemStructuralElementInterface::XfemElementInterface_computeStressVector(), oofem::XfemElementInterface::XfemElementInterface_createEnrNmatrixAt(), oofem::XfemElementInterface::XfemElementInterface_giveNumDofManEnrichments(), oofem::XfemElementInterface::XfemElementInterface_prepareNodesForDelaunay(), oofem::XfemStructuralElementInterface::XfemElementInterface_updateIntegrationRule(), and oofem::XfemElementInterface::XfemElementInterface_updateIntegrationRule().

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

Definition at line 77 of file femcmpnn.C.

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

Referenced by oofem::GeometryBasedEI::appendInputRecords(), oofem::Delamination::appendInputRecords(), oofem::IsotropicDamageMaterial::computeEta(), oofem::DynamicInputRecord::DynamicInputRecord(), oofem::IntMatCoulombContact::give1dStiffnessMatrix_Eng(), oofem::SimpleInterfaceMaterial::giveClassName(), oofem::BondCEBMaterial::giveClassName(), oofem::IsoInterfaceDamageMaterial::giveClassName(), oofem::IsoInterfaceDamageMaterial_2::giveClassName(), oofem::PiecewiseLinFunction::giveInputRecord(), oofem::HeavisideTimeFunction::giveInputRecord(), oofem::ConstantFunction::giveInputRecord(), oofem::CalculatorFunction::giveInputRecord(), oofem::EnrichmentFunction::giveInputRecord(), oofem::PythonExpression::giveInputRecord(), oofem::GeneralBoundaryCondition::giveInputRecord(), oofem::Material::giveInputRecord(), oofem::CrossSection::giveInputRecord(), oofem::DofManager::giveInputRecord(), oofem::Element::giveInputRecord(), oofem::TrabBoneNL::giveInputRecordName(), oofem::IntMatPhaseField::giveInputRecordName(), oofem::TrabBoneNL3D::giveInputRecordName(), oofem::TrabBoneNLEmbed::giveInputRecordName(), oofem::RankineMatNl::giveInputRecordName(), oofem::MisesMatNl::giveInputRecordName(), oofem::IDNLMaterial::giveInputRecordName(), oofem::IntMatBilinearCZElastic::giveInputRecordName(), oofem::CompoDamageMat::giveInputRecordName(), oofem::IsotropicDamageMaterial1::giveInputRecordName(), oofem::AnisotropicDamageMaterial::giveRealStressVector_1d(), oofem::MDM::giveRealStressVector_PlaneStress(), oofem::IntMatBilinearCZ::hasAnalyticalTangentStiffness(), oofem::CebFipSlip90Material::hasAnalyticalTangentStiffness(), oofem::IntMatIsoDamage::hasAnalyticalTangentStiffness(), oofem::IntMatBilinearCZFagerstrom::hasAnalyticalTangentStiffness(), oofem::HuertaErrorEstimator::setupRefinedProblemEpilog2(), oofem::T3DInterface::t3d_2_OOFEM(), oofem::BinghamFluidMaterial2::~BinghamFluidMaterial2(), oofem::FE2FluidMaterial::~FE2FluidMaterial(), and oofem::NonlinearFluidMaterial::~NonlinearFluidMaterial().

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

Implemented in oofem::ConcreteDPM2, oofem::ConcreteDPM, oofem::DustMaterial, oofem::HuertaRemeshingCriteria, oofem::LatticeDamage2d, oofem::MDM, oofem::HydrationModel, oofem::MPSMaterial, oofem::IsotropicDamageMaterial1, oofem::DruckerPragerPlasticitySM, oofem::MPSDamMaterial, oofem::TrabBone3D, oofem::LayeredCrossSection, oofem::ZZRemeshingCriteria, oofem::AnisotropicDamageMaterial, oofem::Concrete2, oofem::AbaqusUserElement, oofem::NURBSSpace3dElement, oofem::RampFunction, oofem::IntMatBilinearCZFagerstrom, oofem::IntMatBilinearCZJansson, oofem::WeakPeriodicBoundaryCondition, oofem::LatticeTransportMaterial, oofem::Eurocode2CreepMaterial, oofem::Node, oofem::PrescribedGradientBCWeak, oofem::TSplinePlaneStressElement, oofem::SteelRelaxMat, oofem::MixedGradientPressureDirichlet, oofem::Beam3d, oofem::HuertaErrorEstimator, oofem::FiberedCrossSection, oofem::FE2FluidMaterial, oofem::Set, oofem::MixedGradientPressureNeumann, oofem::AbaqusUserMaterial, oofem::RankineMat, oofem::NlIsoMoistureMaterial, oofem::ErrorEstimator, oofem::IsoInterfaceDamageMaterial_2, oofem::SimpleCrossSection, oofem::InitialCondition, oofem::SolutionbasedShapeFunction, oofem::CompoDamageMat, oofem::TrabBoneMaterial, oofem::StructuralInterfaceCrossSection, oofem::MITC4Shell, oofem::PrescribedGenStrainShell7, oofem::MixedGradientPressureWeakPeriodic, oofem::IsoInterfaceDamageMaterial, oofem::Beam2d, oofem::IntMatIsoDamage, oofem::StructuralFE2Material, oofem::BinghamFluidMaterial2, oofem::HeavisideFunction, oofem::B3SolidMaterial, oofem::HeMoKunzelMaterial, oofem::OrthotropicLinearElasticMaterial, oofem::TransportGradientDirichlet, oofem::PrescribedGenStrainShell7, oofem::DKTPlate, oofem::BondCEBMaterial, oofem::StructuralPythonMaterial, oofem::RCSDMaterial, oofem::RCSDEMaterial, oofem::RVEStokesFlow, oofem::BoundaryCondition, oofem::VariableCrossSection, oofem::QDKTPlate, oofem::TrabBoneEmbed, oofem::NURBSPlaneStressElement, oofem::TR1_2D_SUPG, oofem::NonlinearFluidMaterial, oofem::IntMatBilinearCZElastic, oofem::CebFipSlip90Material, oofem::Brick1_mt, oofem::QWedge_mt, oofem::TR1_2D_SUPG2, oofem::IDNLMaterial, oofem::IntMatBilinearCZ, oofem::M4Material, oofem::Wedge_mt, oofem::MazarsMaterial, oofem::HeMoTKMaterial, oofem::DruckerPragerCutMat, oofem::M1Material, oofem::DKTPlate3d, oofem::DirectErrorIndicatorRC, oofem::PrescribedGradient, oofem::RerShell, oofem::SpringElement, oofem::FRCFCMNL, oofem::CCTPlate3d, oofem::CombinedZZSIRemeshingCriteria, oofem::IntMatCoulombContact, oofem::Masonry02, oofem::IsotropicLinearElasticMaterial, oofem::TransportGradientPeriodic, oofem::DiscontinuousFunction, oofem::ConcreteFCM, oofem::SimpleInterfaceMaterial, oofem::Quad1_mt, oofem::Tr1_hmt, oofem::PythonExpression, oofem::MisesMat, oofem::TR1_2D_PFEM, oofem::RigidArmNode, oofem::LIBeam3d2, oofem::CCTPlate, oofem::Brick1_hmt, oofem::B3Material, oofem::HeMoBazNajMaterial, oofem::QWedge_hmt, oofem::qcNode, oofem::UserDefDirichletBC, oofem::Wedge_hmt, oofem::PrescribedGradientBCPeriodic, oofem::Lattice2d, oofem::MisesMatNl, oofem::PolylineNonlocalBarrier, oofem::PrescribedMean, oofem::TrPlaneStrRot3d, oofem::TR1_2D_CBS, oofem::Quad1MindlinShell3D, oofem::Tr2Shell7, oofem::NodalSpringElement, oofem::MicroMaterial, oofem::Lattice2d_mt, oofem::PFEMParticle, oofem::Truss2d, oofem::LinQuad3DPlaneStress, oofem::MooneyRivlinMaterial, oofem::RankineMatNl, oofem::CemhydMat, oofem::TrabBoneNLEmbed, oofem::HydratingIsoHeatMaterial, oofem::PointLoad, oofem::TrPlaneStrain, oofem::LinearConstraintBC, oofem::Truss1d, oofem::RankineMatGrad, oofem::Tet1BubbleStokes, oofem::TR1_2D_SUPG2_AXI, oofem::TrabBoneNL3D, oofem::IntMatIsoDamageTable, oofem::SimpleVitrificationMaterial, oofem::Quad1_hmt, oofem::Tetrah1_hmt, oofem::Tr1_mt, oofem::Tr2Shell7XFEM, oofem::IntMatPhaseField, oofem::QBrick1_hmt, oofem::LSpace, oofem::Truss3d, oofem::Quad1PlaneStrain, oofem::PlaneStress2d, oofem::TrabBoneNL, oofem::TR1_2D_SUPG_AXI, oofem::Tr1BubbleStokes, oofem::HangingNode, oofem::NeumannMomentLoad, oofem::Axisymm3d, oofem::TrabBoneGrad3D, oofem::CalculatorFunction, oofem::LIBeam3dNL, oofem::LumpedMassElement, oofem::TrPlanestressRotAllman3d, oofem::TransportGradientNeumann, oofem::Tr21Stokes, oofem::UserDefinedTemperatureField, oofem::ConstantSurfaceLoad, oofem::ConstantPressureLoad, oofem::MisesMatGrad, oofem::InteractionPFEMParticle, oofem::Tet21Stokes, oofem::LIBeam3dNL2, oofem::InterfaceElem1d, oofem::TrPlaneStress2d, oofem::IsotropicHeatTransferMaterial, oofem::IntegrationPointStatus, oofem::QTRSpace, oofem::LIBeam3d, oofem::TrPlanestressRotAllman, oofem::TR_SHELL01, oofem::WinklerMaterial, oofem::SimpleTransportCrossSection, oofem::Hexa21Stokes, oofem::LinearEdgeLoad, oofem::NodalLoad, oofem::Reinforcement, oofem::SurfaceTensionBoundaryCondition, oofem::LIBeam2d, oofem::TR_SHELL02, oofem::ForeignTemperatureFieldLoad, oofem::NonlinearMassTransferMaterial, oofem::Quad1Mindlin, oofem::CohesiveInterfaceMaterial, oofem::CohesiveSurface3d, oofem::RotatingBoundary, oofem::FluidCrossSection, oofem::PrescribedGradientBCNeumann, oofem::LIBeam2dNL, oofem::InterfaceElem2dQuad, oofem::LargeStrainMasterMaterial, oofem::WinklerPasternakMaterial, oofem::Delamination, oofem::TwoFluidMaterial, oofem::PeriodicPiecewiseLinFunction, oofem::SlaveNode, oofem::QSpace, oofem::QWedge, oofem::BsplinePlaneStressElement, oofem::SolidShell, oofem::SymmetryBarrier, oofem::BazantNajjarMoistureTransferMaterial, oofem::Tr1Darcy, oofem::InterfaceElem2dLin, oofem::IntElLine1, oofem::TrPlaneStrRot, oofem::NewtonianFluidMaterial, oofem::InteractionLoad, oofem::LWedge, oofem::InterfaceElement3dTrLin, oofem::IntElPoint, oofem::AnisotropicLinearElasticMaterial, oofem::RCSDNLMaterialStatus, oofem::GravityPressure, oofem::IntElSurfTr1, oofem::QTrPlaneStrain, oofem::HydratingHeMoMaterial, oofem::Line2BoundaryElement, oofem::ConstantFunction, oofem::LTRSpace, oofem::AnisotropicMassTransferMaterial, oofem::Q27Space, oofem::CombinedZZSIErrorEstimator, oofem::LineDistributedSpring, oofem::BasicElement, oofem::QTrPlaneStress2d, oofem::Quad1PlateSubSoil, oofem::Tria1PlateSubSoil, oofem::IntElLine1PF, oofem::InteractionBoundaryCondition, oofem::ElementSide, oofem::HeavisideTimeFunction, oofem::LocalGaussianRandomFunction, oofem::QTruss1d, oofem::Concrete3, oofem::HyperElasticMaterial, oofem::ConstantEdgeLoad, oofem::DeadWeight, oofem::ElementDofManager, oofem::IntElLine1PhF, oofem::MazarsNLMaterialStatus, oofem::TutorialMaterial, oofem::Quad10_2D_SUPG, oofem::TrPlaneStress2dXFEM, oofem::QWedge_ht, oofem::TR21_2D_SUPG, oofem::WarpingCrossSection, oofem::tet21ghostsolid, oofem::CebFip78Material, oofem::StructuralMaterialSettable, oofem::Particle, oofem::Wedge_ht, oofem::InterpolatingFuction, oofem::PeakFunction, oofem::Q4Axisymm, oofem::QTrPlaneStress2dXFEM, oofem::J2plasticMaterial, oofem::BasicElementQuad, oofem::Quad2PlateSubSoil, oofem::J2Mat, oofem::J2MPlasticMaterial, oofem::PiecewiseLinFunction, oofem::L4Axisymm, oofem::GeometryBasedEI, oofem::Inclusion, oofem::StructuralEigenstrainLoad, oofem::TF1, oofem::IDGMaterial, oofem::DoublePowerLawMaterial, oofem::Brick1_ht, oofem::IsotropicLinMoistureTransferMaterial, oofem::QBrick1_ht, oofem::IntElLine2, oofem::MacroLSpace, oofem::HTSelement, oofem::Tr_Warp, oofem::RankinePlasticMaterial, oofem::Tetrah1_ht, oofem::Tr1_ht, oofem::EmptyCS, oofem::QSpaceGrad, oofem::PlaneStressPhF2d, oofem::PlaneStress2dXfem, oofem::QPlaneStress2d, oofem::Quad1_ht, oofem::QTRSpaceGrad, oofem::QWedgeGrad, oofem::Q9PlaneStress2d, oofem::QPlaneStressPhF2d, oofem::IntMatElastic, oofem::TractionPressureBC, oofem::QPlaneStrain, oofem::StructuralTemperatureLoad, oofem::IntMatDummyCZ, oofem::ShellCrack, oofem::HybridEI, oofem::ListBasedEI, oofem::Tet1_3D_SUPG, oofem::DirectEI, oofem::Steel1, oofem::Crack, oofem::MaterialInterface, oofem::QTruss1dGrad, oofem::DummyMaterial, oofem::QPlaneStrainGrad, oofem::QPlaneStressGrad, oofem::QTrPlaneStressGrad, oofem::IntElLine2IntPen, oofem::LSpaceBB, oofem::IntElLine1IntPen, oofem::TrAxisym1_ht, oofem::PrescribedGradientBCWeakDirichlet, and oofem::PrescribedGradientBCWeakPeriodic.

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

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

Interface requesting service.

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

Reimplemented in oofem::LatticeDamage2d, oofem::IsotropicDamageMaterial1, oofem::MDM, oofem::LatticeDamage2dStatus, oofem::AbaqusUserElement, oofem::IsotropicLinearElasticMaterial, oofem::Shell7BaseXFEM, oofem::Beam3d, oofem::MDMStatus, oofem::DKTPlate, oofem::TR1_2D_SUPG, oofem::QDKTPlate, oofem::TR1_2D_SUPG2, oofem::IsotropicDamageMaterial1Status, oofem::StructuralInterfaceElement, oofem::FRCFCMNL, oofem::TR21_2D_SUPG, oofem::Quad1MindlinShell3D, oofem::IDNLMaterial, oofem::RCSDNLMaterial, oofem::CCTPlate, oofem::TR1_2D_PFEM, oofem::MazarsNLMaterial, oofem::TR1_2D_CBS, oofem::TR_SHELL01, oofem::TR_SHELL02, oofem::Tet1BubbleStokes, oofem::MisesMatNl, oofem::Tr1BubbleStokes, oofem::Tr21Stokes, oofem::Shell7Base, oofem::Tet21Stokes, oofem::RankineMatNl, oofem::LIBeam3d2, oofem::TrabBoneNLEmbed, oofem::Quad1Mindlin, oofem::TrabBoneNL3D, oofem::FRCFCMNLStatus, oofem::RankineMatGrad, oofem::IDNLMaterialStatus, oofem::TrabBoneNL, oofem::Hexa21Stokes, oofem::TrPlanestressRotAllman, oofem::TrabBoneGrad3D, oofem::MITC4Shell, oofem::RerShell, oofem::tet21ghostsolid, oofem::MisesMatGrad, oofem::MazarsNLMaterialStatus, oofem::Quad10_2D_SUPG, oofem::Beam2d, oofem::Quad1PlateSubSoil, oofem::Tria1PlateSubSoil, oofem::LineDistributedSpring, oofem::RCSDNLMaterialStatus, oofem::PFEMElement2d, oofem::Truss1d, oofem::Truss3d, oofem::Tr1Darcy, oofem::LIBeam3d, oofem::MisesMatNlStatus, oofem::RankineMatNlStatus, oofem::LinQuad3DPlaneStress, oofem::TrabBoneNLEmbedStatus, oofem::ConcreteFCMStatus, oofem::Line2BoundaryElement, oofem::QWedge_ht, oofem::InterfaceElem1d, oofem::Tr_Warp, oofem::Wedge_ht, oofem::LIBeam2d, oofem::TrPlaneStress2d, oofem::TrabBoneNL3DStatus, oofem::TrabBoneNLStatus, oofem::LTRSpace, oofem::QTRSpace, oofem::Axisymm3d, oofem::Brick1_ht, oofem::QBrick1_ht, oofem::LSpace, oofem::LIBeam2dNL, oofem::InterfaceElem2dQuad, oofem::Quad1_ht, oofem::Tr1_ht, oofem::TrPlaneStrain, oofem::Tetrah1_ht, oofem::InterfaceElem2dLin, oofem::QSpace, oofem::QWedge, oofem::InterfaceElement3dTrLin, oofem::Quad1PlaneStrain, oofem::PlaneStress2d, oofem::TrPlaneStress2dXFEM, oofem::IDGMaterial, oofem::Q4Axisymm, oofem::QTrPlaneStress2dXFEM, oofem::LWedge, oofem::QPlaneStrain, oofem::Q9PlaneStress2d, oofem::QPlaneStress2d, oofem::Tet1_3D_SUPG, oofem::Q27Space, oofem::L4Axisymm, oofem::QTrPlaneStrain, oofem::QTrPlaneStress2d, oofem::PlaneStress2dXfem, oofem::LargeStrainMasterMaterialGrad, and oofem::HydratingTransportMaterialStatus.

Definition at line 179 of file femcmpnn.h.

References oofem::errorInfo().

Referenced by oofem::PrimaryField::__evaluateAt(), oofem::RandomMaterialExtensionInterface::_generateStatusVariables(), oofem::Element::adaptiveFinish(), oofem::Element::adaptiveMap(), oofem::FailureCriteria::computeFailureCriteriaQuantities(), oofem::SPRNodalRecoveryModel::computePatch(), oofem::Quasicontinuum::computeStiffnessTensorOf1Link(), oofem::Quasicontinuum::createGlobalStiffnesMatrix(), oofem::SPRNodalRecoveryModel::determinePatchAssemblyPoints(), oofem::SPRNodalRecoveryModel::determinePatchType(), oofem::ZZErrorEstimator::estimateError(), oofem::LevelSetPCS::evalElemFContribution(), oofem::LevelSetPCS::evalElemfContribution(), oofem::VTKXMLExportModule::exportCompositeElement(), oofem::NonlocalMaterialWTP::fastElementIPNonlocTableUpdater(), oofem::LEPlic::findCellLineConstant(), oofem::RandomMaterialExtensionInterface::give(), oofem::WinklerMaterial::give3dBeamSubSoilStiffMtrx(), oofem::LargeStrainMasterMaterialGrad::give3dGprime(), oofem::LargeStrainMasterMaterialGrad::give3dKappaMatrix(), oofem::DummySpatialLocalizer::giveElementClosestToPoint(), oofem::OctreeSpatialLocalizer::giveElementClosestToPointWithinOctant(), oofem::OctreeSpatialLocalizer::giveElementContainingPoint(), oofem::ZZErrorEstimator::giveElementError(), oofem::LevelSetPCS::giveElementMaterialMixture(), oofem::LEPlic::giveElementMaterialMixture(), oofem::NonlocalMaterialWTP::giveElementNonlocalDepArry(), oofem::LargeStrainMasterMaterialGrad::giveFirstPKStressVectorGrad(), oofem::LayeredCrossSection::giveGeneralizedStress_Beam2d(), oofem::FiberedCrossSection::giveGeneralizedStress_Beam3d(), oofem::LayeredCrossSection::giveGeneralizedStress_Plate(), oofem::LayeredCrossSection::giveGeneralizedStress_Shell(), oofem::Line2BoundaryElement::giveInterface(), oofem::RankineMatNlStatus::giveInterface(), oofem::MisesMatNlStatus::giveInterface(), oofem::tet21ghostsolid::giveInterface(), oofem::Hexa21Stokes::giveInterface(), oofem::Tet21Stokes::giveInterface(), oofem::Shell7Base::giveInterface(), oofem::Tr21Stokes::giveInterface(), oofem::Tr1BubbleStokes::giveInterface(), oofem::Tet1BubbleStokes::giveInterface(), oofem::LargeStrainMasterMaterialGrad::giveInternalLength(), oofem::SimpleCrossSection::giveMaterialInterface(), oofem::LevelSetPCS::giveMaterialMixtureAt(), oofem::LEPlic::giveMaterialMixtureAt(), oofem::LayeredCrossSection::giveRealStress_PlaneStress(), 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().

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

Definition at line 107 of file femcmpnn.h.

Referenced by oofem::MMALeastSquareProjection::__init(), oofem::MMAShapeFunctProjection::__mapVariable(), oofem::Quasicontinuum::applyApproach2(), oofem::Quasicontinuum::applyApproach3(), oofem::NonlocalMaterialExtensionInterface::buildNonlocalPointTable(), oofem::Material::checkConsistency(), oofem::ConcreteFCM::checkSnapBack(), oofem::CompoDamageMat::checkSnapBack(), oofem::MPlasticMaterial::closestPointReturn(), oofem::MPlasticMaterial2::closestPointReturn(), oofem::Tr_Warp::computeBmatrixAt(), oofem::FreeWarping::computeCenterOfGravity(), oofem::Shell7BaseXFEM::computeCohesiveTangent(), oofem::MPSDamMaterial::computeDamageForCohesiveCrack(), oofem::IsotropicDamageMaterial1::computeDamageParamForCohesiveCrack(), oofem::PrescribedGradientBCPeriodic::computeDofTransformation(), oofem::TransportGradientPeriodic::computeDofTransformation(), oofem::SolutionbasedShapeFunction::computeDofTransformation(), oofem::Tr_Warp::computeEdgeLoadVectorAt(), oofem::Shell7BaseXFEM::computeFailureCriteriaQuantities(), oofem::PrescribedGradient::computeField(), oofem::PrescribedGenStrainShell7::computeField(), oofem::TransportGradientDirichlet::computeField(), oofem::MixedGradientPressureDirichlet::computeFields(), oofem::TR1_2D_CBS::computeMyVolume(), oofem::TR1_2D_SUPG2_AXI::computeMyVolume(), oofem::TR1_2D_SUPG2::computeMyVolume(), oofem::TR1_2D_SUPG::computeMyVolume(), oofem::FRCFCMNL::computeNonlocalStressInFibers(), oofem::FRCFCMNL::computeNonlocalStressInFibersInUncracked(), oofem::Concrete3::computeStrength(), oofem::RCSDEMaterial::computeStrength(), oofem::RCSDMaterial::computeStrength(), oofem::StructuralMaterial::computeStressIndependentStrainVector(), oofem::StructuralMaterial::computeStressIndependentStrainVector_3d(), oofem::FRCFCM::computeTempDamage(), oofem::TransportGradientDirichlet::computeXi(), oofem::FreemInterface::createInput(), oofem::T3DInterface::createInput(), oofem::MPlasticMaterial::cuttingPlaneReturn(), oofem::MPlasticMaterial2::cuttingPlaneReturn(), oofem::SPRNodalRecoveryModel::determinePatchAssemblyPoints(), oofem::Shell7BaseXFEM::discComputeBulkTangentMatrix(), oofem::CrackExportModule::doOutput(), oofem::MatlabExportModule::doOutputIntegrationPointFields(), oofem::Element::drawAnnotation(), oofem::Node::drawYourself(), errorInfo(), oofem::Dof::errorInfo(), oofem::HuertaRemeshingCriteria::estimateMeshDensities(), oofem::SmoothedNodalInternalVariableField::evaluateAt(), oofem::DofManValueField::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_AXI::formMaterialVolumePoly(), oofem::TR1_2D_SUPG2::formMaterialVolumePoly(), oofem::TR1_2D_SUPG::formMaterialVolumePoly(), oofem::TR1_2D_CBS::formMyVolumePoly(), oofem::TR1_2D_SUPG2_AXI::formMyVolumePoly(), oofem::TR1_2D_SUPG2::formMyVolumePoly(), oofem::TR1_2D_SUPG::formMyVolumePoly(), oofem::TR1_2D_CBS::formVolumeInterfacePoly(), oofem::TR1_2D_SUPG2_AXI::formVolumeInterfacePoly(), oofem::TR1_2D_SUPG2::formVolumeInterfacePoly(), oofem::TR1_2D_SUPG::formVolumeInterfacePoly(), oofem::VTKXMLExportModule::getCellVariableFromIS(), oofem::VTKExportModule::getDofManPrimaryVariable(), oofem::VTKXMLExportModule::getNodalVariableFromIS(), oofem::VTKXMLExportModule::getNodalVariableFromPrimaryField(), oofem::VTKXMLExportModule::getNodalVariableFromXFEMST(), oofem::TransportGradientDirichlet::give(), oofem::VariableCrossSection::give(), oofem::Material::give(), oofem::VTKXMLExportModule::giveCellType(), oofem::OctreeSpatialLocalizer::giveClosestIP(), oofem::OctreeSpatialLocalizer::giveClosestIPWithinOctant(), oofem::Shell7BaseXFEM::giveCZExportData(), oofem::MITC4Shell::giveDirectorVectors(), oofem::Node2NodeContactL::giveDofManagersToAppendTo(), oofem::Dof::giveDofManNumber(), oofem::VTKExportModule::giveElementCell(), oofem::VTKXMLExportModule::giveElementCell(), oofem::TR1_2D_CBS::giveElementCenter(), oofem::TR1_2D_SUPG2_AXI::giveElementCenter(), oofem::TR1_2D_SUPG2::giveElementCenter(), oofem::TR1_2D_SUPG::giveElementCenter(), oofem::OctreeSpatialLocalizer::giveElementContainingPoint(), oofem::ZZErrorEstimator::giveElementError(), oofem::HuertaErrorEstimator::giveElementError(), oofem::ConnectivityTable::giveElementNeighbourList(), oofem::VariableCrossSection::giveExpression(), oofem::AbaqusUserMaterial::giveFirstPKStressVector_3d(), oofem::Function::giveFunctionParameter(), oofem::Set::giveInputRecord(), giveInputRecord(), oofem::Element::giveInternalStateAtNode(), oofem::Quad10_2D_SUPG::giveIPValue(), oofem::StructuralInterfaceCrossSection::giveIPValue(), oofem::SimpleCrossSection::giveIPValue(), oofem::TR1_2D_SUPG::giveIPValue(), oofem::CrossSection::giveIPValue(), oofem::Material::giveIPValue(), oofem::StructuralMaterial::giveIPValue(), oofem::Element::giveIPValue(), oofem::RheoChainMaterial::giveLinearElasticMaterial(), oofem::PrescribedGradientBCPeriodic::giveMasterDof(), oofem::TransportGradientPeriodic::giveMasterDof(), oofem::MicroplaneMaterial::giveMicroplaneStatus(), oofem::Set::giveNodeList(), oofem::PlasticMaterial::giveRealStressVector(), oofem::CompoDamageMat::giveRealStressVector(), oofem::MDM::giveRealStressVector(), oofem::AbaqusUserMaterial::giveRealStressVector_3d(), oofem::Element::giveRegionNumber(), oofem::Shell7BaseXFEM::giveShellExportData(), oofem::ConcreteFCM::giveStatus(), oofem::Material::giveStatus(), oofem::IsotropicDamageMaterial1::giveStatus(), oofem::LatticeDamage2d::giveStatus(), oofem::MisesMat::giveTemperature(), oofem::SimpleCrossSection::giveTemperatureVector(), oofem::TwoFluidMaterial::giveTempVOF(), oofem::PrescribedGradientBCPeriodic::giveUnknown(), oofem::TransportGradientPeriodic::giveUnknown(), oofem::DruckerPragerPlasticitySM::giveVertexAlgorithmicStiffMatrix(), oofem::Quasicontinuum::initializeConnectivityTableForInterpolationElements(), oofem::SymmetryBarrier::initializeFrom(), oofem::HydratingHeMoMaterial::initializeFrom(), oofem::IntElLine1::initializeFrom(), oofem::CohesiveSurface3d::initializeFrom(), oofem::HydratingIsoHeatMaterial::initializeFrom(), oofem::OrthotropicLinearElasticMaterial::initializeFrom(), oofem::WeakPeriodicBoundaryCondition::initializeFrom(), oofem::Node::initializeFrom(), oofem::SolutionbasedShapeFunction::initializeSurfaceData(), oofem::ListBasedEI::initiateFronts(), oofem::CemhydMat::initMaterial(), oofem::QuasicontinuumVTKXMLExportModule::initRegionNodeNumbering(), oofem::NodalRecoveryModel::initRegionNodeNumbering(), oofem::VTKXMLExportModule::initRegionNodeNumbering(), oofem::ConnectivityTable::instanciateConnectivityTable(), oofem::Delamination::instanciateYourself(), oofem::LEPlicElementInterface::isBoundary(), oofem::QClinearStatic::isElementActivated(), oofem::TR21_2D_SUPG::LS_PCS_computeVOFFractions(), oofem::Element::mapStateVariables(), oofem::MMAShapeFunctProjection::mapVariable(), oofem::LoadBalancer::migrateLoad(), oofem::MixedGradientPressureDirichlet::MixedGradientPressureDirichlet(), oofem::MDM::MMI_map(), oofem::IsotropicDamageMaterial1::MMI_map(), oofem::Material::modifyProperty(), oofem::QClinearStatic::nodeInFullSolvedDomainTest(), oofem::GnuplotExportModule::outputBoundaryCondition(), oofem::GnuplotExportModule::outputXFEM(), oofem::HangingNode::postInitialize(), oofem::RigidArmNode::postInitialize(), oofem::qcNode::postInitializeAsHangingNode(), oofem::PrescribedGradientBCPeriodic::PrescribedGradientBCPeriodic(), oofem::CompoDamageMatStatus::printOutputAt(), oofem::PFEMElement::printOutputAt(), oofem::NodalSpringElement::printOutputAt(), oofem::LineDistributedSpring::printOutputAt(), oofem::LinQuad3DPlaneStress::printOutputAt(), oofem::TR_SHELL02::printOutputAt(), oofem::TR_SHELL01::printOutputAt(), oofem::qcNode::printOutputAt(), oofem::SpringElement::printOutputAt(), oofem::TrPlanestressRotAllman3d::printOutputAt(), oofem::TrPlaneStrRot3d::printOutputAt(), oofem::CCTPlate3d::printOutputAt(), oofem::Beam2d::printOutputAt(), oofem::DKTPlate3d::printOutputAt(), oofem::Beam3d::printOutputAt(), oofem::CemhydMatStatus::printOutputAt(), oofem::DofManager::printOutputAt(), oofem::Element::printOutputAt(), oofem::MasterDof::printYourself(), oofem::Dof::printYourself(), oofem::Delamination::propagateFronts(), oofem::PLCZdamageRadius::propagateInterface(), oofem::NodalAveragingRecoveryModel::recoverValues(), oofem::ZZNodalRecoveryModel::recoverValues(), oofem::RefinedMesh::refineMeshGlobally(), oofem::ParticleTopologyDescription::replaceFEMesh(), oofem::HuertaErrorEstimatorInterface::setupRefinedElementProblem1D(), oofem::HuertaErrorEstimatorInterface::setupRefinedElementProblem2D(), oofem::HuertaErrorEstimatorInterface::setupRefinedElementProblem3D(), oofem::FreemInterface::smoothNodalDensities(), oofem::HuertaErrorEstimator::solveRefinedPatchProblem(), oofem::Q27Space::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::LWedge::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::Quad1PlaneStrain::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::PlaneStress2d::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::L4Axisymm::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::QSpace::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::QWedge::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::QBrick1_ht::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::TrPlaneStrain::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::LSpace::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::Brick1_ht::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::QTRSpace::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::Quad2PlateSubSoil::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::QTrPlaneStress2d::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::QTrPlaneStrain::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::Wedge_ht::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::QWedge_ht::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::Axisymm3d::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::LTRSpace::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::TrPlaneStress2d::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::MITC4Shell::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::Quad1PlateSubSoil::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::Tria1PlateSubSoil::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::LineDistributedSpring::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::Quad1Mindlin::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::Quad1MindlinShell3D::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::TR1_2D_SUPG2_AXI::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::CCTPlate::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::QDKTPlate::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::TR1_2D_CBS::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::TR1_2D_SUPG2::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::DKTPlate::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::TR1_2D_SUPG::SPRNodalRecoveryMI_giveDofMansDeterminedByPatch(), oofem::Q27Space::SPRNodalRecoveryMI_giveSPRAssemblyPoints(), oofem::LWedge::SPRNodalRecoveryMI_giveSPRAssemblyPoints(), oofem::Quad1PlaneStrain::SPRNodalRecoveryMI_giveSPRAssemblyPoints(), oofem::PlaneStress2d::SPRNodalRecoveryMI_giveSPRAssemblyPoints(), oofem::QWedge::SPRNodalRecoveryMI_giveSPRAssemblyPoints(), oofem::L4Axisymm::SPRNodalRecoveryMI_giveSPRAssemblyPoints(), oofem::QSpace::SPRNodalRecoveryMI_giveSPRAssemblyPoints(), oofem::QBrick1_ht::SPRNodalRecoveryMI_giveSPRAssemblyPoints(), oofem::TrPlaneStrain::SPRNodalRecoveryMI_giveSPRAssemblyPoints(), oofem::LSpace::SPRNodalRecoveryMI_giveSPRAssemblyPoints(), oofem::Brick1_ht::SPRNodalRecoveryMI_giveSPRAssemblyPoints(), oofem::QTRSpace::SPRNodalRecoveryMI_giveSPRAssemblyPoints(), oofem::Quad2PlateSubSoil::SPRNodalRecoveryMI_giveSPRAssemblyPoints(), oofem::QTrPlaneStress2d::SPRNodalRecoveryMI_giveSPRAssemblyPoints(), oofem::QTrPlaneStrain::SPRNodalRecoveryMI_giveSPRAssemblyPoints(), oofem::Wedge_ht::SPRNodalRecoveryMI_giveSPRAssemblyPoints(), oofem::QWedge_ht::SPRNodalRecoveryMI_giveSPRAssemblyPoints(), oofem::Axisymm3d::SPRNodalRecoveryMI_giveSPRAssemblyPoints(), oofem::LTRSpace::SPRNodalRecoveryMI_giveSPRAssemblyPoints(), oofem::TrPlaneStress2d::SPRNodalRecoveryMI_giveSPRAssemblyPoints(), oofem::MITC4Shell::SPRNodalRecoveryMI_giveSPRAssemblyPoints(), oofem::Tria1PlateSubSoil::SPRNodalRecoveryMI_giveSPRAssemblyPoints(), oofem::Quad1PlateSubSoil::SPRNodalRecoveryMI_giveSPRAssemblyPoints(), oofem::LineDistributedSpring::SPRNodalRecoveryMI_giveSPRAssemblyPoints(), oofem::Quad1Mindlin::SPRNodalRecoveryMI_giveSPRAssemblyPoints(), oofem::Quad1MindlinShell3D::SPRNodalRecoveryMI_giveSPRAssemblyPoints(), oofem::TR1_2D_SUPG2_AXI::SPRNodalRecoveryMI_giveSPRAssemblyPoints(), oofem::CCTPlate::SPRNodalRecoveryMI_giveSPRAssemblyPoints(), oofem::QDKTPlate::SPRNodalRecoveryMI_giveSPRAssemblyPoints(), oofem::TR1_2D_CBS::SPRNodalRecoveryMI_giveSPRAssemblyPoints(), oofem::TR1_2D_SUPG2::SPRNodalRecoveryMI_giveSPRAssemblyPoints(), oofem::DKTPlate::SPRNodalRecoveryMI_giveSPRAssemblyPoints(), oofem::TR1_2D_SUPG::SPRNodalRecoveryMI_giveSPRAssemblyPoints(), oofem::T3DInterface::t3d_2_OOFEM(), oofem::oofegGraphicContext::testElementGraphicActivity(), oofem::QClinearStatic::transformMeshToParticles(), oofem::TransportGradientPeriodic::TransportGradientPeriodic(), oofem::TwoFluidMaterialStatus::TwoFluidMaterialStatus(), oofem::FreeWarping::updateComputedResults(), oofem::HydratingHeMoMaterial::updateInternalState(), oofem::HydratingIsoHeatMaterial::updateInternalState(), oofem::ListBasedEI::updateNodeEnrMarker(), oofem::RCM2Material::updateStatusForNewCrack(), oofem::VTKXMLExportModule::writeXFEMVars(), oofem::Shell7Base::ZZNodalRecoveryMI_ComputeEstimatedInterpolationMtrx(), and oofem::Tr_Warp::ZZNodalRecoveryMI_computeNNMatrix().

IRResultType 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.

See also
IR_GIVE_FIELD
IR_GIVE_OPTIONAL_FIELD
Parameters
irInput record to initialize from.
Returns
IRResultType

Reimplemented in oofem::Element, oofem::ConcreteDPM2, oofem::ConcreteDPM, oofem::DustMaterial, oofem::DofManager, oofem::LatticeDamage2d, oofem::HuertaRemeshingCriteria, oofem::StructuralElement, oofem::AnisotropicDamageMaterial, oofem::MDM, oofem::CrossSection, oofem::MPSMaterial, oofem::IsotropicDamageMaterial1, oofem::IsotropicDamageMaterial, oofem::MPSDamMaterial, oofem::DruckerPragerPlasticitySM, oofem::TrabBone3D, oofem::HydrationModel, oofem::RheoChainMaterial, oofem::NLStructuralElement, oofem::Concrete2, oofem::Material, oofem::ZZRemeshingCriteria, oofem::FCMMaterial, oofem::IntMatBilinearCZFagerstrom, oofem::AbaqusUserElement, oofem::IntMatBilinearCZJansson, oofem::RCM2Material, oofem::LatticeTransportMaterial, oofem::LEPlic, oofem::NURBSSpace3dElement, oofem::MicroplaneMaterial, oofem::Eurocode2CreepMaterial, oofem::IsoInterfaceDamageMaterial_2, oofem::Node, oofem::Shell7BaseXFEM, oofem::Load, oofem::Beam3d, oofem::FiberedCrossSection, oofem::HuertaErrorEstimator, oofem::IntMatIsoDamage, oofem::GeneralBoundaryCondition, oofem::WeakPeriodicBoundaryCondition, oofem::SteelRelaxMat, oofem::NlIsoMoistureMaterial, oofem::IsoInterfaceDamageMaterial, oofem::PerfectlyPlasticMaterial, oofem::LevelSetPCS, oofem::BoundaryLoad, oofem::RankineMat, oofem::ErrorEstimator, oofem::TSplinePlaneStressElement, oofem::CompoDamageMat, oofem::TrabBoneMaterial, oofem::FE2FluidMaterial, oofem::InitialCondition, oofem::MITC4Shell, oofem::IntMatCoulombContact, oofem::SimpleCrossSection, oofem::MixedGradientPressureNeumann, oofem::Shell7Base, oofem::CebFipSlip90Material, oofem::StructuralInterfaceMaterial, oofem::StructuralMaterial, oofem::MaterialStatus, oofem::Beam2d, oofem::BondCEBMaterial, oofem::IntMatBilinearCZ, oofem::AbaqusUserMaterial, oofem::StructuralInterfaceElement, oofem::B3SolidMaterial, oofem::StructuralFE2Material, oofem::OrthotropicLinearElasticMaterial, oofem::BinghamFluidMaterial2, oofem::DKTPlate, oofem::RCSDMaterial, oofem::RCSDEMaterial, oofem::CemhydMat, oofem::SolutionbasedShapeFunction, oofem::IntMatBilinearCZElastic, oofem::TR1_2D_SUPG, oofem::IGATSplineElement, oofem::TrabBoneEmbed, oofem::ExpCZMaterial, oofem::MixedGradientPressureDirichlet, oofem::PrescribedGradientBCWeak, oofem::ZZErrorEstimator, oofem::RCSDNLMaterial, oofem::HeMoKunzelMaterial, oofem::QDKTPlate, oofem::TR1_2D_SUPG2, oofem::BoundaryCondition, oofem::IDNLMaterial, oofem::MixedGradientPressureWeakPeriodic, oofem::FRCFCM, oofem::MazarsMaterial, oofem::VariableCrossSection, oofem::SimpleInterfaceMaterial, oofem::IsotropicLinearElasticMaterial, oofem::M4Material, oofem::NonlinearFluidMaterial, oofem::LayeredCrossSection, oofem::RerShell, oofem::M1Material, oofem::FRCFCMNL, oofem::MazarsNLMaterial, oofem::RVEStokesFlow, oofem::TR1_2D_PFEM, oofem::SpringElement, oofem::EnrichmentItem, oofem::LatticeMaterialStatus, oofem::CombinedZZSIRemeshingCriteria, oofem::HeMoTKMaterial, oofem::Lattice2d_mt, oofem::CCTPlate, oofem::DruckerPragerCutMat, oofem::Masonry02, oofem::TR1_2D_CBS, oofem::ConcreteFCM, oofem::B3Material, oofem::Lattice2d, oofem::IntMatIsoDamageTable, oofem::MisesMatNl, oofem::IGAElement, oofem::PrescribedGenStrainShell7, oofem::NURBSPlaneStressElement, oofem::Quad1MindlinShell3D, oofem::StructuralPythonMaterial, oofem::NodalSpringElement, oofem::IntMatPhaseField, oofem::MisesMat, oofem::Truss2d, oofem::TrPlaneStress2dXFEM, oofem::RankineMatNl, oofem::HydratingIsoHeatMaterial, oofem::UserDefDirichletBC, oofem::DirectErrorIndicatorRC, oofem::TrabBoneNLEmbed, oofem::TrPlaneStrain, oofem::MicroMaterial, oofem::RankineMatGrad, oofem::HeMoBazNajMaterial, oofem::TR1_2D_SUPG2_AXI, oofem::TrabBoneNL3D, oofem::PythonExpression, oofem::LinearConstraintBC, oofem::RigidArmNode, oofem::LSpace, oofem::Truss3d, oofem::Quad1PlaneStrain, oofem::PlaneStress2d, oofem::PlaneStress2dXfem, oofem::TrabBoneNL, oofem::TransportGradientDirichlet, oofem::MeshQualityErrorEstimator, oofem::TrabBoneGrad3D, oofem::IntMatBilinearCZFagerstromRate, oofem::PrescribedGenStrainShell7, oofem::Axisymm3d, oofem::LIBeam3dNL, oofem::LumpedMassElement, oofem::QTrPlaneStress2dXFEM, oofem::PointLoad, oofem::UserDefinedTemperatureField, oofem::CohesiveInterfaceMaterial, oofem::MisesMatGrad, oofem::NodalLoad, oofem::PolylineNonlocalBarrier, oofem::IsotropicHeatTransferMaterial, oofem::LIBeam3dNL2, oofem::InterfaceElem1d, oofem::IntegrationPointStatus, oofem::NeumannMomentLoad, oofem::qcNode, oofem::TrPlanestressRotAllman, oofem::TR_SHELL01, oofem::ForeignTemperatureFieldLoad, oofem::WinklerMaterial, oofem::HydratingConcreteMat, oofem::NonlinearMassTransferMaterial, oofem::Set, oofem::LIBeam2d, oofem::TR_SHELL02, oofem::TransportGradientPeriodic, oofem::HangingNode, oofem::PrescribedGradient, oofem::CohesiveSurface3d, oofem::Quad1Mindlin, oofem::Structural2DElement, oofem::PFEMElement2d, oofem::LIBeam2dNL, oofem::InterfaceElem2dQuad, oofem::WinklerPasternakMaterial, oofem::BazantNajjarMoistureTransferMaterial, oofem::ConstantSurfaceLoad, oofem::MixedGradientPressureBC, oofem::Reinforcement, oofem::EnrichmentFunction, oofem::SolidShell, oofem::ConstantPressureLoad, oofem::Delamination, oofem::CalculatorFunction, oofem::InterfaceElem2dLin, oofem::IntElLine1, oofem::TrPlaneStrRot, oofem::MooneyRivlinMaterial, oofem::PrescribedMean, oofem::InterfaceElement3dTrLin, oofem::AnisotropicLinearElasticMaterial, oofem::MaxwellChainMaterial, oofem::HydratingHeMoMaterial, oofem::PrescribedGradientBCPeriodic, oofem::IntElPoint, oofem::SimpleVitrificationMaterial, oofem::LinearEdgeLoad, oofem::IntElSurfTr1, oofem::LargeStrainMasterMaterial, oofem::KelvinChainSolidMaterial, oofem::SymmetryBarrier, oofem::Quad10_2D_SUPG, oofem::PeriodicPiecewiseLinFunction, oofem::RotatingBoundary, oofem::PFEMParticle, oofem::StructuralInterfaceCrossSection, oofem::LIBeam3d2, oofem::LineDistributedSpring, oofem::QTrPlaneStress2d, oofem::Quad1PlateSubSoil, oofem::Tria1PlateSubSoil, oofem::IntElLine1PF, oofem::KelvinChainMaterial, oofem::NewtonianFluidMaterial, oofem::ScalarErrorIndicator, oofem::GravityPressure, oofem::QWedge_ht, oofem::SUPGElement, oofem::ActiveBoundaryCondition, oofem::ElementSide, oofem::SlaveNode, oofem::IntElLine1PhF, oofem::CombinedZZSIErrorEstimator, oofem::LinearElasticMaterial, oofem::Wedge_ht, oofem::InteractionPFEMParticle, oofem::PFEMElement, oofem::InteractionLoad, oofem::ConstantFunction, oofem::LocalGaussianRandomFunction, oofem::SurfaceTensionBoundaryCondition, oofem::QTRSpace, oofem::Q4Axisymm, oofem::IntMatDummyCZ, oofem::CebFip78Material, oofem::TwoFluidMaterial, oofem::HeavisideTimeFunction, oofem::L4Axisymm, oofem::Quad2PlateSubSoil, oofem::Concrete3, oofem::TutorialMaterial, oofem::Brick1_ht, oofem::QBrick1_ht, oofem::ElementDofManager, oofem::Structural3DElement, oofem::IntMatElastic, oofem::Particle, oofem::IsotropicLinMoistureTransferMaterial, oofem::IsotropicMoistureTransferMaterial, oofem::TransportGradientNeumann, oofem::ConstantEdgeLoad, oofem::Tr_Warp, oofem::AnisotropicMassTransferMaterial, oofem::Quad1_ht, oofem::SimpleTransportCrossSection, oofem::Tetrah1_ht, oofem::Tr1_ht, oofem::InterpolatingFuction, oofem::PeakFunction, oofem::Inclusion, oofem::MacroLSpace, oofem::QSpace, oofem::IDGMaterial, oofem::J2Mat, oofem::J2MPlasticMaterial, oofem::J2plasticMaterial, oofem::DoublePowerLawMaterial, oofem::StructuralMaterialSettable, oofem::CBSElement, oofem::QWedge, oofem::FluidCrossSection, oofem::PiecewiseLinFunction, oofem::LWedge, oofem::PrescribedGradientBCNeumann, oofem::Q27Space, oofem::QTruss1dGrad, oofem::HTSelement, oofem::BsplinePlaneStressElement, oofem::IntElLine2, oofem::TF1, oofem::RankinePlasticMaterial, oofem::ShellCrack, oofem::SUPGElement2, oofem::WarpingCrossSection, oofem::LIBeam3d, oofem::HyperElasticMaterial, oofem::Crack, oofem::QSpaceGrad, oofem::LargeStrainMasterMaterialGrad, oofem::DummyMaterial, oofem::QTRSpaceGrad, oofem::QWedgeGrad, oofem::IntElLine2IntPen, oofem::LatticeStructuralElement, oofem::Steel1, oofem::Tr1Darcy, oofem::QTruss1d, oofem::CoupledFieldsElement, oofem::LatticeTransportElement, oofem::QPlaneStrainGrad, oofem::QPlaneStressGrad, oofem::QTrPlaneStressGrad, oofem::QTrPlaneStrainGrad, oofem::PrescribedGradientBCWeakDirichlet, and oofem::PrescribedGradientBCWeakPeriodic.

Definition at line 89 of file femcmpnn.C.

References oofem::IRRT_OK.

Referenced by oofem::MacroLSpace::changeMicroBoundaryConditions(), oofem::Subdivision::createMesh(), oofem::PiecewiseLinFunction::initializeFrom(), oofem::PeakFunction::initializeFrom(), oofem::HeavisideTimeFunction::initializeFrom(), oofem::ConstantFunction::initializeFrom(), oofem::CombinedZZSIErrorEstimator::initializeFrom(), oofem::ScalarErrorIndicator::initializeFrom(), oofem::CalculatorFunction::initializeFrom(), oofem::Set::initializeFrom(), oofem::PythonExpression::initializeFrom(), oofem::ZZErrorEstimator::initializeFrom(), oofem::HuertaErrorEstimator::initializeFrom(), and oofem::T3DInterface::t3d_2_OOFEM().

virtual void oofem::FEMComponent::printOutputAt ( FILE *  file,
TimeStep tStep 
)
inlinevirtual

Prints output of receiver to stream, for given time step.

This is used for output into the standard output file.

Parameters
fileFile pointer to print to.
tStepTime step to write for.

Reimplemented in oofem::Element, oofem::DofManager, oofem::RankineMatStatus, oofem::MisesMatStatus, oofem::SteelRelaxMatStatus, oofem::AbaqusUserMaterialStatus, oofem::LatticeDamage2dStatus, oofem::ConcreteDPM2Status, oofem::TR1_2D_SUPG, oofem::CemhydMatStatus, oofem::TR1_2D_SUPG2, oofem::Beam3d, oofem::ConcreteDPMStatus, oofem::HydratingConcreteMatStatus, oofem::TR1_2D_CBS, oofem::MPSDamMaterialStatus, oofem::HydrationModelStatus, oofem::DKTPlate3d, oofem::MDMStatus, oofem::Beam2d, oofem::MITC4Shell, oofem::CCTPlate3d, oofem::LargeStrainMasterMaterialStatus, oofem::TrabBone3DStatus, oofem::TrPlaneStrRot3d, oofem::FE2FluidMaterialStatus, oofem::DustMaterialStatus, oofem::Concrete2MaterialStatus, oofem::RCM2MaterialStatus, oofem::IntMatBilinearCZFagerstromStatus, oofem::AnisotropicDamageMaterialStatus, oofem::IntMatBilinearCZJanssonStatus, oofem::TwoFluidMaterialStatus, oofem::TrPlanestressRotAllman3d, oofem::SpringElement, oofem::TR1_2D_SUPG2_AXI, oofem::qcNode, oofem::IsotropicDamageMaterialStatus, oofem::MPlasticMaterial2Status, oofem::StructuralInterfaceMaterialStatus, oofem::FCMMaterialStatus, oofem::PFEMParticle, oofem::MaterialStatus, oofem::TR_SHELL01, oofem::DruckerPragerPlasticitySMStatus, oofem::TR_SHELL02, oofem::StructuralMaterialStatus, oofem::LinQuad3DPlaneStress, oofem::RheoChainMaterialStatus, oofem::LineDistributedSpring, oofem::FRCFCMStatus, oofem::NodalSpringElement, oofem::MPlasticMaterialStatus, oofem::PFEMElement, oofem::FRCFCMNLStatus, oofem::InteractionPFEMParticle, oofem::RerShell, oofem::Shell7Base, oofem::TrabBoneMaterialStatus, oofem::LatticeTransportMaterialStatus, oofem::M1MaterialStatus, oofem::IsoInterfaceDamageMaterialStatus_2, oofem::BinghamFluidMaterial2Status, oofem::IntMatIsoDamageStatus, oofem::RCSDMaterialStatus, oofem::CompoDamageMatStatus, oofem::IsoInterfaceDamageMaterialStatus, oofem::RCSDEMaterialStatus, oofem::ConcreteFCMStatus, oofem::PerfectlyPlasticMaterialStatus, oofem::PlasticMaterialStatus, oofem::IDNLMaterialStatus, oofem::BondCEBMaterialStatus, oofem::MicroMaterialStatus, oofem::TransportMaterialStatus, oofem::TrabBoneEmbedStatus, oofem::CebFipSlip90MaterialStatus, oofem::IntegrationPointStatus, oofem::IntMatCoulombContactStatus, oofem::RCSDNLMaterialStatus, oofem::FluidDynamicMaterialStatus, oofem::SimpleInterfaceMaterialStatus, oofem::IntMatBilinearCZElasticStatus, oofem::HydratingTransportMaterialStatus, oofem::TrabBoneNLEmbedStatus, oofem::ExpCZMaterialStatus, oofem::MisesMatNlStatus, oofem::TrabBoneNL3DStatus, oofem::MazarsNLMaterialStatus, oofem::RankineMatGradStatus, oofem::TrabBoneGrad3DStatus, oofem::TrabBoneNLStatus, oofem::RankineMatNlStatus, oofem::MisesMatGradStatus, oofem::LatticeMaterialStatus, oofem::KelvinChainMaterialStatus, oofem::KelvinChainSolidMaterialStatus, and oofem::MaxwellChainMaterialStatus.

Definition at line 171 of file femcmpnn.h.

Referenced by oofem::MisesMatStatus::givePlasDef(), oofem::RankineMatStatus::givePlasDef(), oofem::SteelRelaxMatStatus::givePrestress(), oofem::AbaqusUserMaterialStatus::letTempTangentBe(), oofem::LargeStrainMasterMaterialStatus::setTransformationMatrix(), and oofem::TwoFluidMaterialStatus::~TwoFluidMaterialStatus().

contextIOResultType oofem::FEMComponent::restoreContext ( DataStream stream,
ContextMode  mode,
void *  obj = NULL 
)
virtual

Restores the receiver state previously written in stream.

See also
saveContext
Parameters
streamInput stream.
modeDetermines amount of info available in stream (state, definition, ...).
objSpecial parameter for sending extra information.
Returns
contextIOResultType.
Exceptions
throwsan ContextIOERR exception if error encountered.

Reimplemented in oofem::Element, oofem::DofManager, oofem::RankineMatStatus, oofem::LatticeDamage2dStatus, oofem::MisesMatStatus, oofem::SteelRelaxMatStatus, oofem::Node, oofem::ConcreteDPM2Status, oofem::FCMMaterialStatus, oofem::HuertaErrorEstimator, oofem::LevelSetPCS, oofem::GeneralBoundaryCondition, oofem::AnisotropicDamageMaterialStatus, oofem::RCM2MaterialStatus, oofem::Set, oofem::TrabBone3DStatus, oofem::IsotropicDamageMaterialStatus, oofem::ConcreteDPMStatus, oofem::MPSDamMaterialStatus, oofem::MDMStatus, oofem::Concrete2MaterialStatus, oofem::HydrationModelStatus, oofem::LargeStrainMasterMaterialStatus, oofem::TR1_2D_SUPG, oofem::MPSMaterialStatus, oofem::BoundaryCondition, oofem::TR1_2D_SUPG2, oofem::TR1_2D_PFEM, oofem::Lattice2d, oofem::IDGMaterialStatus, oofem::FE2FluidMaterialStatus, oofem::CompoDamageMatStatus, oofem::TR1_2D_CBS, oofem::LinearConstraintBC, oofem::LIBeam3d2, oofem::DustMaterialStatus, oofem::TrabBoneMaterialStatus, oofem::RheoChainMaterialStatus, oofem::TwoFluidMaterialStatus, oofem::RCSDMaterialStatus, oofem::RCSDEMaterialStatus, oofem::MPlasticMaterial2Status, oofem::StructuralInterfaceMaterialStatus, oofem::LIBeam3dNL2, oofem::FRCFCMStatus, oofem::StructuralMaterialStatus, oofem::DruckerPragerPlasticitySMStatus, oofem::TR_SHELL01, oofem::FRCFCMNLStatus, oofem::IsoInterfaceDamageMaterialStatus_2, oofem::TR_SHELL02, oofem::IntMatIsoDamageStatus, oofem::IsoInterfaceDamageMaterialStatus, oofem::MPlasticMaterialStatus, oofem::StructuralFE2MaterialStatus, oofem::TrabBoneEmbedStatus, oofem::BondCEBMaterialStatus, oofem::IDNLMaterialStatus, oofem::CebFipSlip90MaterialStatus, oofem::RCSDNLMaterialStatus, oofem::ConcreteFCMStatus, oofem::Quad10_2D_SUPG, oofem::MazarsMaterialStatus, oofem::BinghamFluidMaterial2Status, oofem::SimpleInterfaceMaterialStatus, oofem::M1MaterialStatus, oofem::TR21_2D_SUPG, oofem::MisesMatNlStatus, oofem::PerfectlyPlasticMaterialStatus, oofem::RankineMatNlStatus, oofem::TrabBoneNLEmbedStatus, oofem::MazarsNLMaterialStatus, oofem::PlasticMaterialStatus, oofem::TransportMaterialStatus, oofem::IntMatCoulombContactStatus, oofem::MicroMaterialStatus, oofem::Eurocode2CreepMaterialStatus, oofem::RVEStokesFlowMaterialStatus, oofem::M4MaterialStatus, oofem::FluidDynamicMaterialStatus, oofem::PiecewiseLinFunction, oofem::B3SolidMaterialStatus, oofem::KelvinChainMaterialStatus, oofem::KelvinChainSolidMaterialStatus, and oofem::MaxwellChainMaterialStatus.

Definition at line 64 of file femcmpnn.C.

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

Referenced by oofem::IDGMaterialStatus::giveClassName(), oofem::MisesMatStatus::givePlasDef(), oofem::RankineMatStatus::givePlasDef(), oofem::SteelRelaxMatStatus::givePrestress(), oofem::FluidDynamicMaterialStatus::restoreContext(), oofem::TransportMaterialStatus::restoreContext(), oofem::StructuralMaterialStatus::restoreContext(), oofem::StructuralInterfaceMaterialStatus::restoreContext(), oofem::TwoFluidMaterialStatus::restoreContext(), oofem::Set::restoreContext(), oofem::HuertaErrorEstimator::restoreContext(), oofem::XfemManager::restoreContext(), oofem::DofManager::restoreContext(), oofem::Element::restoreContext(), oofem::MicroplaneMaterial::restoreIPContext(), oofem::Material::restoreIPContext(), oofem::LargeStrainMasterMaterialStatus::setTransformationMatrix(), and oofem::TwoFluidMaterialStatus::~TwoFluidMaterialStatus().

contextIOResultType oofem::FEMComponent::saveContext ( DataStream stream,
ContextMode  mode,
void *  obj = NULL 
)
virtual

Stores receiver state to output stream.

Parameters
streamOutput stream.
modeDetermines amount of info required in stream (state, definition, ...).
objSpecial parameter, used only to send particular integration point to material class version of this method.
Returns
contextIOResultType.
Exceptions
throwsan ContextIOERR exception if error encountered.

Reimplemented in oofem::Element, oofem::DofManager, oofem::RankineMatStatus, oofem::LatticeDamage2dStatus, oofem::MisesMatStatus, oofem::SteelRelaxMatStatus, oofem::Node, oofem::ConcreteDPM2Status, oofem::FCMMaterialStatus, oofem::HuertaErrorEstimator, oofem::LevelSetPCS, oofem::GeneralBoundaryCondition, oofem::AnisotropicDamageMaterialStatus, oofem::RCM2MaterialStatus, oofem::Set, oofem::TrabBone3DStatus, oofem::IsotropicDamageMaterialStatus, oofem::ConcreteDPMStatus, oofem::MPSDamMaterialStatus, oofem::MDMStatus, oofem::Concrete2MaterialStatus, oofem::HydrationModelStatus, oofem::LargeStrainMasterMaterialStatus, oofem::TR1_2D_SUPG, oofem::MPSMaterialStatus, oofem::BoundaryCondition, oofem::TR1_2D_SUPG2, oofem::TR1_2D_PFEM, oofem::Lattice2d, oofem::IDGMaterialStatus, oofem::FE2FluidMaterialStatus, oofem::CompoDamageMatStatus, oofem::TR1_2D_CBS, oofem::LinearConstraintBC, oofem::LIBeam3d2, oofem::DustMaterialStatus, oofem::TrabBoneMaterialStatus, oofem::RheoChainMaterialStatus, oofem::TwoFluidMaterialStatus, oofem::RCSDMaterialStatus, oofem::RCSDEMaterialStatus, oofem::MPlasticMaterial2Status, oofem::StructuralInterfaceMaterialStatus, oofem::LIBeam3dNL2, oofem::FRCFCMStatus, oofem::StructuralMaterialStatus, oofem::DruckerPragerPlasticitySMStatus, oofem::TR_SHELL01, oofem::FRCFCMNLStatus, oofem::IsoInterfaceDamageMaterialStatus_2, oofem::TR_SHELL02, oofem::IntMatIsoDamageStatus, oofem::IsoInterfaceDamageMaterialStatus, oofem::MPlasticMaterialStatus, oofem::StructuralFE2MaterialStatus, oofem::TrabBoneEmbedStatus, oofem::BondCEBMaterialStatus, oofem::IDNLMaterialStatus, oofem::CebFipSlip90MaterialStatus, oofem::RCSDNLMaterialStatus, oofem::ConcreteFCMStatus, oofem::Quad10_2D_SUPG, oofem::MazarsMaterialStatus, oofem::BinghamFluidMaterial2Status, oofem::SimpleInterfaceMaterialStatus, oofem::M1MaterialStatus, oofem::TR21_2D_SUPG, oofem::MisesMatNlStatus, oofem::PerfectlyPlasticMaterialStatus, oofem::RankineMatNlStatus, oofem::TrabBoneNLEmbedStatus, oofem::MazarsNLMaterialStatus, oofem::PlasticMaterialStatus, oofem::TransportMaterialStatus, oofem::IntMatCoulombContactStatus, oofem::MicroMaterialStatus, oofem::Eurocode2CreepMaterialStatus, oofem::RVEStokesFlowMaterialStatus, oofem::M4MaterialStatus, oofem::FluidDynamicMaterialStatus, oofem::PiecewiseLinFunction, oofem::B3SolidMaterialStatus, oofem::KelvinChainMaterialStatus, oofem::KelvinChainSolidMaterialStatus, and oofem::MaxwellChainMaterialStatus.

Definition at line 51 of file femcmpnn.C.

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

Referenced by oofem::IDGMaterialStatus::giveClassName(), oofem::MisesMatStatus::givePlasDef(), oofem::RankineMatStatus::givePlasDef(), oofem::SteelRelaxMatStatus::givePrestress(), oofem::FluidDynamicMaterialStatus::saveContext(), oofem::TransportMaterialStatus::saveContext(), oofem::StructuralMaterialStatus::saveContext(), oofem::StructuralInterfaceMaterialStatus::saveContext(), oofem::TwoFluidMaterialStatus::saveContext(), oofem::LargeStrainMasterMaterialStatus::saveContext(), oofem::Set::saveContext(), oofem::HuertaErrorEstimator::saveContext(), oofem::XfemManager::saveContext(), oofem::DofManager::saveContext(), oofem::Element::saveContext(), oofem::MicroplaneMaterial::saveIPContext(), oofem::Material::saveIPContext(), oofem::LargeStrainMasterMaterialStatus::setTransformationMatrix(), and oofem::TwoFluidMaterialStatus::~TwoFluidMaterialStatus().

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

Sets number of receiver.

Parameters
numNew number of receiver.

Definition at line 112 of file femcmpnn.h.

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::Element, oofem::DofManager, oofem::Beam3d, oofem::Set, oofem::TR_SHELL01, oofem::TR_SHELL02, oofem::RigidArmNode, and oofem::SlaveNode.

Definition at line 120 of file femcmpnn.h.

Member Data Documentation

Domain* oofem::FEMComponent::domain
protected

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

Definition at line 82 of file femcmpnn.h.

Referenced by oofem::TR1_2D_SUPG2_AXI::_giveMaterial(), oofem::TR1_2D_SUPG2::_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::FluidCrossSection::checkConsistency(), oofem::SimpleTransportCrossSection::checkConsistency(), oofem::NewtonianFluidMaterial::checkConsistency(), oofem::HangingNode::checkConsistency(), oofem::qcNode::checkConsistency(), oofem::NonlinearFluidMaterial::checkConsistency(), oofem::BinghamFluidMaterial2::checkConsistency(), oofem::Node::checkConsistency(), oofem::PrescribedGradientBCWeak::compute_x_times_N_1(), oofem::PrescribedGradientBCWeak::compute_x_times_N_2(), oofem::WeakPeriodicBoundaryCondition::computeBaseFunctionValue(), oofem::TR1_2D_SUPG_AXI::computeBCLhsPressureTerm_MB(), oofem::SUPGElement::computeBCLhsPressureTerm_MB(), oofem::SUPGElement::computeBCLhsPressureTerm_MC(), oofem::TR1_2D_SUPG_AXI::computeBCLhsTerm_MB(), oofem::SUPGElement::computeBCLhsTerm_MB(), oofem::TR1_2D_SUPG_AXI::computeBCRhsTerm_MB(), oofem::SUPGElement2::computeBCRhsTerm_MB(), oofem::TR1_2D_SUPG2_AXI::computeBCRhsTerm_MB(), oofem::TR1_2D_SUPG::computeBCRhsTerm_MB(), oofem::TR1_2D_SUPG2::computeBCRhsTerm_MB(), oofem::TR1_2D_SUPG_AXI::computeBCRhsTerm_MC(), oofem::SUPGElement2::computeBCRhsTerm_MC(), oofem::TR1_2D_SUPG2_AXI::computeBCRhsTerm_MC(), oofem::TR1_2D_SUPG::computeBCRhsTerm_MC(), oofem::TransportElement::computeBCSubMtrxAt(), oofem::TransportElement::computeBCSubVectorAt(), oofem::LIBeam3d2::computeBmatrixAt(), oofem::Beam2d::computeBmatrixAt(), oofem::Beam3d::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::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::TR1_2D_SUPG_AXI::computeDiffusionDerivativeTerm_MB(), oofem::SUPGElement2::computeDiffusionDerivativeTerm_MB(), oofem::TR1_2D_SUPG2_AXI::computeDiffusionDerivativeTerm_MB(), oofem::TR1_2D_SUPG::computeDiffusionDerivativeTerm_MB(), oofem::TR1_2D_SUPG2::computeDiffusionDerivativeTerm_MB(), oofem::TR1_2D_SUPG_AXI::computeDiffusionDerivativeTerm_MC(), oofem::TR1_2D_SUPG2_AXI::computeDiffusionDerivativeTerm_MC(), oofem::TR1_2D_SUPG_AXI::computeDiffusionTerm_MB(), oofem::SUPGElement2::computeDiffusionTerm_MB(), oofem::TR1_2D_SUPG2_AXI::computeDiffusionTerm_MB(), oofem::TR1_2D_SUPG::computeDiffusionTerm_MB(), oofem::TR1_2D_SUPG2::computeDiffusionTerm_MB(), oofem::TR1_2D_SUPG_AXI::computeDiffusionTerm_MC(), oofem::TR1_2D_SUPG2_AXI::computeDiffusionTerm_MC(), oofem::TR1_2D_CBS::computeDiffusionTermsI(), oofem::PrescribedGradientBCPeriodic::computeDofTransformation(), oofem::TransportGradientPeriodic::computeDofTransformation(), oofem::TransportElement::computeEdgeBCSubVectorAt(), oofem::TransportGradientNeumann::computeEta(), oofem::Tr1Darcy::computeExternalForcesVector(), oofem::Hexa21Stokes::computeExternalForcesVector(), oofem::Tet21Stokes::computeExternalForcesVector(), oofem::Tr21Stokes::computeExternalForcesVector(), oofem::Tr1BubbleStokes::computeExternalForcesVector(), oofem::Tet1BubbleStokes::computeExternalForcesVector(), oofem::PrescribedGradientBCPeriodic::computeField(), oofem::TransportGradientPeriodic::computeField(), oofem::PrescribedGradient::computeField(), oofem::PrescribedGenStrainShell7::computeField(), oofem::TransportGradientDirichlet::computeField(), oofem::PrescribedGradientBCWeak::computeField(), oofem::MixedGradientPressureDirichlet::computeFields(), oofem::LIBeam3d2::computeGtoLRotationMatrix(), oofem::Lattice2d_mt::computeInternalSourceRhsVectorAt(), oofem::PrescribedGradientBCWeak::computeIntForceGPContrib(), oofem::Q27Space::computeLoadLSToLRotationMatrix(), oofem::QSpace::computeLoadLSToLRotationMatrix(), oofem::LSpace::computeLoadLSToLRotationMatrix(), oofem::BeamBaseElement::computeLocalForceLoadVector(), oofem::InterfaceElem1d::computeLocalSlipDir(), oofem::IntElPoint::computeLocalSlipDir(), oofem::Shell7Base::computeMassMatrix(), oofem::Shell7BaseXFEM::computeMassMatrixNum(), oofem::Shell7Base::computeMassMatrixNum(), oofem::Beam2d::computeNmatrixAt(), oofem::Beam3d::computeNmatrixAt(), oofem::NeumannMomentLoad::computeNormal(), oofem::TR1_2D_CBS::computePrescribedTractionPressure(), oofem::WeakPeriodicBoundaryCondition::computeProjectionCoefficient(), oofem::StructuralElement::computeResultingIPEigenstrainAt(), oofem::StructuralElement::computeResultingIPTemperatureAt(), oofem::Shell7Base::computeSectionalForces(), oofem::B3Material::computeShrinkageStrainVector(), oofem::Shell7BaseXFEM::computeStiffnessMatrix(), oofem::NLStructuralElement::computeStiffnessMatrix(), oofem::Shell7Base::computeStiffnessMatrix(), oofem::GradDpElement::computeStiffnessMatrix_ku(), oofem::GradDpElement::computeStiffnessMatrix_uk(), oofem::GradDpElement::computeStiffnessMatrix_uu(), oofem::NLStructuralElement::computeStiffnessMatrix_withIRulesAsSubcells(), oofem::MixedGradientPressureWeakPeriodic::computeStress(), oofem::StructuralMaterial::computeStressIndependentStrainVector(), oofem::StructuralMaterial::computeStressIndependentStrainVector_3d(), oofem::Beam3d::computeSubSoilStiffnessMatrix(), oofem::TransportElement::computeSurfaceBCSubVectorAt(), oofem::PrescribedGradientBCNeumann::computeTangent(), oofem::PrescribedGradientBCPeriodic::computeTangent(), oofem::TransportGradientNeumann::computeTangent(), oofem::TransportGradientPeriodic::computeTangent(), oofem::PrescribedGradient::computeTangent(), oofem::PrescribedGenStrainShell7::computeTangent(), oofem::TransportGradientDirichlet::computeTangent(), oofem::PrescribedGradientBCWeak::computeTangent(), oofem::MixedGradientPressureWeakPeriodic::computeTangents(), oofem::MixedGradientPressureDirichlet::computeTangents(), oofem::MixedGradientPressureNeumann::computeTangents(), oofem::InteractionLoad::computeValueAt(), oofem::Quad10_2D_SUPG::computeVolumeAround(), oofem::TransportGradientDirichlet::computeXi(), oofem::StructuralFE2MaterialStatus::copyStateVariables(), oofem::LayeredCrossSection::createMaterialStatus(), oofem::SimpleCrossSection::createMaterialStatus(), oofem::FiberedCrossSection::createMaterialStatus(), oofem::M1Material::CreateMicroplaneStatus(), oofem::M4Material::CreateMicroplaneStatus(), oofem::StructuralFE2MaterialStatus::createRVE(), oofem::FE2FluidMaterialStatus::createRVE(), oofem::IDGMaterial::CreateStatus(), oofem::MicroplaneMaterial_Bazant::CreateStatus(), oofem::IntMatElastic::CreateStatus(), oofem::IntMatDummyCZ::CreateStatus(), oofem::HydratingHeMoMaterial::CreateStatus(), oofem::SimpleVitrificationMaterial::CreateStatus(), oofem::IsotropicHeatTransferMaterial::CreateStatus(), oofem::CohesiveInterfaceMaterial::CreateStatus(), oofem::IntMatPhaseField::CreateStatus(), oofem::HydratingIsoHeatMaterial::CreateStatus(), oofem::ConcreteFCM::CreateStatus(), oofem::TrabBoneNL::CreateStatus(), oofem::M1Material::CreateStatus(), oofem::SimpleInterfaceMaterial::CreateStatus(), oofem::FRCFCM::CreateStatus(), oofem::TrabBoneGrad3D::CreateStatus(), oofem::TrabBoneNLEmbed::CreateStatus(), oofem::MazarsMaterial::CreateStatus(), oofem::FRCFCMNL::CreateStatus(), oofem::ExpCZMaterial::CreateStatus(), oofem::IntMatBilinearCZElastic::CreateStatus(), oofem::HydratingConcreteMat::CreateStatus(), oofem::MisesMatGrad::CreateStatus(), oofem::RankineMatGrad::CreateStatus(), oofem::IntMatBilinearCZ::CreateStatus(), oofem::BondCEBMaterial::CreateStatus(), oofem::RCSDEMaterial::CreateStatus(), oofem::MazarsNLMaterial::CreateStatus(), oofem::RCSDMaterial::CreateStatus(), oofem::CebFipSlip90Material::CreateStatus(), oofem::IntMatCoulombContact::CreateStatus(), oofem::CompoDamageMat::CreateStatus(), oofem::RCSDNLMaterial::CreateStatus(), oofem::IsoInterfaceDamageMaterial::CreateStatus(), oofem::TrabBoneNL3D::CreateStatus(), oofem::IntMatIsoDamage::CreateStatus(), oofem::MisesMatNl::CreateStatus(), oofem::IsoInterfaceDamageMaterial_2::CreateStatus(), oofem::RankineMatNl::CreateStatus(), oofem::LatticeTransportMaterial::CreateStatus(), oofem::TransportMaterial::CreateStatus(), oofem::IntMatBilinearCZJansson::CreateStatus(), oofem::IntMatBilinearCZFagerstrom::CreateStatus(), oofem::IDNLMaterial::CreateStatus(), oofem::RCM2Material::CreateStatus(), oofem::IsotropicDamageMaterial::CreateStatus(), oofem::FCMMaterial::CreateStatus(), oofem::AnisotropicDamageMaterial::CreateStatus(), oofem::IsotropicDamageMaterial1::CreateStatus(), oofem::LatticeDamage2d::CreateStatus(), oofem::PrescribedGradientBCWeak::createTractionMesh(), oofem::Shell7BaseXFEM::discComputeSectionalForces(), oofem::TransportGradientNeumann::domainSize(), oofem::MixedGradientPressureBC::domainSize(), oofem::TransportGradientDirichlet::domainSize(), oofem::PrescribedGenStrainShell7::domainSize(), oofem::PFEMParticle::drawScalar(), oofem::LSpace::drawTriad(), oofem::Node::drawYourself(), oofem::ZZErrorEstimator::estimateError(), oofem::HuertaErrorEstimator::estimateError(), oofem::ZZRemeshingCriteria::estimateMeshDensities(), oofem::HuertaRemeshingCriteria::estimateMeshDensities(), oofem::FluidCrossSection::estimatePackSize(), oofem::SimpleTransportCrossSection::estimatePackSize(), oofem::LevelSetPCS::evalElemFContribution(), oofem::LevelSetPCS::evalElemfContribution(), oofem::PeriodicPiecewiseLinFunction::evaluateAtTime(), oofem::PrescribedGenStrainShell7::evaluateHigherOrderContribution(), oofem::PeriodicPiecewiseLinFunction::evaluateVelocityAtTime(), oofem::DirectErrorIndicatorRC::exchangeDofManDensities(), oofem::DirectErrorIndicatorRC::exchangeDofManIndicatorVals(), oofem::PrescribedGradientBCWeak::findCrackBndIntersecCoord(), oofem::PrescribedGradientBCWeak::findHoleCoord(), oofem::PrescribedGradientBCPeriodic::findSlaveToMasterMap(), oofem::TransportGradientPeriodic::findSlaveToMasterMap(), oofem::LevelSetPCS::FMMReinitialization(), oofem::TractionPressureBC::give(), oofem::RheoChainMaterial::give1dStressStiffMtrx(), oofem::LayeredCrossSection::give2dBeamStiffMtrx(), oofem::RheoChainMaterial::give2dLatticeStiffMtrx(), oofem::LayeredCrossSection::give2dPlateStiffMtrx(), oofem::LargeStrainMasterMaterialGrad::give3dGprime(), oofem::LargeStrainMasterMaterialGrad::give3dKappaMatrix(), oofem::RheoChainMaterial::give3dLatticeStiffMtrx(), oofem::RheoChainMaterial::give3dMaterialStiffnessMatrix(), oofem::LargeStrainMasterMaterial::give3dMaterialStiffnessMatrix_dPdF(), oofem::LayeredCrossSection::give3dShellStiffMtrx(), oofem::GeometryBasedEI::giveBoundingSphere(), oofem::LayeredCrossSection::giveCharMaterialStiffnessMatrix(), oofem::PlaneStress2dXfem::giveCompositeExportData(), oofem::QTrPlaneStress2dXFEM::giveCompositeExportData(), oofem::TrPlaneStress2dXFEM::giveCompositeExportData(), oofem::Element::giveCrossSection(), oofem::FluidCrossSection::giveDensity(), oofem::Element::giveDofManager(), oofem::CombinedZZSIRemeshingCriteria::giveDofManDensity(), oofem::ZZRemeshingCriteria::giveDofManDensity(), oofem::HuertaRemeshingCriteria::giveDofManDensity(), oofem::IntElPoint::giveDofManDofIDMask(), oofem::TrPlaneStress2dXFEM::giveDofManDofIDMask(), oofem::QTrPlaneStress2dXFEM::giveDofManDofIDMask(), oofem::WeakPeriodicBoundaryCondition::giveEdgeNormal(), oofem::LevelSetPCS::giveElementMaterialMixture(), oofem::WeakPeriodicBoundaryCondition::giveExternalForcesVector(), oofem::FiberedCrossSection::giveFiberMaterialStiffnessMatrix(), oofem::LargeStrainMasterMaterial::giveFirstPKStressVector_3d(), oofem::LargeStrainMasterMaterialGrad::giveFirstPKStressVectorGrad(), oofem::FluidCrossSection::giveFluidMaterial(), oofem::InteractionPFEMParticle::giveFluidStructureMasterProblem(), oofem::LayeredCrossSection::giveGeneralizedStress_Beam2d(), oofem::FiberedCrossSection::giveGeneralizedStress_Beam3d(), oofem::LayeredCrossSection::giveGeneralizedStress_Plate(), oofem::LayeredCrossSection::giveGeneralizedStress_Shell(), oofem::B3SolidMaterial::giveHumidity(), oofem::MPSMaterial::giveHumidity(), oofem::B3SolidMaterial::giveHumidityIncrement(), oofem::GradDpElement::giveInternalForcesVector(), oofem::WeakPeriodicBoundaryCondition::giveInternalForcesVector(), oofem::NLStructuralElement::giveInternalForcesVector(), oofem::NLStructuralElement::giveInternalForcesVector_withIRulesAsSubcells(), oofem::Beam3d::giveInternalForcesVectorAtPoint(), oofem::LargeStrainMasterMaterialGrad::giveInternalLength(), oofem::FluidCrossSection::giveIPValue(), oofem::SimpleTransportCrossSection::giveIPValue(), oofem::LargeStrainMasterMaterial::giveIPValue(), oofem::Quad10_2D_SUPG::giveIPValue(), oofem::TR1_2D_SUPG::giveIPValue(), oofem::StructuralMaterial::giveIPValue(), oofem::GradDpElement::giveLocalInternalForcesVector(), oofem::LinearConstraintBC::giveLocArray(), oofem::PrescribedGradientBCPeriodic::giveMasterDof(), oofem::TransportGradientPeriodic::giveMasterDof(), oofem::SimpleTransportCrossSection::giveMaterial(), oofem::TwoFluidMaterial::giveMaterial(), oofem::TransportElement::giveMaterial(), oofem::LayeredCrossSection::giveMaterial(), oofem::Element::giveMaterial(), oofem::LevelSetPCS::giveMaterialMixtureAt(), oofem::Set::giveNodeList(), oofem::RheoChainMaterial::givePlaneStrainStiffMtrx(), oofem::RheoChainMaterial::givePlaneStressStiffMtrx(), oofem::BoundaryLoad::giveProperty(), oofem::LayeredCrossSection::giveRealStress_3d(), oofem::LayeredCrossSection::giveRealStress_PlaneStress(), oofem::RheoChainMaterial::giveRealStressVector(), oofem::LatticeDamage2d::giveRealStressVector(), oofem::Element::giveSide(), oofem::LayeredCrossSection::giveStiffnessMatrix_3d(), oofem::LayeredCrossSection::giveStiffnessMatrix_PlaneStress(), oofem::MisesMat::giveTemperature(), oofem::MPSMaterial::giveTemperature(), oofem::SimpleCrossSection::giveTemperatureVector(), oofem::TwoFluidMaterial::giveTempVOF(), oofem::GeneralBoundaryCondition::giveTimeFunction(), oofem::Shell7Base::giveTractionBC(), oofem::PrescribedGradientBCPeriodic::giveUnknown(), oofem::TransportGradientPeriodic::giveUnknown(), oofem::MeshQualityErrorEstimator::giveValue(), oofem::IsotropicDamageMaterial1::initDamaged(), oofem::LevelSetPCS::initialize(), oofem::PrescribedMean::initializeFrom(), oofem::IntElLine1::initializeFrom(), oofem::InterfaceElem1d::initializeFrom(), oofem::DirectErrorIndicatorRC::initializeFrom(), oofem::MixedGradientPressureWeakPeriodic::initializeFrom(), oofem::MixedGradientPressureDirichlet::initializeFrom(), oofem::SolutionbasedShapeFunction::initializeFrom(), oofem::WeakPeriodicBoundaryCondition::initializeFrom(), oofem::Node::initializeFrom(), oofem::DofManager::initializeFrom(), oofem::SolutionbasedShapeFunction::initializeSurfaceData(), oofem::CemhydMat::initMaterial(), oofem::LargeStrainMasterMaterialStatus::initTempStatus(), oofem::PrescribedGradientBCNeumann::integrateTangent(), oofem::PolylineNonlocalBarrier::isActivated(), oofem::Element::isActivated(), oofem::FluidCrossSection::isCharacteristicMtrxSymmetric(), oofem::SimpleTransportCrossSection::isCharacteristicMtrxSymmetric(), oofem::SimpleCrossSection::isCharacteristicMtrxSymmetric(), oofem::FiberedCrossSection::isCharacteristicMtrxSymmetric(), oofem::LayeredCrossSection::isCharacteristicMtrxSymmetric(), oofem::GeneralBoundaryCondition::isImposed(), oofem::SolutionbasedShapeFunction::loadProblem(), oofem::MixedGradientPressureWeakPeriodic::MixedGradientPressureWeakPeriodic(), oofem::Shell7BaseXFEM::OLDcomputeStiffnessMatrix(), oofem::FluidCrossSection::packUnknowns(), oofem::SimpleTransportCrossSection::packUnknowns(), oofem::LevelSetPCS::pcs_stage1(), oofem::HangingNode::postInitialize(), oofem::RigidArmNode::postInitialize(), oofem::qcNode::postInitializeAsHangingNode(), oofem::LargeStrainMasterMaterialStatus::printOutputAt(), oofem::GeometryBasedEI::propagateFronts(), oofem::LevelSetPCS::redistance(), oofem::PrescribedGradientBCWeak::removeSegOverHoles(), oofem::FiberedCrossSection::restoreIPContext(), oofem::LayeredCrossSection::restoreIPContext(), oofem::RVEStokesFlowMaterialStatus::RVEStokesFlowMaterialStatus(), oofem::LargeStrainMasterMaterialStatus::saveContext(), oofem::HuertaErrorEstimator::saveContext(), oofem::FiberedCrossSection::saveIPContext(), oofem::LayeredCrossSection::saveIPContext(), oofem::InterfaceElem1d::setCoordMode(), oofem::IntElPoint::setCoordMode(), oofem::MixedGradientPressureNeumann::setPrescribedDeviatoricGradientFromVoigt(), oofem::HuertaErrorEstimator::setupRefinedProblemEpilog1(), oofem::HuertaErrorEstimator::setupRefinedProblemEpilog2(), oofem::HuertaErrorEstimator::setupRefinedProblemProlog(), oofem::HuertaErrorEstimator::solveRefinedElementProblem(), oofem::HuertaErrorEstimator::solveRefinedPatchProblem(), oofem::HuertaErrorEstimator::solveRefinedWholeProblem(), oofem::TwoFluidMaterialStatus::TwoFluidMaterialStatus(), oofem::FluidCrossSection::unpackAndUpdateUnknowns(), oofem::SimpleTransportCrossSection::unpackAndUpdateUnknowns(), oofem::DirectErrorIndicatorRC::unpackSharedDofManLocalDensities(), oofem::DirectErrorIndicatorRC::unpackSharedDofManLocalIndicatorVals(), oofem::PrescribedGradient::updateCoefficientMatrix(), oofem::PrescribedGenStrainShell7::updateCoefficientMatrix(), oofem::WeakPeriodicBoundaryCondition::updateDirection(), oofem::GeometryBasedEI::updateLevelSets(), oofem::GeometryBasedEI::updateNodeEnrMarker(), oofem::LevelSetPCS::updatePosition(), oofem::WeakPeriodicBoundaryCondition::updateSminmax(), oofem::Tet1_3D_SUPG::updateStabilizationCoeffs(), oofem::TR1_2D_SUPG_AXI::updateStabilizationCoeffs(), oofem::TR1_2D_SUPG2_AXI::updateStabilizationCoeffs(), oofem::TR1_2D_SUPG2::updateStabilizationCoeffs(), oofem::TR1_2D_SUPG::updateStabilizationCoeffs(), oofem::LargeStrainMasterMaterialStatus::updateYourself(), oofem::Node::updateYourself(), and oofem::GeometryBasedEI::writeVtkDebug().


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

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