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 <constitutive_3D_law.hpp>
Public Member Functions | |
Life Cycle | |
Constitutive3DLaw () | |
Default constructor. More... | |
Constitutive3DLaw (const Constitutive3DLaw &rOther) | |
Copy constructor. More... | |
ConstitutiveLaw::Pointer | Clone () const override |
Clone. More... | |
Constitutive3DLaw & | operator= (const Constitutive3DLaw &rOther) |
Assignment operator. More... | |
~Constitutive3DLaw () override | |
Destructor. More... | |
Operations | |
void | InitializeMaterial (const Properties &rProperties, const GeometryType &rElementGeometry, const Vector &rShapeFunctionsValues) override |
void | CalculateMaterialResponsePK1 (Parameters &rValues) override |
void | CalculateMaterialResponsePK2 (Parameters &rValues) override |
void | CalculateMaterialResponseKirchhoff (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 |
void | GetLawFeatures (Features &rFeatures) override |
int | Check (const Properties &rProperties, const GeometryType &rElementGeometry, const ProcessInfo &rCurrentProcessInfo) const override |
Access | |
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< 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 | 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... | |
double & | GetValue (const Variable< double > &rThisVariable, double &rValue) override |
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... | |
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... | |
int & | CalculateValue (Parameters &rParameterValues, const Variable< int > &rThisVariable, int &rValue) override |
double & | CalculateValue (Parameters &rParameterValues, const Variable< double > &rThisVariable, double &rValue) override |
Calculates the value of a specified variable (double) More... | |
Vector & | CalculateValue (Parameters &rParameterValues, const Variable< Vector > &rThisVariable, Vector &rValue) override |
Calculates the value of a specified variable (Vector) More... | |
Matrix & | CalculateValue (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 |
Inquiry | |
SizeType | WorkingSpaceDimension () override |
SizeType | GetStrainSize () const 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::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 () |
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 & | 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 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 bool & | CalculateValue (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 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) |
Public Member Functions inherited from Kratos::Flags | |
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 Types | |
using | VoigtIndexType = const unsigned int(*)[2] |
Protected Member Functions | |
Protected Operations | |
virtual void | CalculateValue (Parameters &rValues, ModelDataType &rModelValues) |
virtual void | CalculateMaterialResponsePK1 (Parameters &rValues, ModelDataType &rModelValues) |
virtual void | CalculateMaterialResponsePK2 (Parameters &rValues, ModelDataType &rModelValues) |
virtual void | CalculateMaterialResponseKirchhoff (Parameters &rValues, ModelDataType &rModelValues) |
virtual void | CalculateMaterialResponseCauchy (Parameters &rValues, ModelDataType &rModelValues) |
virtual VoigtIndexType | GetVoigtIndexTensor () |
virtual void | InitializeModelData (Parameters &rValues, ModelDataType &rModelValues) |
virtual void | FinalizeModelData (Parameters &rValues, ModelDataType &rModelValues) |
virtual void | CalculateDomainVariables (Parameters &rValues, ModelDataType &rModelValues) |
virtual double & | CalculateDomainVariable (Parameters &rValues, const Variable< double > &rThisVariable, double &rVariable) |
virtual double & | CalculateDomainTemperature (Parameters &rValues, double &rTemperature) |
virtual double & | CalculateDomainPressure (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) |
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) |
Type Definitions | |
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 |
KRATOS_CLASS_POINTER_DEFINITION (Constitutive3DLaw) | |
Pointer definition of Constitutive3DLaw. More... | |
Serialization | |
class | Serializer |
Additional Inherited Members | |
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< Node > | GeometryType |
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) |
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} } |
Defines a elastic constitutive law in 3D
|
protected |
Kratos::Constitutive3DLaw::Constitutive3DLaw | ( | ) |
Default constructor.
Kratos::Constitutive3DLaw::Constitutive3DLaw | ( | const Constitutive3DLaw & | rOther | ) |
Copy constructor.
|
override |
Destructor.
|
protectedvirtual |
Calculates the Pressure of the domain (element)
rValues |
rPressure | the calculated pressure to be returned |
|
protectedvirtual |
Calculates the Temperature of the domain (element)
rValues |
rTemperature | the calculated temperature to be returned |
|
protectedvirtual |
Calculates the Pressure of the domain (element)
rValues |
rPressure | the calculated pressure to be returned |
|
protectedvirtual |
Calculates the variables of the domain (element)
rValues |
rDataValues |
|
overridevirtual |
Computes the material response: Cauchy stresses and algorithmic ConstitutiveMatrix
rValues |
Reimplemented from Kratos::ConstitutiveLaw.
|
protectedvirtual |
Computes the material response with model data: Cauchy stresses and algorithmic ConstitutiveMatrix
rValues |
rModelValues |
|
overridevirtual |
Computes the material response: Kirchhoff stresses and algorithmic ConstitutiveMatrix
rValues |
Reimplemented from Kratos::ConstitutiveLaw.
Reimplemented in Kratos::StrainRate3DLaw, Kratos::SmallStrainPlaneStress2DLaw, Kratos::SmallStrainOrthotropic3DLaw, Kratos::SmallStrain3DLaw, and Kratos::LargeStrain3DLaw.
|
protectedvirtual |
Computes the material response with model data: Kirchhoff stresses and algorithmic ConstitutiveMatrix
rValues |
rModelValues |
Reimplemented in Kratos::StrainRate3DLaw, Kratos::SmallStrain3DLaw, and Kratos::LargeStrain3DLaw.
|
overridevirtual |
Computes the material response: PK1 stresses and algorithmic ConstitutiveMatrix
rValues |
Reimplemented from Kratos::ConstitutiveLaw.
|
protectedvirtual |
Computes the material response with model data: PK1 stresses and algorithmic ConstitutiveMatrix
rValues |
rModelValues |
|
overridevirtual |
Computes the material response: PK2 stresses and algorithmic ConstitutiveMatrix
rValues |
Reimplemented from Kratos::ConstitutiveLaw.
Reimplemented in Kratos::LargeStrain3DLaw.
|
protectedvirtual |
Computes the material response with model data: PK2 stresses and algorithmic ConstitutiveMatrix
rValues |
rModelValues |
Reimplemented in Kratos::LargeStrain3DLaw.
|
overridevirtual |
Calculates the value of a specified variable (array of 3 components)
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 (array of 3 components)
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::ConstitutiveLaw.
|
overridevirtual |
returns the value of a specified variable (array of 6 components)
rThisVariable | the variable to be returned |
rValue | a reference to the returned value |
returns the value of a specified variable (array of 6 components)
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::ConstitutiveLaw.
|
overridevirtual |
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::ConstitutiveLaw.
|
overridevirtual |
Calculate Values
Reimplemented from Kratos::ConstitutiveLaw.
|
overridevirtual |
Calculates the value of a specified variable (Matrix)
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 (Matrix)
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::ConstitutiveLaw.
|
overridevirtual |
Calculates the value of a specified variable (Vector)
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 (Vector)
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::ConstitutiveLaw.
|
protectedvirtual |
Computes an internal value of the material response:
rValues |
rModelValues |
|
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.
rProperties | |
rElementGeometry | |
rCurrentProcessInfo |
Reimplemented from Kratos::ConstitutiveLaw.
Reimplemented in Kratos::StrainRate3DLaw, Kratos::SmallStrainOrthotropic3DLaw, and Kratos::LargeStrain3DLaw.
|
protectedvirtual |
This function is designed to be called when before the material response to check if all needed parameters for the constitutive are initialized
Parameters |
|
overridevirtual |
Clone.
Reimplemented from Kratos::ConstitutiveLaw.
Reimplemented in Kratos::StrainRatePlaneStrain2DLaw, Kratos::StrainRate3DLaw, Kratos::SmallStrainPlaneStress2DLaw, Kratos::SmallStrainPlaneStrain2DLaw, Kratos::SmallStrainOrthotropic3DLaw, Kratos::SmallStrainAxisymmetric2DLaw, Kratos::SmallStrain3DLaw, Kratos::LargeStrainPlaneStrain2DLaw, Kratos::LargeStrainAxisymmetric2DLaw, and Kratos::LargeStrain3DLaw.
|
overridevirtual |
Updates the material response: Cauchy stresses and Internal Variables
rValues |
Reimplemented from Kratos::ConstitutiveLaw.
|
overridevirtual |
Updates the material response: Cauchy stresses and Internal Variables
rValues |
Reimplemented from Kratos::ConstitutiveLaw.
|
overridevirtual |
Updates the material response: Cauchy stresses and Internal Variables
rValues |
Reimplemented from Kratos::ConstitutiveLaw.
|
overridevirtual |
Updates the material response: Cauchy stresses and Internal Variables
rValues |
Reimplemented from Kratos::ConstitutiveLaw.
|
protectedvirtual |
Finalize ModelData type:
Reimplemented in Kratos::StrainRate3DLaw, Kratos::SmallStrain3DLaw, and Kratos::LargeStrain3DLaw.
|
overridevirtual |
This function is designed to be called once to check compatibility with element and the constitutive law
rFeatures |
Reimplemented from Kratos::ConstitutiveLaw.
Reimplemented in Kratos::StrainRatePlaneStrain2DLaw, Kratos::StrainRate3DLaw, Kratos::SmallStrainPlaneStress2DLaw, Kratos::SmallStrainPlaneStrain2DLaw, Kratos::SmallStrainOrthotropic3DLaw, Kratos::SmallStrainAxisymmetric2DLaw, Kratos::SmallStrain3DLaw, Kratos::LargeStrainPlaneStrain2DLaw, Kratos::LargeStrainAxisymmetric2DLaw, and Kratos::LargeStrain3DLaw.
|
inlineoverridevirtual |
Voigt tensor size:
Reimplemented from Kratos::ConstitutiveLaw.
Reimplemented in Kratos::StrainRatePlaneStrain2DLaw, Kratos::SmallStrainPlaneStress2DLaw, Kratos::SmallStrainPlaneStrain2DLaw, Kratos::SmallStrainOrthotropic3DLaw, Kratos::SmallStrainAxisymmetric2DLaw, Kratos::LargeStrainPlaneStrain2DLaw, and Kratos::LargeStrainAxisymmetric2DLaw.
|
overridevirtual |
Returns the value of a specified variable (array of 3 components)
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 |
Reimplemented from Kratos::ConstitutiveLaw.
|
overridevirtual |
Returns the value of a specified variable (array of 6 components)
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 |
Reimplemented from Kratos::ConstitutiveLaw.
|
overridevirtual |
Get Values
Reimplemented from Kratos::ConstitutiveLaw.
Reimplemented in Kratos::StrainRate3DLaw, and Kratos::LargeStrain3DLaw.
|
overridevirtual |
Returns the value of a specified variable (Matrix)
rThisVariable | the variable to be returned |
returns the value of a specified variable
rThisVariable | the variable to be returned |
Reimplemented from Kratos::ConstitutiveLaw.
Reimplemented in Kratos::LargeStrain3DLaw.
|
overridevirtual |
Returns the value of a specified variable (Vector)
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 |
Reimplemented from Kratos::ConstitutiveLaw.
|
inlineprotectedvirtual |
Get voigt index tensor:
Reimplemented in Kratos::StrainRatePlaneStrain2DLaw, Kratos::LargeStrainPlaneStrain2DLaw, and Kratos::LargeStrainAxisymmetric2DLaw.
|
overridevirtual |
Returns whether this constitutive Law has specified variable (array of 3 components)
rThisVariable | the variable to be checked for |
returns whether this constitutive Law has specified variable
rThisVariable | the variable to be checked for |
Reimplemented from Kratos::ConstitutiveLaw.
|
overridevirtual |
Returns whether this constitutive Law has specified variable (array of 6 components)
rThisVariable | the variable to be checked for |
returns whether this constitutive Law has specified variable
rThisVariable | the variable to be checked for |
Reimplemented from Kratos::ConstitutiveLaw.
Has Values
Reimplemented from Kratos::ConstitutiveLaw.
Reimplemented in Kratos::StrainRate3DLaw, and Kratos::LargeStrain3DLaw.
Returns whether this constitutive Law has specified variable (Matrix)
rThisVariable | the variable to be checked for |
returns whether this constitutive Law has specified variable
rThisVariable | the variable to be checked for |
Reimplemented from Kratos::ConstitutiveLaw.
Returns whether this constitutive Law has specified variable (Vector)
rThisVariable | the variable to be checked for |
returns whether this constitutive Law has specified variable
rThisVariable | the variable to be checked for |
Reimplemented from Kratos::ConstitutiveLaw.
|
inlineoverridevirtual |
Turn back information as a string.
Reimplemented from Kratos::ConstitutiveLaw.
Reimplemented in Kratos::StrainRatePlaneStrain2DLaw, Kratos::StrainRate3DLaw, Kratos::SmallStrainPlaneStress2DLaw, Kratos::SmallStrainPlaneStrain2DLaw, Kratos::SmallStrainOrthotropic3DLaw, Kratos::SmallStrainAxisymmetric2DLaw, Kratos::SmallStrain3DLaw, Kratos::LargeStrainPlaneStrain2DLaw, Kratos::LargeStrainAxisymmetric2DLaw, and Kratos::LargeStrain3DLaw.
|
overridevirtual |
Material parameters are inizialized
Reimplemented from Kratos::ConstitutiveLaw.
Reimplemented in Kratos::StrainRate3DLaw, Kratos::SmallStrain3DLaw, and Kratos::LargeStrain3DLaw.
|
overridevirtual |
Initialize the material response in terms of Cauchy stresses
Reimplemented from Kratos::ConstitutiveLaw.
|
overridevirtual |
Initialize the material response in terms of Kirchhoff stresses
Reimplemented from Kratos::ConstitutiveLaw.
|
overridevirtual |
Initialize the material response in terms of 1st Piola-Kirchhoff stresses
Reimplemented from Kratos::ConstitutiveLaw.
|
overridevirtual |
Initialize the material response in terms of 2nd Piola-Kirchhoff stresses
Reimplemented from Kratos::ConstitutiveLaw.
|
protectedvirtual |
Initialize ModelData type:
Reimplemented in Kratos::StrainRate3DLaw, Kratos::SmallStrain3DLaw, and Kratos::LargeStrain3DLaw.
Kratos::Constitutive3DLaw::KRATOS_CLASS_POINTER_DEFINITION | ( | Constitutive3DLaw | ) |
Pointer definition of Constitutive3DLaw.
Constitutive3DLaw & Kratos::Constitutive3DLaw::operator= | ( | const Constitutive3DLaw & | rOther | ) |
Assignment operator.
|
inlineoverridevirtual |
Print object's data.
Reimplemented from Kratos::ConstitutiveLaw.
Reimplemented in Kratos::StrainRatePlaneStrain2DLaw, Kratos::StrainRate3DLaw, Kratos::SmallStrainPlaneStress2DLaw, Kratos::SmallStrainPlaneStrain2DLaw, Kratos::SmallStrainOrthotropic3DLaw, Kratos::SmallStrainAxisymmetric2DLaw, Kratos::SmallStrain3DLaw, Kratos::LargeStrainPlaneStrain2DLaw, Kratos::LargeStrainAxisymmetric2DLaw, and Kratos::LargeStrain3DLaw.
|
inlineoverridevirtual |
Print information about this object.
Reimplemented from Kratos::ConstitutiveLaw.
Reimplemented in Kratos::StrainRatePlaneStrain2DLaw, Kratos::StrainRate3DLaw, Kratos::SmallStrainPlaneStress2DLaw, Kratos::SmallStrainPlaneStrain2DLaw, Kratos::SmallStrainOrthotropic3DLaw, Kratos::SmallStrainAxisymmetric2DLaw, Kratos::SmallStrain3DLaw, Kratos::LargeStrainPlaneStrain2DLaw, Kratos::LargeStrainAxisymmetric2DLaw, and Kratos::LargeStrain3DLaw.
|
overridevirtual |
Sets the value of a specified variable (array of 3 components)
rVariable | the variable to be returned |
rValue | new value of the specified variable |
rCurrentProcessInfo | the process info |
Reimplemented from Kratos::ConstitutiveLaw.
|
overridevirtual |
Sets the value of a specified variable (array of 6 components)
rVariable | the variable to be returned |
rValue | new value of the specified variable |
rCurrentProcessInfo | the process info |
Reimplemented from Kratos::ConstitutiveLaw.
|
overridevirtual |
Set Values
Reimplemented from Kratos::ConstitutiveLaw.
Reimplemented in Kratos::StrainRate3DLaw, and Kratos::LargeStrain3DLaw.
|
overridevirtual |
Sets the value of a specified variable (Matrix)
rVariable | the variable to be returned |
rValue | new value of the specified variable |
rCurrentProcessInfo | the process info |
Reimplemented from Kratos::ConstitutiveLaw.
Reimplemented in Kratos::StrainRate3DLaw, and Kratos::LargeStrain3DLaw.
|
overridevirtual |
Sets the value of a specified variable (Vector)
rVariable | the variable to be returned |
rValue | new value of the specified variable |
rCurrentProcessInfo | the process info |
Reimplemented from Kratos::ConstitutiveLaw.
Reimplemented in Kratos::StrainRate3DLaw, Kratos::LargeStrain3DLaw, and Kratos::SmallStrain3DLaw.
|
inlineoverridevirtual |
Dimension of the law:
Reimplemented from Kratos::ConstitutiveLaw.
Reimplemented in Kratos::StrainRatePlaneStrain2DLaw, Kratos::SmallStrainPlaneStress2DLaw, Kratos::SmallStrainPlaneStrain2DLaw, Kratos::SmallStrainOrthotropic3DLaw, Kratos::SmallStrainAxisymmetric2DLaw, Kratos::LargeStrainPlaneStrain2DLaw, and Kratos::LargeStrainAxisymmetric2DLaw.
|
friend |