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.
Protected Member Functions | List of all members
Kratos::SmallStrain3DLaw Class Reference

#include <small_strain_3D_law.hpp>

Inheritance diagram for Kratos::SmallStrain3DLaw:
Collaboration diagram for Kratos::SmallStrain3DLaw:

Public Member Functions

Life Cycle
 SmallStrain3DLaw ()
 Default constructor. More...
 
 SmallStrain3DLaw (ModelTypePointer pModel)
 Constructor. More...
 
 SmallStrain3DLaw (const SmallStrain3DLaw &rOther)
 Copy constructor. More...
 
ConstitutiveLaw::Pointer Clone () const override
 Clone. More...
 
SmallStrain3DLawoperator= (const SmallStrain3DLaw &rOther)
 Assignment operator. More...
 
 ~SmallStrain3DLaw () override
 Destructor. More...
 
Operations
void InitializeMaterial (const Properties &rProperties, const GeometryType &rElementGeometry, const Vector &rShapeFunctionsValues) override
 
void CalculateMaterialResponseKirchhoff (Parameters &rValues) override
 
void GetLawFeatures (Features &rFeatures) override
 
void GetModelFeatures (Features &rFeatures)
 
Access
void SetValue (const Variable< Vector > &rThisVariable, const Vector &rValue, const ProcessInfo &rCurrentProcessInfo) override
 
Input and output
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...
 
- Public Member Functions inherited from Kratos::Constitutive3DLaw
 Constitutive3DLaw ()
 Default constructor. More...
 
 Constitutive3DLaw (const Constitutive3DLaw &rOther)
 Copy constructor. More...
 
Constitutive3DLawoperator= (const Constitutive3DLaw &rOther)
 Assignment operator. More...
 
 ~Constitutive3DLaw () override
 Destructor. More...
 
void CalculateMaterialResponsePK1 (Parameters &rValues) override
 
void CalculateMaterialResponsePK2 (Parameters &rValues) override
 
void CalculateMaterialResponseCauchy (Parameters &rValues) override
 
void InitializeMaterialResponsePK1 (Parameters &rValues) override
 
void InitializeMaterialResponsePK2 (Parameters &rValues) override
 
void InitializeMaterialResponseKirchhoff (Parameters &rValues) override
 
void InitializeMaterialResponseCauchy (Parameters &rValues) override
 
void FinalizeMaterialResponsePK1 (Parameters &rValues) override
 
void FinalizeMaterialResponsePK2 (Parameters &rValues) override
 
void FinalizeMaterialResponseKirchhoff (Parameters &rValues) override
 
void FinalizeMaterialResponseCauchy (Parameters &rValues) override
 
int Check (const Properties &rProperties, const GeometryType &rElementGeometry, const ProcessInfo &rCurrentProcessInfo) const override
 
bool Has (const Variable< double > &rThisVariable) override
 
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...
 
bool Has (const Variable< array_1d< double, 3 > > &rThisVariable) override
 Returns whether this constitutive Law has specified variable (array of 3 components) More...
 
bool Has (const Variable< array_1d< double, 6 > > &rThisVariable) override
 Returns whether this constitutive Law has specified variable (array of 6 components) More...
 
void SetValue (const Variable< double > &rVariable, const double &rValue, const ProcessInfo &rCurrentProcessInfo) override
 
void SetValue (const Variable< Matrix > &rThisVariable, const Matrix &rValue, const ProcessInfo &rCurrentProcessInfo) override
 Sets the value of a specified variable (Matrix) More...
 
void SetValue (const Variable< array_1d< double, 3 > > &rThisVariable, const array_1d< double, 3 > &rValue, const ProcessInfo &rCurrentProcessInfo) override
 Sets the value of a specified variable (array of 3 components) More...
 
void SetValue (const Variable< array_1d< double, 6 > > &rThisVariable, const array_1d< double, 6 > &rValue, const ProcessInfo &rCurrentProcessInfo) override
 Sets the value of a specified variable (array of 6 components) More...
 
doubleGetValue (const Variable< double > &rThisVariable, double &rValue) override
 
VectorGetValue (const Variable< Vector > &rThisVariable, Vector &rValue) override
 Returns the value of a specified variable (Vector) More...
 
MatrixGetValue (const Variable< Matrix > &rThisVariable, Matrix &rValue) override
 Returns the value of a specified variable (Matrix) More...
 
array_1d< double, 3 > & GetValue (const Variable< array_1d< double, 3 > > &rThisVariable, array_1d< double, 3 > &rValue) override
 Returns the value of a specified variable (array of 3 components) More...
 
array_1d< double, 6 > & GetValue (const Variable< array_1d< double, 6 > > &rThisVariable, array_1d< double, 6 > &rValue) override
 Returns the value of a specified variable (array of 6 components) More...
 
intCalculateValue (Parameters &rParameterValues, const Variable< int > &rThisVariable, int &rValue) override
 
doubleCalculateValue (Parameters &rParameterValues, const Variable< double > &rThisVariable, double &rValue) override
 Calculates the value of a specified variable (double) More...
 
VectorCalculateValue (Parameters &rParameterValues, const Variable< Vector > &rThisVariable, Vector &rValue) override
 Calculates the value of a specified variable (Vector) More...
 
MatrixCalculateValue (Parameters &rParameterValues, const Variable< Matrix > &rThisVariable, Matrix &rValue) override
 Calculates the value of a specified variable (Matrix) More...
 
array_1d< double, 3 > & CalculateValue (Parameters &rParameterValues, const Variable< array_1d< double, 3 > > &rVariable, array_1d< double, 3 > &rValue) override
 Calculates the value of a specified variable (array of 3 components) More...
 
array_1d< double, 6 > & CalculateValue (Parameters &rParameterValues, const Variable< array_1d< double, 6 > > &rVariable, array_1d< double, 6 > &rValue) override
 
SizeType WorkingSpaceDimension () override
 
SizeType GetStrainSize () const override
 
 KRATOS_CLASS_POINTER_DEFINITION (Constitutive3DLaw)
 Pointer definition of Constitutive3DLaw. More...
 
- Public Member Functions inherited from Kratos::ConstitutiveLaw
 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 ()
 
InitialStateGetInitialState ()
 
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 boolGetValue (const Variable< bool > &rThisVariable, bool &rValue)
 Returns the value of a specified variable (boolean) More...
 
virtual intGetValue (const Variable< int > &rThisVariable, int &rValue)
 
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 boolCalculateValue (Parameters &rParameterValues, const Variable< bool > &rThisVariable, bool &rValue)
 Calculates the value of a specified variable (bool) More...
 
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 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 VectorTransformStrains (Vector &rStrainVector, const Matrix &rF, StrainMeasure rStrainInitial, StrainMeasure rStrainFinal)
 
virtual MatrixTransformStresses (Matrix &rStressMatrix, const Matrix &rF, const double &rdetF, StressMeasure rStressInitial, StressMeasure rStressFinal)
 
virtual VectorTransformStresses (Vector &rStressVector, const Matrix &rF, const double &rdetF, StressMeasure rStressInitial, StressMeasure rStressFinal)
 
VectorTransformPK1Stresses (Vector &rStressVector, const Matrix &rF, const double &rdetF, StressMeasure rStressFinal)
 
VectorTransformPK2Stresses (Vector &rStressVector, const Matrix &rF, const double &rdetF, StressMeasure rStressFinal)
 
VectorTransformKirchhoffStresses (Vector &rStressVector, const Matrix &rF, const double &rdetF, StressMeasure rStressFinal)
 
VectorTransformCauchyStresses (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)
 
- Public Member Functions inherited from Kratos::Flags
Flagsoperator= (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 Flagsoperator|= (const Flags &Other)
 
const Flagsoperator&= (const Flags &Other)
 
 Flags ()
 Default constructor. More...
 
 Flags (Flags const &rOther)
 Copy constructor. More...
 
virtual ~Flags ()
 Destructor. More...
 

Protected Member Functions

void CalculateMaterialResponseKirchhoff (Parameters &rValues, ModelDataType &rModelValues) override
 
void InitializeModelData (Parameters &rValues, ModelDataType &rModelValues) override
 
void FinalizeModelData (Parameters &rValues, ModelDataType &rModelValues) override
 
virtual void CalculateStressVector (ModelDataType &rModelValues, Vector &rStressVector)
 
virtual void CalculateConstitutiveMatrix (ModelDataType &rModelValues, Matrix &rConstitutiveMatrix)
 
virtual void CalculateStressVectorAndConstitutiveMatrix (ModelDataType &rModelValues, Vector &rStressVector, Matrix &rConstitutiveMatrix)
 
virtual void CalculateStress (const Vector &rStrainVector, const Matrix &rConstitutiveMatrix, Vector &rStressVector)
 
virtual void CalculateConstitutiveMatrix (Matrix &rConstitutiveMatrix, const Properties &rProperties)
 
- Protected Member Functions inherited from Kratos::Constitutive3DLaw
virtual void CalculateValue (Parameters &rValues, ModelDataType &rModelValues)
 
virtual void CalculateMaterialResponsePK1 (Parameters &rValues, ModelDataType &rModelValues)
 
virtual void CalculateMaterialResponsePK2 (Parameters &rValues, ModelDataType &rModelValues)
 
virtual void CalculateMaterialResponseCauchy (Parameters &rValues, ModelDataType &rModelValues)
 
virtual VoigtIndexType GetVoigtIndexTensor ()
 
virtual void CalculateDomainVariables (Parameters &rValues, ModelDataType &rModelValues)
 
virtual doubleCalculateDomainVariable (Parameters &rValues, const Variable< double > &rThisVariable, double &rVariable)
 
virtual doubleCalculateDomainTemperature (Parameters &rValues, double &rTemperature)
 
virtual doubleCalculateDomainPressure (Parameters &rValues, double &rPressure)
 
virtual bool CheckParameters (Parameters &rValues)
 
- Protected Member Functions inherited from Kratos::ConstitutiveLaw
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)
 
doubleTransformConstitutiveComponent (double &rCabcd, const Matrix &rConstitutiveMatrix, const Matrix &rF, const unsigned int &a, const unsigned int &b, const unsigned int &c, const unsigned int &d)
 
doubleGetConstitutiveComponent (double &rCabcd, const Matrix &rConstitutiveMatrix, const unsigned int &a, const unsigned int &b, const unsigned int &c, const unsigned int &d)
 

Protected Attributes

Protected member Variables
ModelTypePointer mpModel
 

Type Definitions

typedef ConstitutiveModel ModelType
 
typedef ModelType::Pointer ModelTypePointer
 
 KRATOS_CLASS_POINTER_DEFINITION (SmallStrain3DLaw)
 Pointer definition of SmallStrain3DLaw. More...
 

Serialization

class Serializer
 

Additional Inherited Members

- Public Types inherited from Kratos::Constitutive3DLaw
typedef ProcessInfo ProcessInfoType
 
typedef ConstitutiveLaw BaseType
 
typedef ConstitutiveModelData::SizeType SizeType
 
typedef ConstitutiveModelData::VectorType VectorType
 
typedef ConstitutiveModelData::MatrixType MatrixType
 
typedef ConstitutiveModelData::ModelData ModelDataType
 
typedef ConstitutiveModelData::ConstitutiveLawData LawDataType
 
- Public Types inherited from Kratos::ConstitutiveLaw
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< NodeGeometryType
 
typedef Vector StrainVectorType
 
typedef Vector StressVectorType
 
typedef Matrix VoigtSizeMatrixType
 
typedef Matrix DeformationGradientMatrixType
 
- Public Types inherited from Kratos::Flags
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
 
- Static Public Member Functions inherited from Kratos::ConstitutiveLaw
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 Public Member Functions inherited from Kratos::Flags
static const Flags AllDefined ()
 
static const Flags AllTrue ()
 
static Flags Create (IndexType ThisPosition, bool Value=true)
 
- Protected Types inherited from Kratos::Constitutive3DLaw
using VoigtIndexType = const unsigned int(*)[2]
 
- Static Protected Attributes inherited from Kratos::ConstitutiveLaw
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} }
 

Detailed Description

Defines a linear isotropic constitutive law 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.

Member Typedef Documentation

◆ ModelType

◆ ModelTypePointer

typedef ModelType::Pointer Kratos::SmallStrain3DLaw::ModelTypePointer

Constructor & Destructor Documentation

◆ SmallStrain3DLaw() [1/3]

Kratos::SmallStrain3DLaw::SmallStrain3DLaw ( )

Default constructor.

◆ SmallStrain3DLaw() [2/3]

Kratos::SmallStrain3DLaw::SmallStrain3DLaw ( ModelTypePointer  pModel)

Constructor.

◆ SmallStrain3DLaw() [3/3]

Kratos::SmallStrain3DLaw::SmallStrain3DLaw ( const SmallStrain3DLaw rOther)

Copy constructor.

◆ ~SmallStrain3DLaw()

Kratos::SmallStrain3DLaw::~SmallStrain3DLaw ( )
override

Destructor.

Member Function Documentation

◆ CalculateConstitutiveMatrix() [1/2]

void Kratos::SmallStrain3DLaw::CalculateConstitutiveMatrix ( Matrix rConstitutiveMatrix,
const Properties rProperties 
)
protectedvirtual

calculates the linear elastic constitutive matrix in terms of Young's modulus and Poisson ratio

Parameters
Ethe Young's modulus
NUthe Poisson ratio
Returns
the linear elastic constitutive matrix

Reimplemented in Kratos::SmallStrainPlaneStress2DLaw, Kratos::SmallStrainPlaneStrain2DLaw, Kratos::SmallStrainOrthotropic3DLaw, and Kratos::SmallStrainAxisymmetric2DLaw.

◆ CalculateConstitutiveMatrix() [2/2]

void Kratos::SmallStrain3DLaw::CalculateConstitutiveMatrix ( ModelDataType rModelValues,
Matrix rConstitutiveMatrix 
)
protectedvirtual

Calculates the constitutive matrix matrix is to be generated for

Parameters
rResultMatrix the result (Constitutive Matrix) will be stored in

◆ CalculateMaterialResponseKirchhoff() [1/2]

void Kratos::SmallStrain3DLaw::CalculateMaterialResponseKirchhoff ( Parameters rValues)
overridevirtual

Computes the material response: Kirchhoff stresses and algorithmic ConstitutiveMatrix

Parameters
rValues
See also
Parameters

Reimplemented from Kratos::Constitutive3DLaw.

Reimplemented in Kratos::SmallStrainPlaneStress2DLaw, and Kratos::SmallStrainOrthotropic3DLaw.

◆ CalculateMaterialResponseKirchhoff() [2/2]

void Kratos::SmallStrain3DLaw::CalculateMaterialResponseKirchhoff ( Parameters rValues,
ModelDataType rModelValues 
)
overrideprotectedvirtual

Computes the material response with model data: Kirchhoff stresses and algorithmic ConstitutiveMatrix

Parameters
rValues
See also
Parameters
Parameters
rModelValues

Reimplemented from Kratos::Constitutive3DLaw.

◆ CalculateStress()

void Kratos::SmallStrain3DLaw::CalculateStress ( const Vector rStrainVector,
const Matrix rConstitutiveMatrix,
Vector rStressVector 
)
protectedvirtual

Calculates the stresses for given strain state

Parameters
rStrainVector
rConstitutiveMatrix
rStressVectorthe stress vector corresponding to the deformation

◆ CalculateStressVector()

void Kratos::SmallStrain3DLaw::CalculateStressVector ( ModelDataType rModelValues,
Vector rStressVector 
)
protectedvirtual

Calculates the stress vector matrix is to be generated for

Parameters
rResultVector the result (Stress Vector) will be stored in

◆ CalculateStressVectorAndConstitutiveMatrix()

void Kratos::SmallStrain3DLaw::CalculateStressVectorAndConstitutiveMatrix ( ModelDataType rModelValues,
Vector rStressVector,
Matrix rConstitutiveMatrix 
)
protectedvirtual

Calculates the stress vector and constitutive matrix matrix is to be generated for

Parameters
rResultVector the result (Stress Vector) will be stored in
rResultMatrix the result (ConstitutiveMatrix) will be stored in

◆ Clone()

ConstitutiveLaw::Pointer Kratos::SmallStrain3DLaw::Clone ( ) const
overridevirtual

◆ FinalizeModelData()

void Kratos::SmallStrain3DLaw::FinalizeModelData ( Parameters rValues,
ModelDataType rModelValues 
)
overrideprotectedvirtual

Finalize ModelData type:

Reimplemented from Kratos::Constitutive3DLaw.

◆ GetLawFeatures()

void Kratos::SmallStrain3DLaw::GetLawFeatures ( Features rFeatures)
overridevirtual

This function is designed to be called once to check compatibility with element

Parameters
rFeatures

Reimplemented from Kratos::Constitutive3DLaw.

Reimplemented in Kratos::SmallStrainPlaneStress2DLaw, Kratos::SmallStrainPlaneStrain2DLaw, Kratos::SmallStrainOrthotropic3DLaw, and Kratos::SmallStrainAxisymmetric2DLaw.

◆ GetModelFeatures()

void Kratos::SmallStrain3DLaw::GetModelFeatures ( Features rFeatures)

This function is designed to be called once to check compatibility with element and the model

Parameters
rFeatures

◆ Info()

std::string Kratos::SmallStrain3DLaw::Info ( ) const
inlineoverridevirtual

◆ InitializeMaterial()

void Kratos::SmallStrain3DLaw::InitializeMaterial ( const Properties rProperties,
const GeometryType rElementGeometry,
const Vector rShapeFunctionsValues 
)
overridevirtual

Material parameters are inizialized

Reimplemented from Kratos::Constitutive3DLaw.

◆ InitializeModelData()

void Kratos::SmallStrain3DLaw::InitializeModelData ( Parameters rValues,
ModelDataType rModelValues 
)
overrideprotectedvirtual

Initialize ModelData type:

Reimplemented from Kratos::Constitutive3DLaw.

◆ KRATOS_CLASS_POINTER_DEFINITION()

Kratos::SmallStrain3DLaw::KRATOS_CLASS_POINTER_DEFINITION ( SmallStrain3DLaw  )

Pointer definition of SmallStrain3DLaw.

◆ operator=()

SmallStrain3DLaw & Kratos::SmallStrain3DLaw::operator= ( const SmallStrain3DLaw rOther)

Assignment operator.

◆ PrintData()

void Kratos::SmallStrain3DLaw::PrintData ( std::ostream &  rOStream) const
inlineoverridevirtual

◆ PrintInfo()

void Kratos::SmallStrain3DLaw::PrintInfo ( std::ostream &  rOStream) const
inlineoverridevirtual

◆ SetValue()

void Kratos::SmallStrain3DLaw::SetValue ( const Variable< Vector > &  rThisVariable,
const Vector rValue,
const ProcessInfo rCurrentProcessInfo 
)
overridevirtual

Set Values

Reimplemented from Kratos::Constitutive3DLaw.

Friends And Related Function Documentation

◆ Serializer

friend class Serializer
friend

Member Data Documentation

◆ mpModel

ModelTypePointer Kratos::SmallStrain3DLaw::mpModel
protected

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