![]() |
KratosMultiphysics
KRATOS Multiphysics (Kratos) is a framework for building parallel, multi-disciplinary simulation software, aiming at modularity, extensibility, and high performance. Kratos is written in C++, and counts with an extensive Python interface.
|
#include <linear_elastic_3D_law.hpp>
Public Types | |
typedef ProcessInfo | ProcessInfoType |
typedef ConstitutiveLaw | BaseType |
typedef std::size_t | SizeType |
typedef ProcessInfo | ProcessInfoType |
typedef ConstitutiveLaw | BaseType |
typedef std::size_t | SizeType |
typedef ProcessInfo | ProcessInfoType |
typedef ConstitutiveLaw | BaseType |
typedef std::size_t | SizeType |
![]() | |
typedef ProcessInfo | ProcessInfoType |
typedef ConstitutiveLaw | BaseType |
typedef std::size_t | SizeType |
typedef ProcessInfo | ProcessInfoType |
typedef ConstitutiveLaw | BaseType |
typedef std::size_t | SizeType |
typedef ProcessInfo | ProcessInfoType |
typedef ConstitutiveLaw | BaseType |
typedef std::size_t | SizeType |
![]() | |
enum | StrainMeasure { StrainMeasure_Infinitesimal , StrainMeasure_GreenLagrange , StrainMeasure_Almansi , StrainMeasure_Hencky_Material , StrainMeasure_Hencky_Spatial , StrainMeasure_Deformation_Gradient , StrainMeasure_Right_CauchyGreen , StrainMeasure_Left_CauchyGreen , StrainMeasure_Velocity_Gradient } |
enum | StressMeasure { StressMeasure_PK1 , StressMeasure_PK2 , StressMeasure_Kirchhoff , StressMeasure_Cauchy } |
typedef ProcessInfo | ProcessInfoType |
typedef std::size_t | SizeType |
typedef Geometry< Node > | GeometryType |
typedef Vector | StrainVectorType |
typedef Vector | StressVectorType |
typedef Matrix | VoigtSizeMatrixType |
typedef Matrix | DeformationGradientMatrixType |
![]() | |
enum | FlagsList { Flag0 = BlockType(1) , Flag1 = BlockType(1) << 1 , Flag2 = BlockType(1) << 2 , Flag3 = BlockType(1) << 3 , Flag4 = BlockType(1) << 4 , Flag5 = BlockType(1) << 5 , Flag6 = BlockType(1) << 6 , Flag7 = BlockType(1) << 7 , Flag8 = BlockType(1) << 8 , Flag9 = BlockType(1) << 9 , Flag10 = BlockType(1) << 10 , Flag11 = BlockType(1) << 11 , Flag12 = BlockType(1) << 12 , Flag13 = BlockType(1) << 13 , Flag14 = BlockType(1) << 14 , Flag15 = BlockType(1) << 15 , Flag16 = BlockType(1) << 16 , Flag17 = BlockType(1) << 17 , Flag18 = BlockType(1) << 18 , Flag19 = BlockType(1) << 19 , Flag20 = BlockType(1) << 20 , Flag21 = BlockType(1) << 21 , Flag22 = BlockType(1) << 22 , Flag23 = BlockType(1) << 23 , Flag24 = BlockType(1) << 24 , Flag25 = BlockType(1) << 25 , Flag26 = BlockType(1) << 26 , Flag27 = BlockType(1) << 27 , Flag28 = BlockType(1) << 28 , Flag29 = BlockType(1) << 29 , Flag30 = BlockType(1) << 30 } |
typedef int64_t | BlockType |
typedef int64_t | FlagType |
typedef std::size_t | IndexType |
Public Member Functions | |
KRATOS_CLASS_POINTER_DEFINITION (LinearElastic3DLaw) | |
LinearElastic3DLaw () | |
ConstitutiveLaw::Pointer | Clone () const override |
LinearElastic3DLaw (const LinearElastic3DLaw &rOther) | |
~LinearElastic3DLaw () override | |
void | GetLawFeatures (Features &rFeatures) override |
void | CalculateMaterialResponsePK2 (Parameters &rValues) override |
void | CalculateMaterialResponseKirchhoff (Parameters &rValues) override |
int | Check (const Properties &rMaterialProperties, const GeometryType &rElementGeometry, const ProcessInfo &rCurrentProcessInfo) const override |
KRATOS_CLASS_POINTER_DEFINITION (LinearElastic3DLaw) | |
LinearElastic3DLaw () | |
ConstitutiveLaw::Pointer | Clone () const override |
LinearElastic3DLaw (const LinearElastic3DLaw &rOther) | |
~LinearElastic3DLaw () override | |
void | GetLawFeatures (Features &rFeatures) override |
void | CalculateMaterialResponsePK2 (Parameters &rValues) override |
void | CalculateMaterialResponseKirchhoff (Parameters &rValues) override |
int | Check (const Properties &rMaterialProperties, const GeometryType &rElementGeometry, const ProcessInfo &rCurrentProcessInfo) const override |
KRATOS_CLASS_POINTER_DEFINITION (LinearElastic3DLaw) | |
LinearElastic3DLaw () | |
ConstitutiveLaw::Pointer | Clone () const override |
LinearElastic3DLaw (const LinearElastic3DLaw &rOther) | |
~LinearElastic3DLaw () override | |
void | GetLawFeatures (Features &rFeatures) override |
void | CalculateMaterialResponsePK2 (Parameters &rValues) override |
void | CalculateMaterialResponseKirchhoff (Parameters &rValues) override |
int | Check (const Properties &rMaterialProperties, const GeometryType &rElementGeometry, const ProcessInfo &rCurrentProcessInfo) const override |
![]() | |
KRATOS_CLASS_POINTER_DEFINITION (HyperElastic3DLaw) | |
HyperElastic3DLaw () | |
HyperElastic3DLaw (const HyperElastic3DLaw &rOther) | |
~HyperElastic3DLaw () override | |
SizeType | WorkingSpaceDimension () override |
SizeType | GetStrainSize () const override |
bool | Has (const Variable< double > &rThisVariable) override |
Returns whether this constitutive Law has specified variable (double) More... | |
bool | Has (const Variable< Vector > &rThisVariable) override |
Returns whether this constitutive Law has specified variable (Vector) More... | |
bool | Has (const Variable< Matrix > &rThisVariable) override |
Returns whether this constitutive Law has specified variable (Matrix) More... | |
Vector & | GetValue (const Variable< Vector > &rThisVariable, Vector &rValue) override |
Returns the value of a specified variable (Vector) More... | |
Matrix & | GetValue (const Variable< Matrix > &rThisVariable, Matrix &rValue) override |
Returns the value of a specified variable (Matrix) More... | |
void | SetValue (const Variable< double > &rVariable, const double &rValue, const ProcessInfo &rCurrentProcessInfo) override |
Sets the value of a specified variable (double) More... | |
void | SetValue (const Variable< Vector > &rThisVariable, const Vector &rValue, const ProcessInfo &rCurrentProcessInfo) override |
Sets the value of a specified variable (Vector) More... | |
void | SetValue (const Variable< Matrix > &rThisVariable, const Matrix &rValue, const ProcessInfo &rCurrentProcessInfo) override |
Sets the value of a specified variable (Matrix) More... | |
void | InitializeMaterial (const Properties &rMaterialProperties, const GeometryType &rElementGeometry, const Vector &rShapeFunctionsValues) override |
void | CalculateMaterialResponseCauchy (Parameters &rValues) override |
void | FinalizeMaterialResponseKirchhoff (Parameters &rValues) override |
void | FinalizeMaterialResponseCauchy (Parameters &rValues) override |
KRATOS_CLASS_POINTER_DEFINITION (HyperElastic3DLaw) | |
HyperElastic3DLaw () | |
HyperElastic3DLaw (const HyperElastic3DLaw &rOther) | |
~HyperElastic3DLaw () override | |
SizeType | WorkingSpaceDimension () override |
SizeType | GetStrainSize () const override |
bool | Has (const Variable< double > &rThisVariable) override |
Returns whether this constitutive Law has specified variable (double) More... | |
bool | Has (const Variable< Vector > &rThisVariable) override |
Returns whether this constitutive Law has specified variable (Vector) More... | |
bool | Has (const Variable< Matrix > &rThisVariable) override |
Returns whether this constitutive Law has specified variable (Matrix) More... | |
Vector & | GetValue (const Variable< Vector > &rThisVariable, Vector &rValue) override |
Returns the value of a specified variable (Vector) More... | |
Matrix & | GetValue (const Variable< Matrix > &rThisVariable, Matrix &rValue) override |
Returns the value of a specified variable (Matrix) More... | |
void | SetValue (const Variable< double > &rVariable, const double &rValue, const ProcessInfo &rCurrentProcessInfo) override |
Sets the value of a specified variable (double) More... | |
void | SetValue (const Variable< Vector > &rThisVariable, const Vector &rValue, const ProcessInfo &rCurrentProcessInfo) override |
Sets the value of a specified variable (Vector) More... | |
void | SetValue (const Variable< Matrix > &rThisVariable, const Matrix &rValue, const ProcessInfo &rCurrentProcessInfo) override |
Sets the value of a specified variable (Matrix) More... | |
void | InitializeMaterial (const Properties &rMaterialProperties, const GeometryType &rElementGeometry, const Vector &rShapeFunctionsValues) override |
void | CalculateMaterialResponsePK1 (Parameters &rValues) override |
void | CalculateMaterialResponseCauchy (Parameters &rValues) override |
void | FinalizeMaterialResponsePK1 (Parameters &rValues) override |
void | FinalizeMaterialResponsePK2 (Parameters &rValues) override |
void | FinalizeMaterialResponseKirchhoff (Parameters &rValues) override |
void | FinalizeMaterialResponseCauchy (Parameters &rValues) override |
KRATOS_CLASS_POINTER_DEFINITION (HyperElastic3DLaw) | |
HyperElastic3DLaw () | |
HyperElastic3DLaw (const HyperElastic3DLaw &rOther) | |
~HyperElastic3DLaw () override | |
SizeType | WorkingSpaceDimension () override |
SizeType | GetStrainSize () const override |
bool | Has (const Variable< double > &rThisVariable) override |
Returns whether this constitutive Law has specified variable (double) More... | |
bool | Has (const Variable< Vector > &rThisVariable) override |
Returns whether this constitutive Law has specified variable (Vector) More... | |
bool | Has (const Variable< Matrix > &rThisVariable) override |
Returns whether this constitutive Law has specified variable (Matrix) More... | |
Vector & | GetValue (const Variable< Vector > &rThisVariable, Vector &rValue) override |
Returns the value of a specified variable (Vector) More... | |
Matrix & | GetValue (const Variable< Matrix > &rThisVariable, Matrix &rValue) override |
Returns the value of a specified variable (Matrix) More... | |
void | SetValue (const Variable< double > &rVariable, const double &rValue, const ProcessInfo &rCurrentProcessInfo) override |
Sets the value of a specified variable (double) More... | |
void | SetValue (const Variable< Vector > &rThisVariable, const Vector &rValue, const ProcessInfo &rCurrentProcessInfo) override |
Sets the value of a specified variable (Vector) More... | |
void | SetValue (const Variable< Matrix > &rThisVariable, const Matrix &rValue, const ProcessInfo &rCurrentProcessInfo) override |
Sets the value of a specified variable (Matrix) More... | |
void | InitializeMaterial (const Properties &rMaterialProperties, const GeometryType &rElementGeometry, const Vector &rShapeFunctionsValues) override |
void | CalculateMaterialResponsePK1 (Parameters &rValues) override |
void | CalculateMaterialResponseCauchy (Parameters &rValues) override |
void | FinalizeMaterialResponsePK1 (Parameters &rValues) override |
void | FinalizeMaterialResponsePK2 (Parameters &rValues) override |
void | FinalizeMaterialResponseKirchhoff (Parameters &rValues) override |
void | FinalizeMaterialResponseCauchy (Parameters &rValues) override |
![]() | |
KRATOS_CLASS_POINTER_DEFINITION (ConstitutiveLaw) | |
KRATOS_DEFINE_LOCAL_FLAG (USE_ELEMENT_PROVIDED_STRAIN) | |
KRATOS_DEFINE_LOCAL_FLAG (COMPUTE_STRESS) | |
KRATOS_DEFINE_LOCAL_FLAG (COMPUTE_CONSTITUTIVE_TENSOR) | |
KRATOS_DEFINE_LOCAL_FLAG (COMPUTE_STRAIN_ENERGY) | |
KRATOS_DEFINE_LOCAL_FLAG (ISOCHORIC_TENSOR_ONLY) | |
KRATOS_DEFINE_LOCAL_FLAG (VOLUMETRIC_TENSOR_ONLY) | |
KRATOS_DEFINE_LOCAL_FLAG (MECHANICAL_RESPONSE_ONLY) | |
KRATOS_DEFINE_LOCAL_FLAG (THERMAL_RESPONSE_ONLY) | |
KRATOS_DEFINE_LOCAL_FLAG (INCREMENTAL_STRAIN_MEASURE) | |
KRATOS_DEFINE_LOCAL_FLAG (INITIALIZE_MATERIAL_RESPONSE) | |
KRATOS_DEFINE_LOCAL_FLAG (FINALIZE_MATERIAL_RESPONSE) | |
KRATOS_DEFINE_LOCAL_FLAG (FINITE_STRAINS) | |
KRATOS_DEFINE_LOCAL_FLAG (INFINITESIMAL_STRAINS) | |
KRATOS_DEFINE_LOCAL_FLAG (THREE_DIMENSIONAL_LAW) | |
KRATOS_DEFINE_LOCAL_FLAG (PLANE_STRAIN_LAW) | |
KRATOS_DEFINE_LOCAL_FLAG (PLANE_STRESS_LAW) | |
KRATOS_DEFINE_LOCAL_FLAG (AXISYMMETRIC_LAW) | |
KRATOS_DEFINE_LOCAL_FLAG (U_P_LAW) | |
KRATOS_DEFINE_LOCAL_FLAG (ISOTROPIC) | |
KRATOS_DEFINE_LOCAL_FLAG (ANISOTROPIC) | |
ConstitutiveLaw () | |
~ConstitutiveLaw () override | |
virtual Pointer | Create (Kratos::Parameters NewParameters) const |
It creates a new constitutive law pointer. More... | |
virtual Pointer | Create (Kratos::Parameters NewParameters, const Properties &rProperties) const |
It creates a new constitutive law pointer (version with properties) More... | |
void | SetInitialState (InitialState::Pointer pInitialState) |
InitialState::Pointer | pGetInitialState () |
InitialState & | GetInitialState () |
bool | HasInitialState () const |
template<typename TVectorType > | |
void | AddInitialStressVectorContribution (TVectorType &rStressVector) |
Adds the initial stress vector if it is defined in the InitialState. More... | |
template<typename TVectorType > | |
void | AddInitialStrainVectorContribution (TVectorType &rStrainVector) |
Adds the initial strain vector if it is defined in the InitialState. More... | |
template<typename TMatrixType > | |
void | AddInitialDeformationGradientMatrixContribution (TMatrixType &rF) |
Adds the initial strain vector if it is defined in the InitialState. More... | |
virtual bool | Has (const Variable< bool > &rThisVariable) |
Returns whether this constitutive Law has specified variable (boolean) More... | |
virtual bool | Has (const Variable< int > &rThisVariable) |
Returns whether this constitutive Law has specified variable (integer) More... | |
virtual bool | Has (const Variable< array_1d< double, 3 > > &rThisVariable) |
Returns whether this constitutive Law has specified variable (array of 3 components) More... | |
virtual bool | Has (const Variable< array_1d< double, 6 > > &rThisVariable) |
Returns whether this constitutive Law has specified variable (array of 6 components) More... | |
virtual bool & | GetValue (const Variable< bool > &rThisVariable, bool &rValue) |
Returns the value of a specified variable (boolean) More... | |
virtual int & | GetValue (const Variable< int > &rThisVariable, int &rValue) |
virtual array_1d< double, 3 > & | GetValue (const Variable< array_1d< double, 3 > > &rThisVariable, array_1d< double, 3 > &rValue) |
Returns the value of a specified variable (array of 3 components) More... | |
virtual array_1d< double, 6 > & | GetValue (const Variable< array_1d< double, 6 > > &rThisVariable, array_1d< double, 6 > &rValue) |
Returns the value of a specified variable (array of 6 components) More... | |
virtual void | SetValue (const Variable< bool > &rVariable, const bool &Value, const ProcessInfo &rCurrentProcessInfo) |
Sets the value of a specified variable (boolean) More... | |
virtual void | SetValue (const Variable< int > &rVariable, const int &Value, const ProcessInfo &rCurrentProcessInfo) |
Sets the value of a specified variable (integer) More... | |
virtual void | SetValue (const Variable< array_1d< double, 3 > > &rVariable, const array_1d< double, 3 > &rValue, const ProcessInfo &rCurrentProcessInfo) |
Sets the value of a specified variable (array of 3 components) More... | |
virtual void | SetValue (const Variable< array_1d< double, 6 > > &rVariable, const array_1d< double, 6 > &rValue, const ProcessInfo &rCurrentProcessInfo) |
Sets the value of a specified variable (array of 6 components) More... | |
virtual bool & | CalculateValue (Parameters &rParameterValues, const Variable< bool > &rThisVariable, bool &rValue) |
Calculates the value of a specified variable (bool) More... | |
virtual int & | CalculateValue (Parameters &rParameterValues, const Variable< int > &rThisVariable, int &rValue) |
Calculates the value of a specified variable (int) More... | |
virtual Vector & | CalculateValue (Parameters &rParameterValues, const Variable< Vector > &rThisVariable, Vector &rValue) |
Calculates the value of a specified variable (Vector) More... | |
virtual Matrix & | CalculateValue (Parameters &rParameterValues, const Variable< Matrix > &rThisVariable, Matrix &rValue) |
Calculates the value of a specified variable (Matrix) More... | |
virtual array_1d< double, 3 > & | CalculateValue (Parameters &rParameterValues, const Variable< array_1d< double, 3 > > &rVariable, array_1d< double, 3 > &rValue) |
Calculates the value of a specified variable (array of 3 components) More... | |
virtual array_1d< double, 6 > & | CalculateValue (Parameters &rParameterValues, const Variable< array_1d< double, 6 > > &rVariable, array_1d< double, 6 > &rValue) |
virtual void | CalculateDerivative (Parameters &rParameterValues, const Variable< double > &rFunctionVariable, const Variable< double > &rDerivativeVariable, double &rOutput) |
Calculates derivatives of a given function. More... | |
virtual void | CalculateDerivative (Parameters &rParameterValues, const Variable< Vector > &rFunctionVariable, const Variable< double > &rDerivativeVariable, Vector &rOutput) |
Calculates derivatives of a given function. More... | |
virtual void | CalculateDerivative (Parameters &rParameterValues, const Variable< Matrix > &rFunctionVariable, const Variable< double > &rDerivativeVariable, Matrix &rOutput) |
Calculates derivatives of a given function. More... | |
virtual void | CalculateDerivative (Parameters &rParameterValues, const Variable< array_1d< double, 3 >> &rFunctionVariable, const Variable< double > &rDerivativeVariable, array_1d< double, 3 > &rOutput) |
Calculates derivatives of a given function. More... | |
virtual bool | ValidateInput (const Properties &rMaterialProperties) |
virtual StrainMeasure | GetStrainMeasure () |
virtual StressMeasure | GetStressMeasure () |
virtual bool | IsIncremental () |
virtual void | InitializeSolutionStep (const Properties &rMaterialProperties, const GeometryType &rElementGeometry, const Vector &rShapeFunctionsValues, const ProcessInfo &rCurrentProcessInfo) |
virtual void | FinalizeSolutionStep (const Properties &rMaterialProperties, const GeometryType &rElementGeometry, const Vector &rShapeFunctionsValues, const ProcessInfo &rCurrentProcessInfo) |
virtual void | InitializeNonLinearIteration (const Properties &rMaterialProperties, const GeometryType &rElementGeometry, const Vector &rShapeFunctionsValues, const ProcessInfo &rCurrentProcessInfo) |
virtual void | FinalizeNonLinearIteration (const Properties &rMaterialProperties, const GeometryType &rElementGeometry, const Vector &rShapeFunctionsValues, const ProcessInfo &rCurrentProcessInfo) |
void | CalculateMaterialResponse (Parameters &rValues, const StressMeasure &rStressMeasure) |
virtual bool | RequiresInitializeMaterialResponse () |
If the CL requires to initialize the material response, called by the element in InitializeSolutionStep. More... | |
virtual void | CalculateStressResponse (Parameters &rValues, Vector &rInternalVariables) |
void | InitializeMaterialResponse (Parameters &rValues, const StressMeasure &rStressMeasure) |
Initialize the material response, called by the element in InitializeSolutionStep. More... | |
virtual void | InitializeMaterialResponsePK1 (Parameters &rValues) |
Initialize the material response in terms of 1st Piola-Kirchhoff stresses. More... | |
virtual void | InitializeMaterialResponsePK2 (Parameters &rValues) |
Initialize the material response in terms of 2nd Piola-Kirchhoff stresses. More... | |
virtual void | InitializeMaterialResponseKirchhoff (Parameters &rValues) |
Initialize the material response in terms of Kirchhoff stresses. More... | |
virtual void | InitializeMaterialResponseCauchy (Parameters &rValues) |
Initialize the material response in terms of Cauchy stresses. More... | |
virtual bool | RequiresFinalizeMaterialResponse () |
If the CL requires to finalize the material response, called by the element in FinalizeSolutionStep. More... | |
void | FinalizeMaterialResponse (Parameters &rValues, const StressMeasure &rStressMeasure) |
Finalize the material response, called by the element in FinalizeSolutionStep. More... | |
virtual void | ResetMaterial (const Properties &rMaterialProperties, const GeometryType &rElementGeometry, const Vector &rShapeFunctionsValues) |
virtual Vector & | TransformStrains (Vector &rStrainVector, const Matrix &rF, StrainMeasure rStrainInitial, StrainMeasure rStrainFinal) |
virtual Matrix & | TransformStresses (Matrix &rStressMatrix, const Matrix &rF, const double &rdetF, StressMeasure rStressInitial, StressMeasure rStressFinal) |
virtual Vector & | TransformStresses (Vector &rStressVector, const Matrix &rF, const double &rdetF, StressMeasure rStressInitial, StressMeasure rStressFinal) |
Vector & | TransformPK1Stresses (Vector &rStressVector, const Matrix &rF, const double &rdetF, StressMeasure rStressFinal) |
Vector & | TransformPK2Stresses (Vector &rStressVector, const Matrix &rF, const double &rdetF, StressMeasure rStressFinal) |
Vector & | TransformKirchhoffStresses (Vector &rStressVector, const Matrix &rF, const double &rdetF, StressMeasure rStressFinal) |
Vector & | TransformCauchyStresses (Vector &rStressVector, const Matrix &rF, const double &rdetF, StressMeasure rStressFinal) |
void | PullBackConstitutiveMatrix (Matrix &rConstitutiveMatrix, const Matrix &rF) |
void | PushForwardConstitutiveMatrix (Matrix &rConstitutiveMatrix, const Matrix &rF) |
virtual void | CalculateCauchyStresses (Vector &Cauchy_StressVector, const Matrix &F, const Vector &PK2_StressVector, const Vector &GreenLagrangeStrainVector) |
std::string | Info () const override |
Turn back information as a string. More... | |
void | PrintInfo (std::ostream &rOStream) const override |
Print information about this object. More... | |
void | PrintData (std::ostream &rOStream) const override |
Print object's data. More... | |
![]() | |
Flags & | operator= (Flags const &rOther) |
Assignment operator. More... | |
operator bool () const | |
Flags | operator~ () const |
bool | operator! () const |
void | AssignFlags (Flags const &rOther) |
void | Set (const Flags ThisFlag) |
void | Set (const Flags ThisFlag, bool Value) |
void | Reset (const Flags ThisFlag) |
void | Flip (const Flags ThisFlag) |
void | SetPosition (IndexType Position, bool Value=true) |
bool | GetPosition (IndexType Position) const |
void | FlipPosition (IndexType Position) |
void | ClearPosition (IndexType Position) |
void | Clear () |
Flags | AsFalse () const |
bool | Is (Flags const &rOther) const |
bool | IsDefined (Flags const &rOther) const |
bool | IsNot (Flags const &rOther) const |
bool | IsNotDefined (Flags const &rOther) const |
KRATOS_CLASS_POINTER_DEFINITION (Flags) | |
Pointer definition of Flags. More... | |
const Flags & | operator|= (const Flags &Other) |
const Flags & | operator&= (const Flags &Other) |
Flags () | |
Default constructor. More... | |
Flags (Flags const &rOther) | |
Copy constructor. More... | |
virtual | ~Flags () |
Destructor. More... | |
Protected Member Functions | |
virtual void | CalculateStress (const Vector &rStrainVector, const Matrix &rConstitutiveMatrix, Vector &rStressVector) |
virtual void | CalculateLinearElasticMatrix (Matrix &rConstitutiveMatrix, const double &rYoungModulus, const double &rPoissonCoefficient) |
double & | CalculateValue (Parameters &rParameterValues, const Variable< double > &rThisVariable, double &rValue) override |
Calculates the value of a specified variable (double) More... | |
double & | GetValue (const Variable< double > &rThisVariable, double &rValue) override |
Returns the value of a specified variable (double) More... | |
virtual void | CalculateStress (const Vector &rStrainVector, const Matrix &rConstitutiveMatrix, Vector &rStressVector) |
virtual void | CalculateLinearElasticMatrix (Matrix &rConstitutiveMatrix, const double &rYoungModulus, const double &rPoissonCoefficient) |
bool | CheckParameters (Parameters &rValues) override |
double & | CalculateValue (Parameters &rParameterValues, const Variable< double > &rThisVariable, double &rValue) override |
Calculates the value of a specified variable (double) More... | |
double & | GetValue (const Variable< double > &rThisVariable, double &rValue) override |
Returns the value of a specified variable (double) More... | |
virtual void | CalculateStress (const Vector &rStrainVector, const Matrix &rConstitutiveMatrix, Vector &rStressVector) |
virtual void | CalculateLinearElasticMatrix (Matrix &rConstitutiveMatrix, const double &rYoungModulus, const double &rPoissonCoefficient) |
bool | CheckParameters (Parameters &rValues) override |
double & | CalculateValue (Parameters &rParameterValues, const Variable< double > &rThisVariable, double &rValue) override |
Calculates the value of a specified variable (double) More... | |
double & | GetValue (const Variable< double > &rThisVariable, double &rValue) override |
Returns the value of a specified variable (double) More... | |
![]() | |
virtual void | CalculateGreenLagrangeStrain (const Matrix &rRightCauchyGreen, Vector &rStrainVector) |
virtual void | CalculateAlmansiStrain (const Matrix &rLeftCauchyGreen, Vector &rStrainVector) |
virtual double & | CalculateDomainTemperature (const MaterialResponseVariables &rElasticVariables, double &rTemperature) |
void | CalculateStress (const MaterialResponseVariables &rElasticVariables, StressMeasure rStressMeasure, Vector &rStressVector) |
virtual void | CalculateVolumetricStress (const MaterialResponseVariables &rElasticVariables, Vector &rVolStressVector) |
virtual void | CalculateIsochoricStress (const MaterialResponseVariables &rElasticVariables, StressMeasure rStressMeasure, Vector &rIsoStressVector) |
virtual void | CalculateConstitutiveMatrix (const MaterialResponseVariables &rElasticVariables, Matrix &rConstitutiveMatrix) |
double & | ConstitutiveComponent (double &rCabcd, const MaterialResponseVariables &rElasticVariables, const unsigned int &a, const unsigned int &b, const unsigned int &c, const unsigned int &d) |
virtual void | CalculateVolumetricConstitutiveMatrix (const MaterialResponseVariables &rElasticVariables, Matrix &rConstitutiveMatrix) |
double & | VolumetricConstitutiveComponent (double &rCabcd, const MaterialResponseVariables &rElasticVariables, const Vector &rFactors, const unsigned int &a, const unsigned int &b, const unsigned int &c, const unsigned int &d) |
virtual void | CalculateIsochoricConstitutiveMatrix (const MaterialResponseVariables &rElasticVariables, const Matrix &rIsoStressMatrix, Matrix &rConstitutiveMatrix) |
double & | IsochoricConstitutiveComponent (double &rCabcd, const MaterialResponseVariables &rElasticVariables, const Matrix &rIsoStressMatrix, const unsigned int &a, const unsigned int &b, const unsigned int &c, const unsigned int &d) |
virtual double & | CalculateVolumetricFactor (const MaterialResponseVariables &rElasticVariables, double &rFactor) |
virtual double & | CalculateVolumetricPressure (const MaterialResponseVariables &rElasticVariables, double &rPressure) |
virtual Vector & | CalculateVolumetricPressureFactors (const MaterialResponseVariables &rElasticVariables, Vector &rFactors) |
Matrix & | Transform2DTo3D (Matrix &rMatrix) |
virtual void | UpdateInternalVariables (Parameters &rValues) |
virtual void | CalculateGreenLagrangeStrain (const Matrix &rRightCauchyGreen, Vector &rStrainVector) |
virtual void | CalculateAlmansiStrain (const Matrix &rLeftCauchyGreen, Vector &rStrainVector) |
void | CalculateStress (const MaterialResponseVariables &rElasticVariables, StressMeasure rStressMeasure, Vector &rStressVector) |
virtual void | CalculateIsochoricStress (const MaterialResponseVariables &rElasticVariables, StressMeasure rStressMeasure, Vector &rIsoStressVector) |
virtual void | CalculateVolumetricStress (const MaterialResponseVariables &rElasticVariables, Vector &rVolStressVector) |
virtual void | CalculateConstitutiveMatrix (const MaterialResponseVariables &rElasticVariables, Matrix &rConstitutiveMatrix) |
double & | ConstitutiveComponent (double &rCabcd, const MaterialResponseVariables &rElasticVariables, const unsigned int &a, const unsigned int &b, const unsigned int &c, const unsigned int &d) |
virtual void | CalculateIsochoricConstitutiveMatrix (const MaterialResponseVariables &rElasticVariables, const Matrix &rIsoStressMatrix, Matrix &rConstitutiveMatrix) |
double & | IsochoricConstitutiveComponent (double &rCabcd, const MaterialResponseVariables &rElasticVariables, const Matrix &rIsoStressMatrix, const unsigned int &a, const unsigned int &b, const unsigned int &c, const unsigned int &d) |
virtual void | CalculateVolumetricConstitutiveMatrix (const MaterialResponseVariables &rElasticVariables, Matrix &rConstitutiveMatrix) |
double & | VolumetricConstitutiveComponent (double &rCabcd, const MaterialResponseVariables &rElasticVariables, const Vector &rFactors, const unsigned int &a, const unsigned int &b, const unsigned int &c, const unsigned int &d) |
virtual double & | CalculateVolumetricFactor (const MaterialResponseVariables &rElasticVariables, double &rFactor) |
virtual double & | CalculateVolumetricPressure (const MaterialResponseVariables &rElasticVariables, double &rPressure) |
virtual Vector & | CalculateVolumetricPressureFactors (const MaterialResponseVariables &rElasticVariables, Vector &rFactors) |
virtual double & | CalculateDomainTemperature (const MaterialResponseVariables &rElasticVariables, double &rTemperature) |
Matrix & | Transform2DTo3D (Matrix &rMatrix) |
virtual void | UpdateInternalVariables (Parameters &rValues) |
virtual void | CalculateGreenLagrangeStrain (const Matrix &rRightCauchyGreen, Vector &rStrainVector) |
virtual void | CalculateAlmansiStrain (const Matrix &rLeftCauchyGreen, Vector &rStrainVector) |
void | CalculateStress (const MaterialResponseVariables &rElasticVariables, StressMeasure rStressMeasure, Vector &rStressVector) |
virtual void | CalculateIsochoricStress (const MaterialResponseVariables &rElasticVariables, StressMeasure rStressMeasure, Vector &rIsoStressVector) |
virtual void | CalculateVolumetricStress (const MaterialResponseVariables &rElasticVariables, Vector &rVolStressVector) |
virtual void | CalculateConstitutiveMatrix (const MaterialResponseVariables &rElasticVariables, Matrix &rConstitutiveMatrix) |
double & | ConstitutiveComponent (double &rCabcd, const MaterialResponseVariables &rElasticVariables, const unsigned int &a, const unsigned int &b, const unsigned int &c, const unsigned int &d) |
virtual void | CalculateIsochoricConstitutiveMatrix (const MaterialResponseVariables &rElasticVariables, const Matrix &rIsoStressMatrix, Matrix &rConstitutiveMatrix) |
double & | IsochoricConstitutiveComponent (double &rCabcd, const MaterialResponseVariables &rElasticVariables, const Matrix &rIsoStressMatrix, const unsigned int &a, const unsigned int &b, const unsigned int &c, const unsigned int &d) |
virtual void | CalculateVolumetricConstitutiveMatrix (const MaterialResponseVariables &rElasticVariables, Matrix &rConstitutiveMatrix) |
double & | VolumetricConstitutiveComponent (double &rCabcd, const MaterialResponseVariables &rElasticVariables, const Vector &rFactors, const unsigned int &a, const unsigned int &b, const unsigned int &c, const unsigned int &d) |
virtual double & | CalculateVolumetricFactor (const MaterialResponseVariables &rElasticVariables, double &rFactor) |
virtual double & | CalculateVolumetricPressure (const MaterialResponseVariables &rElasticVariables, double &rPressure) |
virtual Vector & | CalculateVolumetricPressureFactors (const MaterialResponseVariables &rElasticVariables, Vector &rFactors) |
virtual double & | CalculateDomainTemperature (const MaterialResponseVariables &rElasticVariables, double &rTemperature) |
Matrix & | Transform2DTo3D (Matrix &rMatrix) |
virtual void | UpdateInternalVariables (Parameters &rValues) |
![]() | |
void | ContraVariantPushForward (Matrix &rMatrix, const Matrix &rF) |
void | ContraVariantPullBack (Matrix &rMatrix, const Matrix &rF) |
void | CoVariantPushForward (Matrix &rMatrix, const Matrix &rF) |
void | CoVariantPullBack (Matrix &rMatrix, const Matrix &rF) |
void | ConstitutiveMatrixTransformation (Matrix &rConstitutiveMatrix, const Matrix &rOriginalConstitutiveMatrix, const Matrix &rF) |
double & | TransformConstitutiveComponent (double &rCabcd, const Matrix &rConstitutiveMatrix, const Matrix &rF, const unsigned int &a, const unsigned int &b, const unsigned int &c, const unsigned int &d) |
double & | GetConstitutiveComponent (double &rCabcd, const Matrix &rConstitutiveMatrix, const unsigned int &a, const unsigned int &b, const unsigned int &c, const unsigned int &d) |
Serialization | |
class | Serializer |
Additional Inherited Members | |
![]() | |
static bool | HasSameType (const ConstitutiveLaw &rLHS, const ConstitutiveLaw &rRHS) |
This method is used to check that two Constitutive Laws are the same type (references) More... | |
static bool | HasSameType (const ConstitutiveLaw *rLHS, const ConstitutiveLaw *rRHS) |
This method is used to check that two Constitutive Laws are the same type (pointers) More... | |
![]() | |
static const Flags | AllDefined () |
static const Flags | AllTrue () |
static Flags | Create (IndexType ThisPosition, bool Value=true) |
![]() | |
Matrix | mInverseDeformationGradientF0 |
double | mDeterminantF0 |
double | mStrainEnergy |
![]() | |
static const unsigned int | msIndexVoigt3D6C [6][2] = { {0, 0}, {1, 1}, {2, 2}, {0, 1}, {1, 2}, {0, 2} } |
static const unsigned int | msIndexVoigt2D4C [4][2] = { {0, 0}, {1, 1}, {2, 2}, {0, 1} } |
static const unsigned int | msIndexVoigt2D3C [3][2] = { {0, 0}, {1, 1}, {0, 1} } |
Defines a linear isotropic constitutive law in 2D (Plane Strain) This material law is defined by the parameters: 1) YOUNG MODULUS 2) POISSON RATIO As there are no further parameters the functionality is valid for small and large displacements elasticity.
Type Definitions
Type Definitions
Type Definitions
typedef std::size_t Kratos::LinearElastic3DLaw::SizeType |
typedef std::size_t Kratos::LinearElastic3DLaw::SizeType |
typedef std::size_t Kratos::LinearElastic3DLaw::SizeType |
Kratos::LinearElastic3DLaw::LinearElastic3DLaw | ( | ) |
Life Cycle Default constructor.
Kratos::LinearElastic3DLaw::LinearElastic3DLaw | ( | const LinearElastic3DLaw & | rOther | ) |
Copy constructor.
|
override |
Assignment operator. Destructor.
Kratos::LinearElastic3DLaw::LinearElastic3DLaw | ( | ) |
Life Cycle Default constructor.
Kratos::LinearElastic3DLaw::LinearElastic3DLaw | ( | const LinearElastic3DLaw & | rOther | ) |
Copy constructor.
|
override |
Assignment operator. Destructor.
Kratos::LinearElastic3DLaw::LinearElastic3DLaw | ( | ) |
Life Cycle Default constructor.
Kratos::LinearElastic3DLaw::LinearElastic3DLaw | ( | const LinearElastic3DLaw & | rOther | ) |
Copy constructor.
|
override |
Assignment operator. Destructor.
|
protectedvirtual |
calculates the linear elastic constitutive matrix in terms of Young's modulus and Poisson ratio
E | the Young's modulus |
NU | the Poisson ratio |
Reimplemented in Kratos::HistoryLinearElasticPlaneStress2DLaw, Kratos::HistoryLinearElasticPlaneStrain2DLaw, Kratos::LinearElasticPlaneStress2DLaw, Kratos::LinearElasticPlaneStrain2DLaw, Kratos::LinearElasticAxisym2DLaw, Kratos::LinearElasticPlaneStress2DLaw, Kratos::LinearElasticPlaneStrain2DLaw, Kratos::LinearElasticPlaneStress2DLaw, Kratos::LinearElasticPlaneStrain2DLaw, Kratos::LinearElasticAxisym2DLaw, Kratos::ThermalLinearElastic2DPlaneStressNodal, Kratos::ThermalLinearElastic2DPlaneStress, Kratos::ThermalLinearElastic2DPlaneStrainNodal, Kratos::ThermalLinearElastic2DPlaneStrain, Kratos::LinearElastic2DPlaneStressNodal, and Kratos::LinearElastic2DPlaneStrainNodal.
|
protectedvirtual |
calculates the linear elastic constitutive matrix in terms of Young's modulus and Poisson ratio
E | the Young's modulus |
NU | the Poisson ratio |
Reimplemented in Kratos::HistoryLinearElasticPlaneStress2DLaw, Kratos::HistoryLinearElasticPlaneStrain2DLaw, Kratos::LinearElasticPlaneStress2DLaw, Kratos::LinearElasticPlaneStrain2DLaw, Kratos::LinearElasticAxisym2DLaw, Kratos::LinearElasticPlaneStress2DLaw, Kratos::LinearElasticPlaneStrain2DLaw, Kratos::LinearElasticPlaneStress2DLaw, Kratos::LinearElasticPlaneStrain2DLaw, Kratos::LinearElasticAxisym2DLaw, Kratos::ThermalLinearElastic2DPlaneStressNodal, Kratos::ThermalLinearElastic2DPlaneStress, Kratos::ThermalLinearElastic2DPlaneStrainNodal, Kratos::ThermalLinearElastic2DPlaneStrain, Kratos::LinearElastic2DPlaneStressNodal, and Kratos::LinearElastic2DPlaneStrainNodal.
|
protectedvirtual |
calculates the linear elastic constitutive matrix in terms of Young's modulus and Poisson ratio
E | the Young's modulus |
NU | the Poisson ratio |
Reimplemented in Kratos::HistoryLinearElasticPlaneStress2DLaw, Kratos::HistoryLinearElasticPlaneStrain2DLaw, Kratos::LinearElasticPlaneStress2DLaw, Kratos::LinearElasticPlaneStrain2DLaw, Kratos::LinearElasticAxisym2DLaw, Kratos::LinearElasticPlaneStress2DLaw, Kratos::LinearElasticPlaneStrain2DLaw, Kratos::LinearElasticPlaneStress2DLaw, Kratos::LinearElasticPlaneStrain2DLaw, Kratos::LinearElasticAxisym2DLaw, Kratos::ThermalLinearElastic2DPlaneStressNodal, Kratos::ThermalLinearElastic2DPlaneStress, Kratos::ThermalLinearElastic2DPlaneStrainNodal, Kratos::ThermalLinearElastic2DPlaneStrain, Kratos::LinearElastic2DPlaneStressNodal, and Kratos::LinearElastic2DPlaneStrainNodal.
|
overridevirtual |
Computes the material response: Kirchhoff stresses and algorithmic ConstitutiveMatrix
rValues |
Reimplemented from Kratos::HyperElastic3DLaw.
Reimplemented in Kratos::HistoryLinearElastic3DLaw.
|
overridevirtual |
Computes the material response: Kirchhoff stresses and algorithmic ConstitutiveMatrix
rValues |
Reimplemented from Kratos::HyperElastic3DLaw.
|
overridevirtual |
Computes the material response: Kirchhoff stresses and algorithmic ConstitutiveMatrix
rValues |
Reimplemented from Kratos::HyperElastic3DLaw.
|
overridevirtual |
Computes the material response: PK2 stresses and algorithmic ConstitutiveMatrix
rValues |
Reimplemented from Kratos::ConstitutiveLaw.
|
overridevirtual |
Computes the material response: PK2 stresses and algorithmic ConstitutiveMatrix
rValues |
Reimplemented from Kratos::HyperElastic3DLaw.
|
overridevirtual |
Computes the material response: PK2 stresses and algorithmic ConstitutiveMatrix
rValues |
Reimplemented from Kratos::HyperElastic3DLaw.
|
protectedvirtual |
Calculates the stresses for given strain state
rStrainVector | |
rConstitutiveMatrix | |
rStressVector | the stress vector corresponding to the deformation |
|
protectedvirtual |
Calculates the stresses for given strain state
rStrainVector | |
rConstitutiveMatrix | |
rStressVector | the stress vector corresponding to the deformation |
|
protectedvirtual |
Calculates the stresses for given strain state
rStrainVector | |
rConstitutiveMatrix | |
rStressVector | the stress vector corresponding to the deformation |
|
overrideprotectedvirtual |
Calculates the value of a specified variable (double)
rParameterValues | the needed parameters for the CL calculation |
rThisVariable | the variable to be returned |
rValue | a reference to the returned value |
rValue | output: the value of the specified variable |
returns the value of a specified variable (double)
rParameterValues | the needed parameters for the CL calculation |
rThisVariable | the variable to be returned |
rValue | a reference to the returned value |
rValue | output: the value of the specified variable |
Reimplemented from Kratos::HyperElastic3DLaw.
|
overrideprotectedvirtual |
Calculates the value of a specified variable (double)
rParameterValues | the needed parameters for the CL calculation |
rThisVariable | the variable to be returned |
rValue | a reference to the returned value |
rValue | output: the value of the specified variable |
returns the value of a specified variable (double)
rParameterValues | the needed parameters for the CL calculation |
rThisVariable | the variable to be returned |
rValue | a reference to the returned value |
rValue | output: the value of the specified variable |
Reimplemented from Kratos::HyperElastic3DLaw.
|
overrideprotectedvirtual |
Calculates the value of a specified variable (double)
rParameterValues | the needed parameters for the CL calculation |
rThisVariable | the variable to be returned |
rValue | a reference to the returned value |
rValue | output: the value of the specified variable |
returns the value of a specified variable (double)
rParameterValues | the needed parameters for the CL calculation |
rThisVariable | the variable to be returned |
rValue | a reference to the returned value |
rValue | output: the value of the specified variable |
Reimplemented from Kratos::HyperElastic3DLaw.
|
overridevirtual |
This function is designed to be called once to perform all the checks needed on the input provided. Checks can be "expensive" as the function is designed to catch user's errors.
rMaterialProperties | |
rElementGeometry | |
rCurrentProcessInfo |
Reimplemented from Kratos::HyperElastic3DLaw.
|
overridevirtual |
This function is designed to be called once to perform all the checks needed on the input provided. Checks can be "expensive" as the function is designed to catch user's errors.
rMaterialProperties | |
rElementGeometry | |
rCurrentProcessInfo |
Reimplemented from Kratos::HyperElastic3DLaw.
|
overridevirtual |
This function is designed to be called once to perform all the checks needed on the input provided. Checks can be "expensive" as the function is designed to catch user's errors.
rMaterialProperties | |
rElementGeometry | |
rCurrentProcessInfo |
Reimplemented from Kratos::HyperElastic3DLaw.
|
overrideprotectedvirtual |
This function is designed to be called when before the material response to check if all needed parameters for the constitutive are initialized
Parameters |
Reimplemented from Kratos::HyperElastic3DLaw.
|
overrideprotectedvirtual |
This function is designed to be called when before the material response to check if all needed parameters for the constitutive are initialized
Parameters |
Reimplemented from Kratos::HyperElastic3DLaw.
|
overridevirtual |
Clone function (has to be implemented by any derived class)
Reimplemented from Kratos::HyperElastic3DLaw.
Reimplemented in Kratos::LinearElasticPlaneStress2DLaw, Kratos::LinearElasticPlaneStrain2DLaw, Kratos::LinearElasticAxisym2DLaw, Kratos::LinearElasticPlaneStress2DLaw, Kratos::LinearElasticPlaneStrain2DLaw, Kratos::HistoryLinearElasticPlaneStress2DLaw, Kratos::HistoryLinearElasticPlaneStrain2DLaw, Kratos::HistoryLinearElastic3DLaw, Kratos::LinearElasticPlaneStress2DLaw, Kratos::LinearElasticPlaneStrain2DLaw, and Kratos::LinearElasticAxisym2DLaw.
|
overridevirtual |
Clone function (has to be implemented by any derived class)
Reimplemented from Kratos::HyperElastic3DLaw.
Reimplemented in Kratos::LinearElasticPlaneStress2DLaw, Kratos::LinearElasticPlaneStrain2DLaw, Kratos::LinearElasticAxisym2DLaw, Kratos::LinearElasticPlaneStress2DLaw, and Kratos::LinearElasticPlaneStrain2DLaw.
|
overridevirtual |
Clone function (has to be implemented by any derived class)
Reimplemented from Kratos::HyperElastic3DLaw.
Reimplemented in Kratos::LinearElasticPlaneStress2DLaw, Kratos::LinearElasticPlaneStrain2DLaw, and Kratos::LinearElasticAxisym2DLaw.
|
overridevirtual |
Operators Operations needed by the base class: This function is designed to be called once to check compatibility with element
rFeatures |
Reimplemented from Kratos::HyperElastic3DLaw.
Reimplemented in Kratos::LinearElasticPlaneStress2DLaw, Kratos::LinearElasticPlaneStrain2DLaw, Kratos::LinearElasticAxisym2DLaw, Kratos::LinearElasticPlaneStress2DLaw, Kratos::LinearElasticPlaneStrain2DLaw, Kratos::HistoryLinearElasticPlaneStress2DLaw, Kratos::HistoryLinearElasticPlaneStrain2DLaw, Kratos::LinearElasticPlaneStress2DLaw, Kratos::LinearElasticPlaneStrain2DLaw, and Kratos::LinearElasticAxisym2DLaw.
|
overridevirtual |
Operators Operations needed by the base class: This function is designed to be called once to check compatibility with element
rFeatures |
Reimplemented from Kratos::HyperElastic3DLaw.
Reimplemented in Kratos::LinearElasticPlaneStress2DLaw, Kratos::LinearElasticPlaneStrain2DLaw, Kratos::LinearElasticAxisym2DLaw, Kratos::LinearElasticPlaneStress2DLaw, and Kratos::LinearElasticPlaneStrain2DLaw.
|
overridevirtual |
Operators Operations needed by the base class: This function is designed to be called once to check compatibility with element
rFeatures |
Reimplemented from Kratos::HyperElastic3DLaw.
Reimplemented in Kratos::LinearElasticPlaneStress2DLaw, Kratos::LinearElasticPlaneStrain2DLaw, and Kratos::LinearElasticAxisym2DLaw.
|
overrideprotectedvirtual |
Returns the value of a specified variable (double)
rThisVariable | the variable to be returned |
rValue | a reference to the returned value |
returns the value of a specified variable
rThisVariable | the variable to be returned |
rValue | a reference to the returned value |
rValue | output: the value of the specified variable |
Reimplemented from Kratos::HyperElastic3DLaw.
|
overrideprotectedvirtual |
Returns the value of a specified variable (double)
rThisVariable | the variable to be returned |
rValue | a reference to the returned value |
returns the value of a specified variable
rThisVariable | the variable to be returned |
rValue | a reference to the returned value |
rValue | output: the value of the specified variable |
Reimplemented from Kratos::HyperElastic3DLaw.
|
overrideprotectedvirtual |
Returns the value of a specified variable (double)
rThisVariable | the variable to be returned |
rValue | a reference to the returned value |
returns the value of a specified variable
rThisVariable | the variable to be returned |
rValue | a reference to the returned value |
rValue | output: the value of the specified variable |
Reimplemented from Kratos::HyperElastic3DLaw.
Kratos::LinearElastic3DLaw::KRATOS_CLASS_POINTER_DEFINITION | ( | LinearElastic3DLaw | ) |
Counted pointer of LinearElastic3DLaw
Kratos::LinearElastic3DLaw::KRATOS_CLASS_POINTER_DEFINITION | ( | LinearElastic3DLaw | ) |
Counted pointer of LinearElastic3DLaw
Kratos::LinearElastic3DLaw::KRATOS_CLASS_POINTER_DEFINITION | ( | LinearElastic3DLaw | ) |
Counted pointer of LinearElastic3DLaw
|
friend |