OOFEM  2.4
OOFEM.org - Object Oriented Finite Element Solver
oofem::GaussPoint Class Reference

Class representing integration point in finite element program. More...

#include <gausspoint.h>

+ Inheritance diagram for oofem::GaussPoint:
+ Collaboration diagram for oofem::GaussPoint:

Public Member Functions

 GaussPoint (IntegrationRule *ir, int n, FloatArray iNaturalCoord, double w, MaterialMode mode)
 Creates integration point belonging to given integration rule, with given number, integration weight, coordinates and material mode. More...
 
 GaussPoint (IntegrationRule *ir, int n, double w, MaterialMode mode)
 
virtual ~GaussPoint ()
 Destructor. More...
 
double giveNaturalCoordinate (int i) const
 Returns i-th natural element coordinate of receiver. More...
 
const FloatArraygiveNaturalCoordinates ()
 Returns coordinate array of receiver. More...
 
void setNaturalCoordinates (const FloatArray &c)
 
const FloatArraygiveSubPatchCoordinates ()
 Returns local sub-patch coordinates of the receiver. More...
 
void setSubPatchCoordinates (const FloatArray &c)
 
const FloatArraygiveGlobalCoordinates ()
 
void setGlobalCoordinates (const FloatArray &iCoord)
 
virtual double giveWeight ()
 Returns integration weight of receiver. More...
 
void setWeight (double w)
 
int giveNumber ()
 Returns number of receiver. More...
 
IntegrationRulegiveIntegrationRule ()
 Returns corresponding integration rule to receiver. More...
 
ElementgiveElement ()
 Returns corresponding element to receiver. More...
 
MaterialMode giveMaterialMode ()
 Returns corresponding material mode of receiver. More...
 
void setMaterialMode (MaterialMode newMode)
 Sets material mode of receiver. More...
 
MaterialgiveMaterial ()
 Returns reference to material associated to related element of receiver. More...
 
CrossSectiongiveCrossSection ()
 Returns reference to cross section associated to related element of receiver. More...
 
IntegrationPointStatusgiveMaterialStatus ()
 Returns reference to associated material status (NULL if not defined). More...
 
IntegrationPointStatussetMaterialStatus (IntegrationPointStatus *ptr, int n)
 Sets Material status managed by receiver. More...
 
IntegrationPointStatussetMaterialStatus (IntegrationPointStatus *ptr)
 Sets Material status managed by receiver. More...
 
GaussPointgiveSlaveGaussPoint (int index)
 Returns index-th slave gauss point of receiver. More...
 
bool hasSlaveGaussPoint ()
 True if gauss point has slave points. More...
 
size_t findFirstIndexOfSlaveGaussPoint (GaussPoint *gp)
 Finds index of slave point in an array. More...
 
virtual void printOutputAt (FILE *file, TimeStep *tStep)
 Prints output of receiver to file. More...
 
virtual void updateYourself (TimeStep *tStep)
 Updates internal state of receiver after finishing time step. More...
 
virtual const char * giveClassName () const
 Returns class name of the receiver. More...
 
virtual IRResultType initializeFrom (InputRecord *ir)
 Initializes receiver according to object description stored in input record. More...
 

Protected Attributes

std::vector< GaussPoint * > gaussPoints
 List of slave integration points. More...
 
IntegrationPointStatusmaterialStatus
 Status of e.g. material in point. More...
 

Private Attributes

int number
 Number. More...
 
IntegrationRuleirule
 Reference to parent integration rule. More...
 
FloatArray naturalCoordinates
 Natural Element Coordinates of receiver. More...
 
FloatArraysubPatchCoordinates
 Optional local sub-patch (sub-patches form element volume) coordinates of the receiver. More...
 
FloatArrayglobalCoordinates
 Optional global (Cartesian) coordinates. More...
 
double weight
 Integration weight. More...
 
MaterialMode materialMode
 Material mode of receiver. More...
 

Friends

class LayeredCrossSection
 
class MicroplaneMaterial
 
class FiberedCrossSection
 

Detailed Description

Class representing integration point in finite element program.

Integration point maintain its space position, integration weight and corresponding material mode. Link to related element which integration point belongs to is also maintained. Integration point generally can contain list of slave integration points therefore is called as master point. Slaves are used for example to implement layered or fibered cross sections by cross section class. Then in one "macro" master gauss point, cross section creates few slaves (one per layer) and puts them into master list. When cross sections completes requests for particular master integration point, it performs integration over layers. It therefore calls material class for each layer, sending corresponding slave as parameter and integrates results. Generally, every integration point must hold its own copy of history variables (which are related to corresponding material model used). These material type dependent history variables are stored in material type related material status, which can be managed by integration point. Each material model class should introduce related material status class (derived from material status class or from its children), where necessary history variables are kept and can be accessed by material. Material class then creates unique copy of related status in all necessary integration points. Because integration point is compulsory parameter of all member functions of material class, particular material then can easily access its associated status from integration point and therefore its history variables for particular integration point.

To provide support to integrate element contribution by parts from element subVolumes (possibly with different material parameters etc), the integration point can maintain not only its element natural coordinates, but also its subVolume local coordinates, that are necessary to compute its jacobian, for example. These coordinates are stored in localCoordinates attribute.

Definition at line 93 of file gausspoint.h.

Constructor & Destructor Documentation

oofem::GaussPoint::GaussPoint ( IntegrationRule ir,
int  n,
FloatArray  iNaturalCoord,
double  w,
MaterialMode  mode 
)

Creates integration point belonging to given integration rule, with given number, integration weight, coordinates and material mode.

Parameters
irIntegration rule to which integration point belongs to.
nIntegration point number.
iNaturalCoordNatueral coordinates.
wIntegration weight.
modeMaterial mode.

Definition at line 43 of file gausspoint.C.

References globalCoordinates, materialStatus, and subPatchCoordinates.

oofem::GaussPoint::GaussPoint ( IntegrationRule ir,
int  n,
double  w,
MaterialMode  mode 
)

Definition at line 55 of file gausspoint.C.

References globalCoordinates, materialStatus, and subPatchCoordinates.

oofem::GaussPoint::~GaussPoint ( )
virtual

Destructor.

Definition at line 66 of file gausspoint.C.

References gaussPoints, globalCoordinates, materialStatus, and subPatchCoordinates.

Member Function Documentation

size_t oofem::GaussPoint::findFirstIndexOfSlaveGaussPoint ( GaussPoint gp)

Finds index of slave point in an array.

Returns position. If not found, returns error.

Definition at line 131 of file gausspoint.C.

References gaussPoints, and OOFEM_ERROR.

virtual const char* oofem::GaussPoint::giveClassName ( ) const
inlinevirtual

Returns class name of the receiver.

Reimplemented in oofem::Microplane.

Definition at line 289 of file gausspoint.h.

CrossSection* oofem::GaussPoint::giveCrossSection ( )
inline

Returns reference to cross section associated to related element of receiver.

Definition at line 200 of file gausspoint.h.

Referenced by oofem::Element::giveIPValue(), oofem::IntegrationRule::restoreContext(), and oofem::IntegrationRule::saveContext().

Element* oofem::GaussPoint::giveElement ( )
inline

Returns corresponding element to receiver.

Definition at line 188 of file gausspoint.h.

References oofem::IntegrationRule::giveElement().

Referenced by oofem::MMALeastSquareProjection::__mapVariable(), oofem::RandomMaterialExtensionInterface::_generateStatusVariables(), oofem::NonlocalMaterialExtensionInterface::buildNonlocalPointTable(), oofem::ConcreteFCM::checkSnapBack(), oofem::CompoDamageMat::checkSnapBack(), oofem::MPlasticMaterial::closestPointReturn(), oofem::MPlasticMaterial2::closestPointReturn(), oofem::PlaneStressStructuralElementEvaluator::computeBMatrixAt(), oofem::Tr_Warp::computeBmatrixAt(), oofem::LatticeTransportMaterial::computeConductivity(), oofem::MPSDamMaterial::computeDamageForCohesiveCrack(), oofem::LatticeDamage2d::computeDamageParam(), oofem::IsotropicDamageMaterial1::computeDamageParamForCohesiveCrack(), oofem::LatticeDamage2d::computeDeltaDissipation(), oofem::FRCFCMNL::computeElementCentroid(), oofem::Eurocode2CreepMaterial::computeEquivalentMaturity(), oofem::Tr_Warp::computeFirstMomentOfArea(), oofem::ConcreteDPM::computeInverseDamage(), oofem::PlaneStressStructuralElementEvaluator::computeNMatrixAt(), oofem::FRCFCMNL::computeNonlocalStressInFibers(), oofem::FRCFCMNL::computeNonlocalStressInFibersInUncracked(), oofem::PerfectlyPlasticMaterial::computePlasticStiffnessAt(), oofem::B3Material::computeShrinkageStrainVector(), oofem::Concrete3::computeStrength(), oofem::RCSDEMaterial::computeStrength(), oofem::RCSDMaterial::computeStrength(), oofem::IDNLMaterial::computeStressBasedWeight(), oofem::IDNLMaterial::computeStressBasedWeightForPeriodicCell(), oofem::StructuralMaterial::computeStressIndependentStrainVector(), oofem::LatticeDamage2d::computeStressIndependentStrainVector(), oofem::StructuralMaterial::computeStressIndependentStrainVector_3d(), oofem::FRCFCM::computeTempDamage(), oofem::MPlasticMaterial::cuttingPlaneReturn(), oofem::MPlasticMaterial2::cuttingPlaneReturn(), oofem::NonlocalMaterialWTP::fastElementIPNonlocTableUpdater(), oofem::VariableCrossSection::give(), oofem::Material::give(), oofem::WinklerMaterial::give3dBeamSubSoilStiffMtrx(), oofem::RCM2Material::giveCharacteristicElementLength(), oofem::FCMMaterial::giveCharacteristicElementLength(), oofem::CompoDamageMat::giveCharLength(), oofem::AbaqusUserMaterial::giveFirstPKStressVector_3d(), oofem::RVEStokesFlow::giveFluxVector(), 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::IDGMaterial::giveInternalLength(), oofem::Quad10_2D_SUPG::giveIPValue(), oofem::TR1_2D_SUPG::giveIPValue(), oofem::TransportMaterial::giveIPValue(), oofem::StructuralMaterial::giveIPValue(), oofem::TrabBoneNL3D::giveLocalNonlocalStiffnessContribution(), oofem::MisesMatNl::giveLocalNonlocalStiffnessContribution(), oofem::RankineMatNl::giveLocalNonlocalStiffnessContribution(), oofem::IDNLMaterial::giveLocalNonlocalStiffnessContribution(), oofem::FluidCrossSection::giveMaterial(), oofem::StructuralInterfaceCrossSection::giveMaterial(), oofem::SimpleCrossSection::giveMaterial(), oofem::CompoDamageMat::giveMatStiffRotationMatrix(), oofem::MDM::giveRawMDMParameters(), oofem::LayeredCrossSection::giveRealStress_PlaneStress(), oofem::PerfectlyPlasticMaterial::giveRealStressVector(), oofem::PlasticMaterial::giveRealStressVector(), oofem::CompoDamageMat::giveRealStressVector(), oofem::MDM::giveRealStressVector(), oofem::LatticeDamage2d::giveRealStressVector(), oofem::AbaqusUserMaterial::giveRealStressVector_3d(), oofem::LinearElasticMaterial::giveRealStressVector_Warping(), oofem::TrabBoneNL3D::giveRemoteNonlocalStiffnessContribution(), oofem::MisesMatNl::giveRemoteNonlocalStiffnessContribution(), oofem::RankineMatNl::giveRemoteNonlocalStiffnessContribution(), oofem::IDNLMaterial::giveRemoteNonlocalStiffnessContribution(), oofem::PerfectlyPlasticMaterial::GiveStressCorrectionBackToYieldSurface(), oofem::MisesMat::giveTemperature(), oofem::MPSMaterial::giveTemperature(), oofem::SimpleCrossSection::giveTemperatureVector(), oofem::TwoFluidMaterial::giveTempVOF(), oofem::OrthotropicLinearElasticMaterial::giveTensorRotationMatrix(), oofem::MazarsMaterial::initDamaged(), oofem::MPSDamMaterial::initDamaged(), oofem::IsotropicDamageMaterial1::initDamaged(), oofem::ConcreteDPM::initDamaged(), oofem::ConcreteDPM2::initDamaged(), oofem::IntMatBilinearCZJanssonStatus::IntMatBilinearCZJanssonStatus(), oofem::FRCFCMNL::isInElementProjection(), oofem::NonlocalMaterialExtensionInterface::manipulateWeight(), oofem::MMAShapeFunctProjection::mapVariable(), oofem::NonlocalMaterialExtensionInterface::modifyNonlocalWeightFunction_1D_Around(), oofem::MisesMatNl::modifyNonlocalWeightFunctionAround(), oofem::NonlocalMaterialExtensionInterface::modifyNonlocalWeightFunctionAround(), oofem::Material::modifyProperty(), oofem::TrabBoneNL3D::NonlocalMaterialStiffnessInterface_addIPContribution(), oofem::MisesMatNl::NonlocalMaterialStiffnessInterface_addIPContribution(), oofem::RankineMatNl::NonlocalMaterialStiffnessInterface_addIPContribution(), oofem::IDNLMaterial::NonlocalMaterialStiffnessInterface_addIPContribution(), oofem::IDNLMaterial::NonlocalMaterialStiffnessInterface_showSparseMtrxStructure(), oofem::ConcreteDPM2::performPlasticityReturn(), oofem::TransportMaterialStatus::printOutputAt(), oofem::CompoDamageMatStatus::printOutputAt(), oofem::NonlocalMaterialExtensionInterface::rebuildNonlocalPointTable(), oofem::ConcreteDPMStatus::restoreConsistency(), oofem::StructuralMaterialStatus::StructuralMaterialStatus(), oofem::HydratingHeMoMaterial::updateInternalState(), oofem::HydratingIsoHeatMaterial::updateInternalState(), oofem::RCM2Material::updateStatusForNewCrack(), and oofem::CemhydMatStatus::updateYourself().

MaterialMode oofem::GaussPoint::giveMaterialMode ( )
inline

Returns corresponding material mode of receiver.

Definition at line 191 of file gausspoint.h.

Referenced by oofem::BinghamFluidMaterial2Status::BinghamFluidMaterial2Status(), oofem::RCM2Material::checkForNewActiveCracks(), oofem::IDNLMaterial::computeAngleAndSigmaRatio(), oofem::MPSMaterial::computeB4AutogenousShrinkageStrainVector(), oofem::LatticeTransportMaterial::computeConductivity(), oofem::HeMoBazNajMaterial::computeConductivityMtrx(), oofem::HeMoTKMaterial::computeConductivityMtrx(), oofem::HeMoKunzelMaterial::computeConductivityMtrx(), oofem::RCSDEMaterial::computeCurrEquivStrain(), oofem::RCSDMaterial::computeCurrEquivStrain(), oofem::MDM::computeDamageOnPlane(), oofem::AnisotropicDamageMaterial::computeDamageTensor(), oofem::GradDpElement::computeDeformationGradientVector(), oofem::NLStructuralElement::computeDeformationGradientVector(), oofem::tet21ghostsolid::computeDeformationGradientVectorFromDispl(), oofem::NewtonianFluidMaterial::computeDeviatoricStressVector(), oofem::FluidDynamicMaterial::computeDeviatoricStressVector(), oofem::BinghamFluidMaterial2::computeDeviatoricStressVector(), oofem::FE2FluidMaterial::computeDeviatoricStressVector(), oofem::Quad1_ht::computeEdgeVolumeAround(), oofem::MazarsMaterial::computeEquivalentStrain(), oofem::IsotropicDamageMaterial1::computeEquivalentStrain(), oofem::AnisotropicDamageMaterial::computeEquivalentStrain(), oofem::IsotropicDamageMaterial1::computeEta(), oofem::MPSMaterial::computeFibAutogenousShrinkageStrainVector(), oofem::PlasticMaterial::ComputeGradientVector(), oofem::MPlasticMaterial::computeGradientVector(), oofem::J2MPlasticMaterial::computeHardeningReducedModuli(), oofem::J2plasticMaterial::computeHardeningReducedModuli(), oofem::KelvinChainSolidMaterial::computeHiddenVars(), oofem::KelvinChainMaterial::computeHiddenVars(), oofem::Eurocode2CreepMaterial::computeIncrementOfAutogenousShrinkageVector(), oofem::Eurocode2CreepMaterial::computeIncrementOfDryingShrinkageVector(), oofem::B3SolidMaterial::computePointShrinkageStrainVector(), oofem::MPSMaterial::computePointShrinkageStrainVector(), oofem::Masonry02::computeReducedElasticModuli(), oofem::J2MPlasticMaterial::computeReducedGradientMatrix(), oofem::J2plasticMaterial::computeReducedGradientMatrix(), oofem::J2Mat::computeReducedHardeningVarsSigmaGradient(), oofem::DruckerPragerCutMat::computeReducedHardeningVarsSigmaGradient(), oofem::J2Mat::computeReducedSKGradientMatrix(), oofem::DruckerPragerCutMat::computeReducedSKGradientMatrix(), oofem::J2Mat::computeReducedSSGradientMatrix(), oofem::DruckerPragerCutMat::computeReducedSSGradientMatrix(), oofem::MPlasticMaterial2::computeReducedStressGradientVector(), oofem::FCMMaterial::computeShearSlipOnCrack(), oofem::B3Material::computeShrinkageStrainVector(), oofem::StructuralElementEvaluator::computeStrainVector(), oofem::StructuralElement::computeStrainVector(), oofem::StructuralMaterial::computeStressIndependentStrainVector(), oofem::J2MPlasticMaterial::computeStressSpaceHardeningVars(), oofem::J2plasticMaterial::ComputeStressSpaceHardeningVars(), oofem::J2MPlasticMaterial::computeStressSpaceHardeningVarsReducedGradient(), oofem::J2plasticMaterial::ComputeStressSpaceHardeningVarsReducedGradient(), oofem::B3Material::computeTotalAverageShrinkageStrainVector(), oofem::B3SolidMaterial::computeTotalAverageShrinkageStrainVector(), oofem::J2plasticMaterial::computeTrialStressIncrement(), oofem::MPlasticMaterial::computeTrialStressIncrement(), oofem::MPlasticMaterial2::computeTrialStressIncrement(), oofem::MPlasticMaterial::cuttingPlaneReturn(), oofem::PerfectlyPlasticMaterial::give1dStressStiffMtrx(), oofem::PerfectlyPlasticMaterial::give2dBeamLayerStiffMtrx(), oofem::PlasticMaterial::give3dMaterialStiffnessMatrix(), oofem::StructuralFE2Material::give3dMaterialStiffnessMatrix(), oofem::PerfectlyPlasticMaterial::give3dMaterialStiffnessMatrix(), oofem::MPlasticMaterial::give3dMaterialStiffnessMatrix(), oofem::MPlasticMaterial2::give3dMaterialStiffnessMatrix(), oofem::StructuralMaterial::give_dPdF_from(), oofem::SimpleCrossSection::giveCauchyStresses(), oofem::IsotropicMoistureTransferMaterial::giveCharacteristicMatrix(), oofem::IsotropicHeatTransferMaterial::giveCharacteristicMatrix(), oofem::NonlinearMassTransferMaterial::giveCharacteristicMatrix(), oofem::AnisotropicMassTransferMaterial::giveCharacteristicMatrix(), oofem::SimpleCrossSection::giveCharMaterialStiffnessMatrix(), oofem::FiberedCrossSection::giveCharMaterialStiffnessMatrix(), oofem::LayeredCrossSection::giveCharMaterialStiffnessMatrix(), oofem::PlasticMaterial::giveConsistentStiffnessMatrix(), oofem::MPlasticMaterial::giveConsistentStiffnessMatrix(), oofem::MPlasticMaterial2::giveConsistentStiffnessMatrix(), oofem::NewtonianFluidMaterial::giveDeviatoricStiffnessMatrix(), oofem::BinghamFluidMaterial2::giveDeviatoricStiffnessMatrix(), oofem::PerfectlyPlasticMaterial::giveEffectiveMaterialStiffnessMatrix(), oofem::RCM2Material::giveEffectiveMaterialStiffnessMatrix(), oofem::FE2FluidMaterial::giveEffectiveViscosity(), oofem::MPlasticMaterial::giveElastoPlasticStiffnessMatrix(), oofem::MPlasticMaterial2::giveElastoPlasticStiffnessMatrix(), oofem::SimpleCrossSection::giveEshelbyStresses(), oofem::SimpleCrossSection::giveFirstPKStresses(), oofem::LargeStrainMasterMaterialGrad::giveFirstPKStressVectorGrad(), oofem::StructuralElement::giveInternalForcesVector(), oofem::StructuralElement::giveInternalForcesVector_withIRulesAsSubcells(), oofem::IDGMaterial::giveInternalLength(), oofem::IDGMaterial::giveInternalLengthDerivative(), oofem::tet21ghostsolid::giveIPValue(), oofem::FluidDynamicMaterial::giveIPValue(), oofem::PlasticMaterial::giveIPValue(), oofem::PerfectlyPlasticMaterial::giveIPValue(), oofem::MPlasticMaterial::giveIPValue(), oofem::MPlasticMaterial2::giveIPValue(), oofem::FCMMaterial::giveIPValue(), oofem::MPSMaterial::giveIPValue(), oofem::StructuralMaterial::giveIPValue(), oofem::FCMMaterial::giveLocalCrackedStiffnessMatrix(), oofem::PerfectlyPlasticMaterial::giveMaterialStiffnessMatrix(), oofem::FCMMaterial::giveMaterialStiffnessMatrix(), oofem::CompoDamageMat::giveMatStiffRotationMatrix(), oofem::FCMMaterialStatus::giveMaxNumberOfCracks(), oofem::MicroplaneMaterial::giveMicroplane(), oofem::RCM2Material::giveNormalElasticStiffnessMatrix(), oofem::MazarsMaterial::giveNumberOfSpatialDimensions(), oofem::LargeStrainMasterMaterialGrad::givePDGradMatrix_kk(), oofem::IDGMaterial::givePDGradMatrix_kk(), oofem::TrabBoneGrad3D::givePDGradMatrix_kk(), oofem::MisesMatGrad::givePDGradMatrix_kk(), oofem::RankineMatGrad::givePDGradMatrix_kk(), oofem::LargeStrainMasterMaterialGrad::givePDGradMatrix_ku(), oofem::IDGMaterial::givePDGradMatrix_ku(), oofem::TrabBoneGrad3D::givePDGradMatrix_ku(), oofem::MisesMatGrad::givePDGradMatrix_ku(), oofem::RankineMatGrad::givePDGradMatrix_ku(), oofem::LargeStrainMasterMaterialGrad::givePDGradMatrix_LD(), oofem::IDGMaterial::givePDGradMatrix_LD(), oofem::TrabBoneGrad3D::givePDGradMatrix_LD(), oofem::MisesMatGrad::givePDGradMatrix_LD(), oofem::RankineMatGrad::givePDGradMatrix_LD(), oofem::LargeStrainMasterMaterialGrad::givePDGradMatrix_uk(), oofem::IDGMaterial::givePDGradMatrix_uk(), oofem::TrabBoneGrad3D::givePDGradMatrix_uk(), oofem::MisesMatGrad::givePDGradMatrix_uk(), oofem::RankineMatGrad::givePDGradMatrix_uk(), oofem::LargeStrainMasterMaterialGrad::givePDGradMatrix_uu(), oofem::IDGMaterial::givePDGradMatrix_uu(), oofem::TrabBoneGrad3D::givePDGradMatrix_uu(), oofem::MisesMatGrad::givePDGradMatrix_uu(), oofem::RankineMatGrad::givePDGradMatrix_uu(), oofem::PerfectlyPlasticMaterial::givePlaneStrainStiffMtrx(), oofem::PerfectlyPlasticMaterial::givePlaneStressStiffMtrx(), oofem::PerfectlyPlasticMaterial::givePlateLayerStiffMtrx(), oofem::MDM::giveRawMDMParameters(), oofem::StructuralCrossSection::giveRealStresses(), oofem::RCSDNLMaterial::giveRealStressVector(), oofem::PerfectlyPlasticMaterial::giveRealStressVector(), oofem::RCSDEMaterial::giveRealStressVector(), oofem::RCSDMaterial::giveRealStressVector(), oofem::PlasticMaterial::giveRealStressVector(), oofem::CompoDamageMat::giveRealStressVector(), oofem::StructuralMaterial::giveRealStressVector(), oofem::RheoChainMaterial::giveRealStressVector(), oofem::MPlasticMaterial::giveRealStressVector(), oofem::RCM2Material::giveRealStressVector(), oofem::MPlasticMaterial2::giveRealStressVector(), oofem::FCMMaterial::giveRealStressVector(), oofem::MPSDamMaterial::giveRealStressVector(), oofem::AnisotropicDamageMaterial::giveRealStressVector(), oofem::StructuralFE2Material::giveRealStressVector_3d(), oofem::Concrete2::giveRealStressVector_PlateLayer(), oofem::MisesMatNl::giveRemoteNonlocalStiffnessContribution(), oofem::IDNLMaterial::giveRemoteNonlocalStiffnessContribution(), oofem::B3Material::giveShrinkageStrainVector(), oofem::B3SolidMaterial::giveShrinkageStrainVector(), oofem::Eurocode2CreepMaterial::giveShrinkageStrainVector(), oofem::MPSMaterial::giveShrinkageStrainVector(), oofem::J2Mat::giveSizeOfReducedHardeningVarsVector(), oofem::J2MPlasticMaterial::giveSizeOfReducedHardeningVarsVector(), oofem::J2plasticMaterial::giveSizeOfReducedHardeningVarsVector(), oofem::FiberedCrossSection::giveSlaveGaussPoint(), oofem::LayeredCrossSection::giveSlaveGaussPoint(), oofem::Masonry02::giveStiffnessMatrix(), oofem::StructuralMaterial::giveStiffnessMatrix(), oofem::LatticeDamage2d::giveStiffnessMatrix(), oofem::SimpleCrossSection::giveStiffnessMatrix_dCde(), oofem::SimpleCrossSection::giveStiffnessMatrix_dPdF(), oofem::J2Mat::giveStressBackVector(), oofem::OrthotropicLinearElasticMaterial::giveTensorRotationMatrix(), oofem::RheoChainMaterial::giveThermalDilatationVector(), oofem::FiberedCrossSection::imposeStrainConstrainsOnGradient(), oofem::LayeredCrossSection::imposeStrainConstrainsOnGradient(), oofem::StructuralCrossSection::imposeStrainConstrainsOnGradient(), oofem::FiberedCrossSection::imposeStressConstrainsOnGradient(), oofem::LayeredCrossSection::imposeStressConstrainsOnGradient(), oofem::StructuralCrossSection::imposeStressConstrainsOnGradient(), oofem::MazarsMaterial::initDamaged(), oofem::IsotropicDamageMaterial1::initDamaged(), oofem::FCMMaterial::initializeCrack(), oofem::MisesMatGradStatus::initTempStatus(), oofem::RankineMatGradStatus::initTempStatus(), oofem::PlasticMaterialStatus::initTempStatus(), oofem::RCSDNLMaterialStatus::initTempStatus(), oofem::PerfectlyPlasticMaterialStatus::initTempStatus(), oofem::MPlasticMaterialStatus::initTempStatus(), oofem::StructuralMaterialStatus::initTempStatus(), oofem::MPlasticMaterial2Status::initTempStatus(), oofem::Concrete2MaterialStatus::initTempStatus(), oofem::RankineMatStatus::initTempStatus(), oofem::FRCFCM::maxShearStress(), oofem::IsotropicDamageMaterial1::MMI_map(), oofem::MPSDamMaterialStatus::MPSDamMaterialStatus(), oofem::MPSMaterialStatus::MPSMaterialStatus(), oofem::RankineMat::performPlasticityReturn(), oofem::IDNLMaterial::predictRelativeComputationalCost(), oofem::RCSDNLMaterialStatus::printOutputAt(), oofem::CompoDamageMatStatus::printOutputAt(), oofem::StructuralMaterialStatus::printOutputAt(), oofem::AnisotropicDamageMaterialStatus::printOutputAt(), oofem::RCSDNLMaterialStatus::RCSDNLMaterialStatus(), oofem::M1MaterialStatus::restoreContext(), oofem::IntegrationRule::saveContext(), oofem::HuertaErrorEstimatorInterface::setupRefinedElementProblem1D(), oofem::HuertaErrorEstimatorInterface::setupRefinedElementProblem2D(), oofem::HuertaErrorEstimatorInterface::setupRefinedElementProblem3D(), oofem::StructuralMaterialStatus::StructuralMaterialStatus(), oofem::MDM::transformStrainToPDC(), oofem::MDM::transformStressFromPDC(), oofem::RCM2Material::updateCrackStatus(), and oofem::XfemStructuralElementInterface::XfemElementInterface_computeDeformationGradientVector().

IntegrationPointStatus* oofem::GaussPoint::giveMaterialStatus ( )
inline

Returns reference to associated material status (NULL if not defined).

Definition at line 205 of file gausspoint.h.

Referenced by oofem::MMAClosestIPTransfer::__init(), oofem::RandomMaterialExtensionInterface::_generateStatusVariables(), oofem::Crack::AppendCohesiveZoneGaussPoint(), oofem::NonlocalMaterialExtensionInterface::buildNonlocalPointTable(), oofem::XfemStructuralElementInterface::computeCohesiveForces(), oofem::XfemStructuralElementInterface::computeCohesiveTangent(), oofem::TR1_2D_CBS::computeDiffusionTermsI(), oofem::IDNLMaterial::computeEquivalentStrain(), oofem::PhaseFieldElement::computeFreeEnergy(), oofem::IntElLine1PF::computeFreeEnergy(), oofem::SolidShell::computeGeometricStiffness(), oofem::IntElLine1PF::computeGMatrix(), oofem::FRCFCMNL::computeNonlocalStressInFibers(), oofem::FRCFCMNL::computeNonlocalStressInFibersInUncracked(), oofem::TR1_2D_CBS::computePrescribedTractionPressure(), oofem::LIBeam3d2::computeStrainVector(), oofem::LIBeam3dNL::computeTempCurv(), oofem::LIBeam3dNL2::computeTempCurv(), oofem::StructuralInterfaceElement::computeTraction(), oofem::NonlocalMaterialExtensionInterface::endIPNonlocalAverage(), oofem::RandomMaterialExtensionInterface::give(), oofem::StructuralPythonMaterial::give3dMaterialStiffnessMatrix(), oofem::AbaqusUserMaterial::give3dMaterialStiffnessMatrix(), oofem::StructuralPythonMaterial::give3dMaterialStiffnessMatrix_dPdF(), oofem::AbaqusUserMaterial::give3dMaterialStiffnessMatrix_dPdF(), oofem::TrPlaneStrRot3d::giveCharacteristicTensor(), oofem::TrPlanestressRotAllman3d::giveCharacteristicTensor(), oofem::DKTPlate3d::giveCharacteristicTensor(), oofem::CCTPlate3d::giveCharacteristicTensor(), oofem::LinQuad3DPlaneStress::giveCharacteristicTensor(), oofem::Lattice2d::giveCrackFlag(), oofem::Lattice2d::giveCrackWidth(), oofem::Lattice2d::giveDeltaDissipation(), oofem::Lattice2d::giveDissipation(), oofem::LIBeam3dNL2::giveInternalForcesVector(), oofem::LIBeam3dNL::giveInternalForcesVector(), oofem::StructuralElement::giveInternalForcesVector(), oofem::StructuralElement::giveInternalForcesVector_withIRulesAsSubcells(), oofem::NonlocalMaterialExtensionInterface::giveIPIntegrationList(), oofem::LIBeam2d::giveIPValue(), oofem::LIBeam3d::giveIPValue(), oofem::LIBeam2dNL::giveIPValue(), oofem::LIBeam3dNL::giveIPValue(), oofem::TrPlaneStrRot::giveIPValue(), oofem::Quad1PlateSubSoil::giveIPValue(), oofem::Quad1Mindlin::giveIPValue(), oofem::Quad1MindlinShell3D::giveIPValue(), oofem::CCTPlate::giveIPValue(), oofem::QDKTPlate::giveIPValue(), oofem::Beam2d::giveIPValue(), oofem::DKTPlate::giveIPValue(), oofem::Beam3d::giveIPValue(), oofem::Lattice2d_mt::giveMass(), oofem::MicroplaneMaterial::giveMicroplaneStatus(), oofem::NonlocalMaterialWTP::giveNonlocalDepArryElementPlugin(), oofem::Lattice2d::giveNormalStress(), oofem::Lattice2d::giveOldCrackWidth(), oofem::Lattice2d::giveOldNormalStress(), oofem::Lattice2d_mt::giveOldPressure(), oofem::Lattice2d_mt::givePressure(), oofem::ConcreteFCM::giveStatus(), oofem::IsotropicDamageMaterial1::giveStatus(), oofem::LatticeDamage2d::giveStatus(), oofem::Lattice2d::hasBeenUpdated(), oofem::TwoFluidMaterialStatus::initTempStatus(), oofem::FRCFCMNL::isInElementProjection(), oofem::NonlocalMaterialExtensionInterface::modifyNonlocalWeightFunction_1D_Around(), oofem::NonlocalMaterialExtensionInterface::modifyNonlocalWeightFunctionAround(), oofem::NCPrincipalStrain::nucleateEnrichmentItems(), oofem::NCPrincipalStress::nucleateEnrichmentItems(), oofem::GnuplotExportModule::outputInterfaceEl(), oofem::GnuplotExportModule::outputXFEM(), oofem::TwoFluidMaterialStatus::printOutputAt(), printOutputAt(), oofem::PLPrincipalStrain::propagateInterface(), oofem::PLHoopStressCirc::propagateInterface(), oofem::NonlocalMaterialExtensionInterface::rebuildNonlocalPointTable(), oofem::TwoFluidMaterialStatus::restoreContext(), oofem::TwoFluidMaterialStatus::saveContext(), oofem::Shell7Base::updateLayerTransvNormalStressSR(), oofem::Shell7Base::updateLayerTransvShearStressesSR(), oofem::Shell7Base::updateLayerTransvStressesSR(), oofem::TwoFluidMaterialStatus::updateYourself(), and updateYourself().

double oofem::GaussPoint::giveNaturalCoordinate ( int  i) const
inline

Returns i-th natural element coordinate of receiver.

Definition at line 136 of file gausspoint.h.

References oofem::FloatArray::at().

Referenced by oofem::Tr2Shell7XFEM::computeAreaAround(), oofem::Tr2Shell7::computeAreaAround(), oofem::QDKTPlate::computeBmatrixAt(), oofem::InterfaceElem2dQuad::computeBmatrixAt(), oofem::DKTPlate::computeBmatrixAt(), oofem::LIBeam2d::computeBmatrixAt(), oofem::LIBeam2dNL::computeBmatrixAt(), oofem::LIBeam3d::computeBmatrixAt(), oofem::MITC4Shell::computeBmatrixAt(), oofem::LIBeam3d2::computeBmatrixAt(), oofem::Beam2d::computeBmatrixAt(), oofem::Beam3d::computeBmatrixAt(), oofem::LIBeam2dNL::computeNLBMatrixAt(), oofem::IntElLine1IntPen::computeNmatrixAt(), oofem::TR1_2D_SUPG::computeNMtrx(), oofem::Shell7Base::computePressureForceAt(), oofem::TR1_2D_SUPG2_AXI::computeRadiusAt(), oofem::LIBeam2d::computeStrainVectorInLayer(), oofem::LIBeam2dNL::computeStrainVectorInLayer(), oofem::RerShell::computeStrainVectorInLayer(), oofem::TrPlanestressRotAllman::computeStrainVectorInLayer(), oofem::CCTPlate::computeStrainVectorInLayer(), oofem::QDKTPlate::computeStrainVectorInLayer(), oofem::Beam2d::computeStrainVectorInLayer(), oofem::DKTPlate::computeStrainVectorInLayer(), oofem::MITC4Shell::computeSurfaceVolumeAround(), oofem::HTSelement::computeSvMatrixAt(), oofem::HTSelement::computeUvMatrixAt(), oofem::InterfaceElem2dQuad::computeVolumeAround(), oofem::MITC4Shell::computeVolumeAround(), oofem::LIBeam3d::FiberedCrossSectionInterface_computeStrainVectorInFiber(), oofem::LIBeam3d2::FiberedCrossSectionInterface_computeStrainVectorInFiber(), oofem::Beam3d::FiberedCrossSectionInterface_computeStrainVectorInFiber(), oofem::LayeredCrossSection::give2dBeamStiffMtrx(), oofem::LayeredCrossSection::give2dPlateStiffMtrx(), oofem::LayeredCrossSection::give3dShellStiffMtrx(), oofem::Shell7BaseXFEM::giveFailedInterfaceNumber(), oofem::LayeredCrossSection::giveGeneralizedStress_Beam2d(), oofem::FiberedCrossSection::giveGeneralizedStress_Beam3d(), oofem::LayeredCrossSection::giveGeneralizedStress_Plate(), oofem::LayeredCrossSection::giveGeneralizedStress_Shell(), oofem::LayeredCrossSection::giveRealStress_PlaneStress(), and oofem::HTSelement::u_gammaLin().

const FloatArray& oofem::GaussPoint::giveNaturalCoordinates ( )
inline

Returns coordinate array of receiver.

Definition at line 138 of file gausspoint.h.

Referenced by oofem::NonlocalMaterialExtensionInterface::buildNonlocalPointTable(), oofem::IntElLine1PhF::computeAreaAround(), oofem::IntElLine1::computeAreaAround(), oofem::PhaseFieldElement::computeBd_matrixAt(), oofem::StructuralInterfaceElementPhF::computeBd_matrixAt(), oofem::IntElLine1PF::computeBd_vectorAt(), oofem::SolidShell::computeBEmatrixAt(), oofem::SolidShell::computeBHmatrixAt(), oofem::Structural3DElement::computeBHmatrixAt(), oofem::Quad1PlaneStrain::computeBHmatrixAt(), oofem::PlaneStress2d::computeBHmatrixAt(), oofem::tet21ghostsolid::computeBHmatrixAt(), oofem::PlaneStressElement::computeBHmatrixAt(), oofem::PlaneStrainElement::computeBHmatrixAt(), oofem::AxisymElement::computeBHmatrixAt(), oofem::QTrPlaneStrainGrad::computeBkappaMatrixAt(), oofem::QPlaneStressGrad::computeBkappaMatrixAt(), oofem::QPlaneStrainGrad::computeBkappaMatrixAt(), oofem::QTrPlaneStressGrad::computeBkappaMatrixAt(), oofem::QTruss1dGrad::computeBkappaMatrixAt(), oofem::QTRSpaceGrad::computeBkappaMatrixAt(), oofem::QWedgeGrad::computeBkappaMatrixAt(), oofem::QSpaceGrad::computeBkappaMatrixAt(), oofem::Tet1_3D_SUPG::computeBMatrix(), oofem::PFEMElement2d::computeBMatrix(), oofem::TR21_2D_SUPG::computeBMatrix(), oofem::Quad10_2D_SUPG::computeBMatrix(), oofem::LSpaceBB::computeBmatrixAt(), oofem::PlaneStressStructuralElementEvaluator::computeBMatrixAt(), oofem::Space3dStructuralElementEvaluator::computeBMatrixAt(), oofem::SolidShell::computeBmatrixAt(), oofem::TrPlaneStrRot::computeBmatrixAt(), oofem::TrPlanestressRotAllman::computeBmatrixAt(), oofem::Q4Axisymm::computeBmatrixAt(), oofem::Tr_Warp::computeBmatrixAt(), oofem::Quad2PlateSubSoil::computeBmatrixAt(), oofem::QTruss1d::computeBmatrixAt(), oofem::Structural3DElement::computeBmatrixAt(), oofem::L4Axisymm::computeBmatrixAt(), oofem::InterfaceElem2dLin::computeBmatrixAt(), oofem::InterfaceElement3dTrLin::computeBmatrixAt(), oofem::Tria1PlateSubSoil::computeBmatrixAt(), oofem::Quad1PlateSubSoil::computeBmatrixAt(), oofem::LineDistributedSpring::computeBmatrixAt(), oofem::Quad1PlaneStrain::computeBmatrixAt(), oofem::PlaneStress2d::computeBmatrixAt(), oofem::Quad1Mindlin::computeBmatrixAt(), oofem::Truss3d::computeBmatrixAt(), oofem::tet21ghostsolid::computeBmatrixAt(), oofem::Truss1d::computeBmatrixAt(), oofem::PlaneStressElement::computeBmatrixAt(), oofem::PlaneStrainElement::computeBmatrixAt(), oofem::Quad1MindlinShell3D::computeBmatrixAt(), oofem::AxisymElement::computeBmatrixAt(), oofem::StructuralElement::computeBoundaryEdgeLoadVector(), oofem::StructuralElement::computeBoundarySurfaceLoadVector(), oofem::Shell7Base::computeCauchyStressVector(), oofem::Structural3DElement::computeConstitutiveMatrixAt(), oofem::PlaneStressElement::computeConstitutiveMatrixAt(), oofem::PlaneStrainElement::computeConstitutiveMatrixAt(), oofem::AxisymElement::computeConstitutiveMatrixAt(), oofem::IntElLine1PhF::computeCovarBaseVectorAt(), oofem::IntElLine1PF::computeCovarBaseVectorAt(), oofem::IntElLine1::computeCovarBaseVectorAt(), oofem::IntElSurfTr1::computeCovarBaseVectorsAt(), oofem::PhaseFieldElement::computeDamageAt(), oofem::IntElLine1PF::computeDamageAt(), oofem::StructuralInterfaceElementPhF::computeDamageAt(), oofem::TR21_2D_SUPG::computeDivTauMatrix(), oofem::Tet1_3D_SUPG::computeDivUMatrix(), oofem::TR21_2D_SUPG::computeDivUMatrix(), oofem::Quad10_2D_SUPG::computeDivUMatrix(), oofem::SolidShell::computeEASBmatrixAt(), oofem::PFEMElement2d::computeEdgeNMatrixAt(), oofem::TrAxisym1_ht::computeEdgeVolumeAround(), oofem::QuadAxisym1_ht::computeEdgeVolumeAround(), oofem::QBrick1_ht::computeEdgeVolumeAround(), oofem::Tr1_ht::computeEdgeVolumeAround(), oofem::Quad1_ht::computeEdgeVolumeAround(), oofem::Tetrah1_ht::computeEdgeVolumeAround(), oofem::Structural3DElement::computeEdgeVolumeAround(), oofem::Wedge_ht::computeEdgeVolumeAround(), oofem::QWedge_ht::computeEdgeVolumeAround(), oofem::Brick1_ht::computeEdgeVolumeAround(), oofem::DKTPlate3d::computeEdgeVolumeAround(), oofem::Structural2DElement::computeEdgeVolumeAround(), oofem::CCTPlate::computeEdgeVolumeAround(), oofem::Tr_Warp::computeEdgeVolumeAround(), oofem::Truss3d::computeEdgeVolumeAround(), oofem::Quad1Mindlin::computeEdgeVolumeAround(), oofem::QDKTPlate::computeEdgeVolumeAround(), oofem::DKTPlate::computeEdgeVolumeAround(), oofem::PFEMElement2d::computeEdgeVolumeAround(), oofem::Quad1MindlinShell3D::computeEdgeVolumeAround(), oofem::AxisymElement::computeEdgeVolumeAround(), oofem::MITC4Shell::computeEdgeVolumeAround(), oofem::StructuralElement::computeEdgeVolumeAround(), oofem::TrPlanestressRotAllman::computeEgdeNMatrixAt(), oofem::PFEMElement2d::computeEgdeNVectorAt(), oofem::Shell7BaseXFEM::computeEnrTractionForce(), oofem::Tr_Warp::computeFirstMomentOfArea(), oofem::TransportElement::computeFlow(), oofem::SolidShell::computeGeometricStiffness(), oofem::Tet1_3D_SUPG::computeGradPMatrix(), oofem::TR21_2D_SUPG::computeGradPMatrix(), oofem::Quad10_2D_SUPG::computeGradPMatrix(), oofem::Tet1_3D_SUPG::computeGradUMatrix(), oofem::TR21_2D_SUPG::computeGradUMatrix(), oofem::Quad10_2D_SUPG::computeGradUMatrix(), oofem::Shell7Base::computeInterLaminarStressesAt(), oofem::Shell7Base::computeLinearizedStiffness(), oofem::Structural2DElement::computeLoadLEToLRotationMatrix(), oofem::QTrPlaneStrainGrad::computeNkappaMatrixAt(), oofem::QPlaneStressGrad::computeNkappaMatrixAt(), oofem::QPlaneStrainGrad::computeNkappaMatrixAt(), oofem::QTrPlaneStressGrad::computeNkappaMatrixAt(), oofem::QTRSpaceGrad::computeNkappaMatrixAt(), oofem::QTruss1dGrad::computeNkappaMatrixAt(), oofem::QWedgeGrad::computeNkappaMatrixAt(), oofem::QSpaceGrad::computeNkappaMatrixAt(), oofem::PlaneStressStructuralElementEvaluator::computeNMatrixAt(), oofem::Space3dStructuralElementEvaluator::computeNMatrixAt(), oofem::IntElLine2::computeNmatrixAt(), oofem::IntElSurfTr1::computeNmatrixAt(), oofem::IntElLine1PhF::computeNmatrixAt(), oofem::IntElLine1::computeNmatrixAt(), oofem::IntElLine1PF::computeNmatrixAt(), oofem::Tet1_3D_SUPG::computeNpMatrix(), oofem::TR21_2D_SUPG::computeNpMatrix(), oofem::Quad10_2D_SUPG::computeNpMatrix(), oofem::Tet1_3D_SUPG::computeNuMatrix(), oofem::TR21_2D_SUPG::computeNuMatrix(), oofem::Quad10_2D_SUPG::computeNuMatrix(), oofem::TR1_2D_SUPG2_AXI::computeNVector(), oofem::TR1_2D_SUPG2::computeNVector(), oofem::Shell7BaseXFEM::computePressureTangentMatrixDis(), oofem::TrAxisym1_ht::computeRadiusAt(), oofem::StructuralElement::computeResultingIPEigenstrainAt(), oofem::StructuralElement::computeResultingIPTemperatureAt(), oofem::Shell7BaseXFEM::computeSectionalForcesAt(), oofem::Shell7Base::computeSectionalForcesAt(), oofem::DKTPlate::computeShearForces(), oofem::B3Material::computeShrinkageStrainVector(), oofem::IDNLMaterial::computeStressBasedWeight(), oofem::IDNLMaterial::computeStressBasedWeightForPeriodicCell(), oofem::StructuralMaterial::computeStressIndependentStrainVector(), oofem::StructuralMaterial::computeStressIndependentStrainVector_3d(), oofem::Shell7Base::computeStressMatrix(), oofem::Structural3DElement::computeStressVector(), oofem::PlaneStressElement::computeStressVector(), oofem::PlaneStrainElement::computeStressVector(), oofem::AxisymElement::computeStressVector(), oofem::Beam3d::computeSubSoilNMatrixAt(), oofem::TrPlaneStrRot3d::computeSurfaceNMatrixAt(), oofem::Structural3DElement::computeSurfaceNMatrixAt(), oofem::CCTPlate3d::computeSurfaceNMatrixAt(), oofem::QDKTPlate::computeSurfaceNMatrixAt(), oofem::DKTPlate3d::computeSurfaceNMatrixAt(), oofem::Tria1PlateSubSoil::computeSurfaceNMatrixAt(), oofem::Quad1PlateSubSoil::computeSurfaceNMatrixAt(), oofem::DKTPlate::computeSurfaceNMatrixAt(), oofem::MITC4Shell::computeSurfaceNMatrixAt(), oofem::QBrick1_ht::computeSurfaceVolumeAround(), oofem::Tetrah1_ht::computeSurfaceVolumeAround(), oofem::Brick1_ht::computeSurfaceVolumeAround(), oofem::Structural3DElement::computeSurfaceVolumeAround(), oofem::StructuralElement::computeSurfaceVolumeAround(), oofem::Shell7Base::computeThicknessMappingCoeff(), oofem::Tet1_3D_SUPG::computeUDotGradUMatrix(), oofem::TR21_2D_SUPG::computeUDotGradUMatrix(), oofem::Quad10_2D_SUPG::computeUDotGradUMatrix(), oofem::TrAxisym1_ht::computeVolumeAround(), oofem::QuadAxisym1_ht::computeVolumeAround(), oofem::Tr_Warp::computeVolumeAround(), oofem::PlaneStressStructuralElementEvaluator::computeVolumeAround(), oofem::Space3dStructuralElementEvaluator::computeVolumeAround(), oofem::Tetrah1_ht::computeVolumeAround(), oofem::Quad1_ht::computeVolumeAround(), oofem::Tr1_ht::computeVolumeAround(), oofem::QBrick1_ht::computeVolumeAround(), oofem::Brick1_ht::computeVolumeAround(), oofem::InterfaceElem2dLin::computeVolumeAround(), oofem::InterfaceElement3dTrLin::computeVolumeAround(), oofem::Wedge_ht::computeVolumeAround(), oofem::QWedge_ht::computeVolumeAround(), oofem::Tet1_3D_SUPG::computeVolumeAround(), oofem::QTruss1d::computeVolumeAround(), oofem::Structural3DElement::computeVolumeAround(), oofem::Tr21Stokes::computeVolumeAround(), oofem::Tr1BubbleStokes::computeVolumeAround(), oofem::Truss3d::computeVolumeAround(), oofem::TrPlaneStrRot3d::computeVolumeAround(), oofem::Truss1d::computeVolumeAround(), oofem::LineDistributedSpring::computeVolumeAround(), oofem::Tet1BubbleStokes::computeVolumeAround(), oofem::TrPlanestressRotAllman3d::computeVolumeAround(), oofem::Structural2DElement::computeVolumeAround(), oofem::Tria1PlateSubSoil::computeVolumeAround(), oofem::Quad1PlateSubSoil::computeVolumeAround(), oofem::tet21ghostsolid::computeVolumeAround(), oofem::Quad1Mindlin::computeVolumeAround(), oofem::Quad1MindlinShell3D::computeVolumeAround(), oofem::CCTPlate::computeVolumeAround(), oofem::TR1_2D_PFEM::computeVolumeAround(), oofem::QDKTPlate::computeVolumeAround(), oofem::DKTPlate::computeVolumeAround(), oofem::TR21_2D_SUPG::computeVolumeAround(), oofem::AxisymElement::computeVolumeAround(), oofem::Quad10_2D_SUPG::computeVolumeAround(), oofem::Tr2Shell7XFEM::computeVolumeAroundLayer(), oofem::Tr2Shell7::computeVolumeAroundLayer(), oofem::Shell7Base::CopyIPvaluesToNodes(), oofem::Shell7BaseXFEM::discComputeBulkTangentMatrix(), oofem::Shell7BaseXFEM::discComputeStiffness(), oofem::Shell7Base::edgeComputeLengthAround(), oofem::GeometryBasedEI::evaluateEnrFuncJumps(), oofem::IntegrationRule::findIntegrationPointClosestTo(), oofem::VariableCrossSection::give(), oofem::PlaneStress2d::giveCharacteristicSize(), oofem::AbaqusUserMaterial::giveFirstPKStressVector_3d(), oofem::B3SolidMaterial::giveHumidity(), oofem::MPSMaterial::giveHumidity(), oofem::B3SolidMaterial::giveHumidityIncrement(), oofem::IDGMaterial::giveInternalLength(), oofem::tet21ghostsolid::giveIPValue(), oofem::StructuralMaterial::giveIPValue(), oofem::Shell7Base::giveL2contribution(), oofem::LayeredCrossSection::giveLayer(), oofem::MITC4Shell::giveMidplaneIPValue(), oofem::AbaqusUserMaterial::giveRealStressVector_3d(), oofem::LinearElasticMaterial::giveRealStressVector_Warping(), oofem::LayeredCrossSection::giveSlaveGaussPoint(), oofem::MisesMat::giveTemperature(), oofem::MPSMaterial::giveTemperature(), oofem::SimpleCrossSection::giveTemperatureVector(), oofem::Inclusion::isMaterialModified(), oofem::Tet1_3D_SUPG::LS_PCS_computedN(), oofem::MMAShapeFunctProjection::mapVariable(), oofem::NonlocalMaterialExtensionInterface::modifyNonlocalWeightFunction_1D_Around(), oofem::MisesMatNl::modifyNonlocalWeightFunctionAround(), oofem::NonlocalMaterialExtensionInterface::modifyNonlocalWeightFunctionAround(), oofem::Shell7Base::nodalLeastSquareFitFromIP(), oofem::NonlocalMaterialExtensionInterface::rebuildNonlocalPointTable(), oofem::Shell7BaseXFEM::recoverValuesFromCZIP(), oofem::IntegrationRule::saveContext(), oofem::DiscontinuousSegmentIntegrationRule::SetUpPointsOnLine(), oofem::PatchIntegrationRule::SetUpPointsOnTriangle(), oofem::PatchIntegrationRule::SetUpPointsOnWedge(), oofem::XfemElementInterface::XfemElementInterface_createEnrBHmatrixAt(), oofem::XfemElementInterface::XfemElementInterface_createEnrBmatrixAt(), oofem::Shell7Base::ZZNodalRecoveryMI_ComputeEstimatedInterpolationMtrx(), oofem::Tr_Warp::ZZNodalRecoveryMI_computeNNMatrix(), and oofem::Tr_Warp::ZZNodalRecoveryMI_computeNValProduct().

int oofem::GaussPoint::giveNumber ( )
inline

Returns number of receiver.

Definition at line 184 of file gausspoint.h.

Referenced by oofem::CompoDamageMat::checkSnapBack(), oofem::MPlasticMaterial::closestPointReturn(), oofem::MPlasticMaterial2::closestPointReturn(), oofem::MicroplaneMaterial::computeNormalStrainComponent(), oofem::MicroplaneMaterial::computeShearLStrainComponent(), oofem::MicroplaneMaterial::computeShearMStrainComponent(), oofem::MicroplaneMaterial::computeStrainVectorComponents(), oofem::Concrete3::computeStrength(), oofem::RCSDEMaterial::computeStrength(), oofem::RCSDMaterial::computeStrength(), oofem::MPlasticMaterial::cuttingPlaneReturn(), oofem::MPlasticMaterial2::cuttingPlaneReturn(), oofem::Material::give(), oofem::LayeredCrossSection::giveCharMaterialStiffnessMatrix(), oofem::FiberedCrossSection::giveFiberMaterialStiffnessMatrix(), oofem::RVEStokesFlow::giveFluxVector(), oofem::TR_SHELL01::giveIPValue(), oofem::TR_SHELL02::giveIPValue(), oofem::MITC4Shell::giveIPValue(), oofem::LayeredCrossSection::giveIPValue(), oofem::MicroplaneMaterial::giveMicroplaneIntegrationWeight(), oofem::MicroplaneMaterial::giveMicroplaneNormal(), oofem::LayeredCrossSection::giveRealStress_3d(), oofem::PlasticMaterial::giveRealStressVector(), oofem::MDM::giveRealStressVector(), oofem::LayeredCrossSection::giveStiffnessMatrix_3d(), oofem::Material::modifyProperty(), oofem::NonlocalMaterialExtensionInterface::rebuildNonlocalPointTable(), oofem::HydratingHeMoMaterial::updateInternalState(), and oofem::HydratingIsoHeatMaterial::updateInternalState().

GaussPoint * oofem::GaussPoint::giveSlaveGaussPoint ( int  index)

Returns index-th slave gauss point of receiver.

Parameters
indexIndex of returned slave.
Returns
Slave gp.

Definition at line 106 of file gausspoint.C.

References gaussPoints, and OOFEM_ERROR.

Referenced by oofem::MicroplaneMaterial::giveMicroplane(), oofem::FiberedCrossSection::giveSlaveGaussPoint(), and oofem::LayeredCrossSection::giveSlaveGaussPoint().

virtual double oofem::GaussPoint::giveWeight ( )
inlinevirtual

Returns integration weight of receiver.

Reimplemented in oofem::Microplane.

Definition at line 181 of file gausspoint.h.

Referenced by oofem::PrescribedGradientBCWeak::assembleTangentGPContributionNew(), oofem::IntElSurfTr1::computeAreaAround(), oofem::IntElLine1PhF::computeAreaAround(), oofem::IntElLine1PF::computeAreaAround(), oofem::IntElLine1::computeAreaAround(), oofem::Tr2Shell7XFEM::computeAreaAround(), oofem::Tr2Shell7::computeAreaAround(), oofem::XfemStructuralElementInterface::computeCohesiveForces(), oofem::XfemStructuralElementInterface::computeCohesiveTangent(), oofem::TrAxisym1_ht::computeEdgeVolumeAround(), oofem::QuadAxisym1_ht::computeEdgeVolumeAround(), oofem::Tr1Darcy::computeEdgeVolumeAround(), oofem::QBrick1_ht::computeEdgeVolumeAround(), oofem::Tr1_ht::computeEdgeVolumeAround(), oofem::Quad1_ht::computeEdgeVolumeAround(), oofem::Tetrah1_ht::computeEdgeVolumeAround(), oofem::Structural3DElement::computeEdgeVolumeAround(), oofem::Wedge_ht::computeEdgeVolumeAround(), oofem::QWedge_ht::computeEdgeVolumeAround(), oofem::LIBeam2d::computeEdgeVolumeAround(), oofem::Brick1_ht::computeEdgeVolumeAround(), oofem::DKTPlate3d::computeEdgeVolumeAround(), oofem::LIBeam2dNL::computeEdgeVolumeAround(), oofem::Structural2DElement::computeEdgeVolumeAround(), oofem::LIBeam3d::computeEdgeVolumeAround(), oofem::CCTPlate::computeEdgeVolumeAround(), oofem::Tr_Warp::computeEdgeVolumeAround(), oofem::Truss3d::computeEdgeVolumeAround(), oofem::LIBeam3dNL2::computeEdgeVolumeAround(), oofem::LIBeam3dNL::computeEdgeVolumeAround(), oofem::Quad1Mindlin::computeEdgeVolumeAround(), oofem::Truss2d::computeEdgeVolumeAround(), oofem::DKTPlate::computeEdgeVolumeAround(), oofem::QDKTPlate::computeEdgeVolumeAround(), oofem::PFEMElement2d::computeEdgeVolumeAround(), oofem::LIBeam3d2::computeEdgeVolumeAround(), oofem::Quad1MindlinShell3D::computeEdgeVolumeAround(), oofem::AxisymElement::computeEdgeVolumeAround(), oofem::MITC4Shell::computeEdgeVolumeAround(), oofem::StructuralElement::computeEdgeVolumeAround(), oofem::QBrick1_ht::computeSurfaceVolumeAround(), oofem::Tetrah1_ht::computeSurfaceVolumeAround(), oofem::Brick1_ht::computeSurfaceVolumeAround(), oofem::Structural3DElement::computeSurfaceVolumeAround(), oofem::MITC4Shell::computeSurfaceVolumeAround(), oofem::StructuralElement::computeSurfaceVolumeAround(), oofem::TrAxisym1_ht::computeVolumeAround(), oofem::QuadAxisym1_ht::computeVolumeAround(), oofem::Tr_Warp::computeVolumeAround(), oofem::PlaneStressStructuralElementEvaluator::computeVolumeAround(), oofem::Space3dStructuralElementEvaluator::computeVolumeAround(), oofem::Tetrah1_ht::computeVolumeAround(), oofem::Tr1_ht::computeVolumeAround(), oofem::Quad1_ht::computeVolumeAround(), oofem::Brick1_ht::computeVolumeAround(), oofem::QBrick1_ht::computeVolumeAround(), oofem::InterfaceElem2dLin::computeVolumeAround(), oofem::InterfaceElement3dTrLin::computeVolumeAround(), oofem::Wedge_ht::computeVolumeAround(), oofem::InterfaceElem2dQuad::computeVolumeAround(), oofem::QWedge_ht::computeVolumeAround(), oofem::Tet1_3D_SUPG::computeVolumeAround(), oofem::QTruss1d::computeVolumeAround(), oofem::LIBeam3d::computeVolumeAround(), oofem::Structural3DElement::computeVolumeAround(), oofem::Tr21Stokes::computeVolumeAround(), oofem::LIBeam2dNL::computeVolumeAround(), oofem::Tr1BubbleStokes::computeVolumeAround(), oofem::TrPlaneStrRot3d::computeVolumeAround(), oofem::Truss3d::computeVolumeAround(), oofem::LIBeam2d::computeVolumeAround(), oofem::Truss1d::computeVolumeAround(), oofem::LIBeam3dNL2::computeVolumeAround(), oofem::LineDistributedSpring::computeVolumeAround(), oofem::Tet1BubbleStokes::computeVolumeAround(), oofem::LIBeam3dNL::computeVolumeAround(), oofem::TrPlanestressRotAllman3d::computeVolumeAround(), oofem::Structural2DElement::computeVolumeAround(), oofem::Tria1PlateSubSoil::computeVolumeAround(), oofem::Quad1PlateSubSoil::computeVolumeAround(), oofem::tet21ghostsolid::computeVolumeAround(), oofem::Lattice2d::computeVolumeAround(), oofem::TR1_2D_SUPG_AXI::computeVolumeAround(), oofem::Truss2d::computeVolumeAround(), oofem::LIBeam3d2::computeVolumeAround(), oofem::Quad1Mindlin::computeVolumeAround(), oofem::Quad1MindlinShell3D::computeVolumeAround(), oofem::CCTPlate::computeVolumeAround(), oofem::TR1_2D_PFEM::computeVolumeAround(), oofem::QDKTPlate::computeVolumeAround(), oofem::Beam2d::computeVolumeAround(), oofem::MITC4Shell::computeVolumeAround(), oofem::TR21_2D_SUPG::computeVolumeAround(), oofem::DKTPlate::computeVolumeAround(), oofem::AxisymElement::computeVolumeAround(), oofem::TR1_2D_SUPG::computeVolumeAround(), oofem::Beam3d::computeVolumeAround(), oofem::Quad10_2D_SUPG::computeVolumeAround(), oofem::TR1_2D_SUPG2_AXI::computeVolumeAroundID(), oofem::TR1_2D_SUPG2::computeVolumeAroundID(), oofem::Tr2Shell7XFEM::computeVolumeAroundLayer(), oofem::Tr2Shell7::computeVolumeAroundLayer(), oofem::HTSelement::computeVolumeAroundSide(), oofem::Shell7Base::edgeComputeLengthAround(), oofem::MITC4Shell::giveMidplaneIPValue(), oofem::IntegrationRule::saveContext(), oofem::DiscontinuousSegmentIntegrationRule::SetUpPointsOnLine(), and oofem::PatchIntegrationRule::SetUpPointsOnTriangle().

bool oofem::GaussPoint::hasSlaveGaussPoint ( )

True if gauss point has slave points.

Otherwise false.

Definition at line 124 of file gausspoint.C.

References gaussPoints.

Referenced by oofem::LayeredCrossSection::giveMaterial().

virtual IRResultType oofem::GaussPoint::initializeFrom ( InputRecord ir)
inlinevirtual

Initializes receiver according to object description stored in input record.

Reimplemented in oofem::Microplane.

Definition at line 291 of file gausspoint.h.

References oofem::IRRT_OK.

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

Prints output of receiver to file.

Corresponding printOutputAt function for associated status is called. The same function is also invoked for all available slaves of receiver.

Reimplemented in oofem::Microplane.

Definition at line 78 of file gausspoint.C.

References gaussPoints, giveMaterialStatus(), oofem::IntegrationRule::giveNumber(), irule, number, and oofem::IntegrationPointStatus::printOutputAt().

Referenced by oofem::IntegrationRule::printOutputAt().

void oofem::GaussPoint::setGlobalCoordinates ( const FloatArray iCoord)
inline
void oofem::GaussPoint::setMaterialMode ( MaterialMode  newMode)
inline

Sets material mode of receiver.

Definition at line 193 of file gausspoint.h.

Referenced by oofem::tet21ghostsolid::giveIPValue().

IntegrationPointStatus* oofem::GaussPoint::setMaterialStatus ( IntegrationPointStatus ptr,
int  n 
)
inline

Sets Material status managed by receiver.

Parameters
ptrPointer to new status of receiver.
Returns
Pointer to new status.
Deprecated:
should be removed since only one mat stat is saved in the integration point

Definition at line 213 of file gausspoint.h.

Referenced by oofem::LayeredCrossSection::createMaterialStatus(), oofem::SimpleCrossSection::createMaterialStatus(), oofem::FiberedCrossSection::createMaterialStatus(), oofem::MicroplaneMaterial::giveMicroplaneStatus(), oofem::ConcreteFCM::giveStatus(), oofem::IsotropicDamageMaterial1::giveStatus(), and oofem::LatticeDamage2d::giveStatus().

IntegrationPointStatus* oofem::GaussPoint::setMaterialStatus ( IntegrationPointStatus ptr)
inline

Sets Material status managed by receiver.

Parameters
ptrPointer to new status of receiver.
Returns
Pointer to new status.

Definition at line 223 of file gausspoint.h.

References OOFEM_ERROR.

void oofem::GaussPoint::setWeight ( double  w)
inline
void oofem::GaussPoint::updateYourself ( TimeStep tStep)
virtual

Updates internal state of receiver after finishing time step.

Material::updateYourself (receiver, tStep) function is called to update material status. Same function is also invoked for all receiver's slaves.

Definition at line 141 of file gausspoint.C.

References gaussPoints, giveMaterialStatus(), and oofem::IntegrationPointStatus::updateYourself().

Referenced by oofem::MDM::MMI_update(), oofem::IsotropicDamageMaterial1::MMI_update(), oofem::StructuralMaterialEvaluator::solveYourself(), oofem::FluidMaterialEvaluator::solveYourself(), and oofem::IntegrationRule::updateYourself().

Friends And Related Function Documentation

friend class FiberedCrossSection
friend

Definition at line 295 of file gausspoint.h.

friend class LayeredCrossSection
friend

Definition at line 293 of file gausspoint.h.

friend class MicroplaneMaterial
friend

Definition at line 294 of file gausspoint.h.

Member Data Documentation

FloatArray* oofem::GaussPoint::globalCoordinates
private

Optional global (Cartesian) coordinates.

Definition at line 105 of file gausspoint.h.

Referenced by GaussPoint(), and ~GaussPoint().

IntegrationRule* oofem::GaussPoint::irule
private

Reference to parent integration rule.

Definition at line 99 of file gausspoint.h.

Referenced by printOutputAt().

MaterialMode oofem::GaussPoint::materialMode
private

Material mode of receiver.

Definition at line 109 of file gausspoint.h.

IntegrationPointStatus* oofem::GaussPoint::materialStatus
protected

Status of e.g. material in point.

Definition at line 116 of file gausspoint.h.

Referenced by GaussPoint(), and ~GaussPoint().

FloatArray oofem::GaussPoint::naturalCoordinates
private

Natural Element Coordinates of receiver.

Definition at line 101 of file gausspoint.h.

int oofem::GaussPoint::number
private

Number.

Definition at line 97 of file gausspoint.h.

Referenced by printOutputAt().

FloatArray* oofem::GaussPoint::subPatchCoordinates
private

Optional local sub-patch (sub-patches form element volume) coordinates of the receiver.

Definition at line 103 of file gausspoint.h.

Referenced by GaussPoint(), and ~GaussPoint().

double oofem::GaussPoint::weight
private

Integration weight.

Definition at line 107 of file gausspoint.h.

Referenced by oofem::IDNLMaterial::computeEquivalentStrain().


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:36 for OOFEM by doxygen 1.8.11 written by Dimitri van Heesch, © 1997-2011