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.
List of all members
Kratos::SerialParallelRuleOfMixturesLaw Class Reference

This CL implements the serial-parallel rule of mixtures developed by F.Rastellini. More...

#include <serial_parallel_rule_of_mixtures_law.h>

Inheritance diagram for Kratos::SerialParallelRuleOfMixturesLaw:
Collaboration diagram for Kratos::SerialParallelRuleOfMixturesLaw:

Public Member Functions

Life Cycle
 SerialParallelRuleOfMixturesLaw ()
 
 SerialParallelRuleOfMixturesLaw (double FiberVolParticipation, const Vector &rParallelDirections)
 
ConstitutiveLaw::Pointer Clone () const override
 
 SerialParallelRuleOfMixturesLaw (SerialParallelRuleOfMixturesLaw const &rOther)
 
 ~SerialParallelRuleOfMixturesLaw () override
 
Operations
ConstitutiveLaw::Pointer Create (Kratos::Parameters NewParameters) const override
 
SizeType WorkingSpaceDimension () override
 Dimension of the law: More...
 
SizeType GetStrainSize () const override
 Voigt tensor size: More...
 
void CalculateMaterialResponsePK1 (ConstitutiveLaw::Parameters &rValues) override
 
void CalculateMaterialResponsePK2 (ConstitutiveLaw::Parameters &rValues) override
 
void CalculateMaterialResponseKirchhoff (ConstitutiveLaw::Parameters &rValues) override
 
void CalculateMaterialResponseCauchy (ConstitutiveLaw::Parameters &rValues) override
 
void FinalizeMaterialResponsePK1 (ConstitutiveLaw::Parameters &rValues) override
 
void FinalizeMaterialResponsePK2 (ConstitutiveLaw::Parameters &rValues) override
 
void FinalizeMaterialResponseKirchhoff (ConstitutiveLaw::Parameters &rValues) override
 
void FinalizeMaterialResponseCauchy (ConstitutiveLaw::Parameters &rValues) override
 
VectorGetValue (const Variable< Vector > &rThisVariable, Vector &rValue) override
 Returns the value of a specified variable (Vector) More...
 
boolGetValue (const Variable< bool > &rThisVariable, bool &rValue) override
 Returns the value of a specified variable (bool) More...
 
intGetValue (const Variable< int > &rThisVariable, int &rValue) override
 Returns the value of a specified variable (integer) More...
 
doubleGetValue (const Variable< double > &rThisVariable, double &rValue) override
 Returns the value of a specified variable (double) More...
 
MatrixGetValue (const Variable< Matrix > &rThisVariable, Matrix &rValue) override
 Returns the value of a specified variable (Matrix) More...
 
void SetValue (const Variable< bool > &rThisVariable, const bool &rValue, const ProcessInfo &rCurrentProcessInfo) override
 Sets the value of a specified variable (bool) More...
 
void SetValue (const Variable< int > &rThisVariable, const int &rValue, const ProcessInfo &rCurrentProcessInfo) override
 Sets the value of a specified variable (integer) More...
 
void SetValue (const Variable< double > &rThisVariable, const double &rValue, const ProcessInfo &rCurrentProcessInfo) override
 Sets the value of a specified variable (double) More...
 
bool Has (const Variable< bool > &rThisVariable) override
 Returns whether this constitutive Law has specified variable (boolean) More...
 
bool Has (const Variable< int > &rThisVariable) override
 Returns whether this constitutive Law has specified variable (integer) More...
 
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...
 
boolCalculateValue (Parameters &rParameterValues, const Variable< bool > &rThisVariable, bool &rValue) override
 Calculates the value of a specified variable (bool) More...
 
intCalculateValue (Parameters &rParameterValues, const Variable< int > &rThisVariable, int &rValue) override
 Calculates the value of a specified variable (integer) More...
 
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...
 
void InitializeMaterial (const Properties &rMaterialProperties, const GeometryType &rElementGeometry, const Vector &rShapeFunctionsValues) override
 
void IntegrateStrainSerialParallelBehaviour (const Vector &rStrainVector, Vector &FiberStressVector, Vector &MatrixStressVector, const Properties &rMaterialProperties, ConstitutiveLaw::Parameters &rValues, Vector &rSerialStrainMatrix, const ConstitutiveLaw::StressMeasure &rStressMeasure=ConstitutiveLaw::StressMeasure_Cauchy)
 
void CalculateSerialParallelProjectionMatrices (Matrix &rParallelProjector, Matrix &rSerialProjector)
 
void InitializeMaterialResponsePK2 (ConstitutiveLaw::Parameters &rValues) override
 
void InitializeMaterialResponseCauchy (ConstitutiveLaw::Parameters &rValues) override
 
void InitializeMaterialResponsePK1 (ConstitutiveLaw::Parameters &rValues) override
 
void InitializeMaterialResponseKirchhoff (ConstitutiveLaw::Parameters &rValues) override
 
void CalculateGreenLagrangeStrain (Parameters &rValues)
 
void CalculateAlmansiStrain (Parameters &rValues)
 
void CalculateStrainsOnEachComponent (const Vector &rStrainVector, const Matrix &rParallelProjector, const Matrix &rSerialProjector, const Vector &rSerialStrainMatrix, Vector &rStrainVectorMatrix, Vector &rStrainVectorFiber, ConstitutiveLaw::Parameters &rValues, const int Iteration=1)
 
void CalculateInitialApproximationSerialStrainMatrix (const Vector &rStrainVector, const Vector &rPreviousStrainVector, const Properties &rMaterialProperties, const Matrix &rParallelProjector, const Matrix &rSerialProjector, Matrix &rConstitutiveTensorMatrixSS, Matrix &rConstitutiveTensorFiberSS, Vector &rInitialApproximationSerialStrainMatrix, ConstitutiveLaw::Parameters &rValues, const ConstitutiveLaw::StressMeasure &rStressMeasure)
 
void IntegrateStressesOfFiberAndMatrix (ConstitutiveLaw::Parameters &rValues, Vector &rMatrixStrainVector, Vector &rFiberStrainVector, Vector &rMatrixStressVector, Vector &rFiberStressVector, const ConstitutiveLaw::StressMeasure &rStressMeasure)
 
void CheckStressEquilibrium (ConstitutiveLaw::Parameters &rValues, const Vector &rStrainVector, const Matrix &rSerialProjector, const Vector &rMatrixStressVector, const Vector &rFiberStressVector, Vector &rStressResidual, bool &rIsConverged, const Matrix &rConstitutiveTensorMatrixSS, const Matrix &rConstitutiveTensorFiberSS)
 
void CorrectSerialStrainMatrix (ConstitutiveLaw::Parameters &rValues, const Vector &rResidualStresses, Vector &rSerialStrainMatrix, const Matrix &rSerialProjector, const ConstitutiveLaw::StressMeasure &rStressMeasure)
 
void CalculateTangentTensor (ConstitutiveLaw::Parameters &rValues, const ConstitutiveLaw::StressMeasure &rStressMeasure=ConstitutiveLaw::StressMeasure_Cauchy)
 This method computes the tangent tensor. More...
 
bool RequiresInitializeMaterialResponse () override
 If the CL requires to initialize the material response, called by the element in InitializeSolutionStep. More...
 
bool RequiresFinalizeMaterialResponse () override
 If the CL requires to initialize the material response, called by the element in InitializeSolutionStep. More...
 
int Check (const Properties &rMaterialProperties, const GeometryType &rElementGeometry, const ProcessInfo &rCurrentProcessInfo) const override
 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. 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 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< 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 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< Vector > &rVariable, const Vector &rValue, const ProcessInfo &rCurrentProcessInfo)
 Sets the value of a specified variable (Vector) More...
 
virtual void SetValue (const Variable< Matrix > &rVariable, const Matrix &rValue, const ProcessInfo &rCurrentProcessInfo)
 Sets the value of a specified variable (Matrix) 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 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 void CalculateStressResponse (Parameters &rValues, Vector &rInternalVariables)
 
void InitializeMaterialResponse (Parameters &rValues, const StressMeasure &rStressMeasure)
 Initialize the material response, called by the element in InitializeSolutionStep. 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 GetLawFeatures (Features &rFeatures)
 
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...
 
- 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

Protected Operators
ConstitutiveLaw::Pointer GetMatrixConstitutiveLaw ()
 This method the constitutive law of the matrix material. More...
 
void SetMatrixConstitutiveLaw (ConstitutiveLaw::Pointer pMatrixConstitutiveLaw)
 This method sets the constitutive law of the matrix material. More...
 
ConstitutiveLaw::Pointer GetFiberConstitutiveLaw ()
 This method the constitutive law of the fiber material. More...
 
void SetFiberConstitutiveLaw (ConstitutiveLaw::Pointer pFiberConstitutiveLaw)
 This method sets the constitutive law of the fiber material. More...
 
int GetNumberOfSerialComponents ()
 This method returns the number of directions with serial behaviour (iso-stress behaviour) More...
 
- 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)
 

Type Definitions

typedef Node NodeType
 The node definition. More...
 
typedef Geometry< NodeTypeGeometryType
 The geometry definition. More...
 
static constexpr double machine_tolerance = std::numeric_limits<double>::epsilon()
 Definition of the machine precision tolerance. More...
 
 KRATOS_CLASS_POINTER_DEFINITION (SerialParallelRuleOfMixturesLaw)
 Counted pointer of SerialParallelRuleOfMixturesLaw. More...
 

Un accessible methods

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< 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)
 
- 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

This CL implements the serial-parallel rule of mixtures developed by F.Rastellini.

Author
Alejandro Cornejo

Member Typedef Documentation

◆ GeometryType

The geometry definition.

◆ NodeType

The node definition.

Constructor & Destructor Documentation

◆ SerialParallelRuleOfMixturesLaw() [1/3]

Kratos::SerialParallelRuleOfMixturesLaw::SerialParallelRuleOfMixturesLaw ( )
inline

Default constructor.

◆ SerialParallelRuleOfMixturesLaw() [2/3]

Kratos::SerialParallelRuleOfMixturesLaw::SerialParallelRuleOfMixturesLaw ( double  FiberVolParticipation,
const Vector rParallelDirections 
)
inline

Constructor.

◆ SerialParallelRuleOfMixturesLaw() [3/3]

Kratos::SerialParallelRuleOfMixturesLaw::SerialParallelRuleOfMixturesLaw ( SerialParallelRuleOfMixturesLaw const &  rOther)
inline

◆ ~SerialParallelRuleOfMixturesLaw()

Kratos::SerialParallelRuleOfMixturesLaw::~SerialParallelRuleOfMixturesLaw ( )
inlineoverride

Destructor.

Member Function Documentation

◆ CalculateAlmansiStrain()

void Kratos::SerialParallelRuleOfMixturesLaw::CalculateAlmansiStrain ( ConstitutiveLaw::Parameters rValues)

This method computes the Almansi strain

See also
Parameters

◆ CalculateGreenLagrangeStrain()

void Kratos::SerialParallelRuleOfMixturesLaw::CalculateGreenLagrangeStrain ( ConstitutiveLaw::Parameters rValues)

This method computes the Green-Lagrange strain

See also
Parameters

◆ CalculateInitialApproximationSerialStrainMatrix()

void Kratos::SerialParallelRuleOfMixturesLaw::CalculateInitialApproximationSerialStrainMatrix ( const Vector rStrainVector,
const Vector rPreviousStrainVector,
const Properties rMaterialProperties,
const Matrix rParallelProjector,
const Matrix rSerialProjector,
Matrix rConstitutiveTensorMatrixSS,
Matrix rConstitutiveTensorFiberSS,
Vector rInitialApproximationSerialStrainMatrix,
ConstitutiveLaw::Parameters rValues,
const ConstitutiveLaw::StressMeasure rStressMeasure 
)

This method computes the initial aproximation of the Newton-Raphson procedure regarding the serial strain of the matrix

Parameters
rStrainVectorThe total strain of the composite
rPreviousStrainVectorThe total strain of the composite of the previous step
rMaterialPropertiesthe Properties instance of the current element
rParallelProjectorThe Parallel behaviour projector
rSerialProjectorThe Serial behaviour projector
rConstitutiveTensorMatrixSSthe serial-serial components of the constitutive tensor of the matrix
rConstitutiveTensorFiberSSthe serial-serial components of the constitutive tensor of the fiber
rInitialApproximationSerialStrainMatrixinitial aproximation of the serial strain of the matrix

◆ CalculateMaterialResponseCauchy()

void Kratos::SerialParallelRuleOfMixturesLaw::CalculateMaterialResponseCauchy ( ConstitutiveLaw::Parameters rValues)
overridevirtual

Computes the material response in terms of Cauchy stresses and constitutive tensor

See also
Parameters

Reimplemented from Kratos::ConstitutiveLaw.

◆ CalculateMaterialResponseKirchhoff()

void Kratos::SerialParallelRuleOfMixturesLaw::CalculateMaterialResponseKirchhoff ( ConstitutiveLaw::Parameters rValues)
overridevirtual

Computes the material response in terms of Kirchhoff stresses and constitutive tensor

See also
Parameters

Reimplemented from Kratos::ConstitutiveLaw.

◆ CalculateMaterialResponsePK1()

void Kratos::SerialParallelRuleOfMixturesLaw::CalculateMaterialResponsePK1 ( ConstitutiveLaw::Parameters rValues)
overridevirtual

Computes the material response in terms of 1st Piola-Kirchhoff stresses and constitutive tensor

See also
Parameters

Reimplemented from Kratos::ConstitutiveLaw.

◆ CalculateMaterialResponsePK2()

void Kratos::SerialParallelRuleOfMixturesLaw::CalculateMaterialResponsePK2 ( ConstitutiveLaw::Parameters rValues)
overridevirtual

Computes the material response in terms of 2nd Piola-Kirchhoff stresses and constitutive tensor

See also
Parameters

Reimplemented from Kratos::ConstitutiveLaw.

◆ CalculateSerialParallelProjectionMatrices()

void Kratos::SerialParallelRuleOfMixturesLaw::CalculateSerialParallelProjectionMatrices ( Matrix rParallelProjector,
Matrix rSerialProjector 
)

This method computes the projection tensors that divide the serial & paralle behaviours of the Strain/Stress

Parameters
rParallelProjectorThe Parallel behaviour projector
rSerialProjectorThe Serial behaviour projector

◆ CalculateStrainsOnEachComponent()

void Kratos::SerialParallelRuleOfMixturesLaw::CalculateStrainsOnEachComponent ( const Vector rStrainVector,
const Matrix rParallelProjector,
const Matrix rSerialProjector,
const Vector rSerialStrainMatrix,
Vector rStrainVectorMatrix,
Vector rStrainVectorFiber,
ConstitutiveLaw::Parameters rValues,
const int  Iteration = 1 
)

This method computes the strain vector in the fiber and matrix according to the total strain and the serial strain of the matrix

Parameters
rStrainVectorThe total strain of the composite
rParallelProjectorThe Parallel behaviour projector
rSerialProjectorThe Serial behaviour projector
rSerialStrainMatrixthe serial component of the matrix strain vector
rStrainVectorMatrixthe strain vector of the matrix
rStrainVectorFiberthe strain vector of the fiber

◆ CalculateTangentTensor()

void Kratos::SerialParallelRuleOfMixturesLaw::CalculateTangentTensor ( ConstitutiveLaw::Parameters rValues,
const ConstitutiveLaw::StressMeasure rStressMeasure = ConstitutiveLaw::StressMeasure_Cauchy 
)

This method computes the tangent tensor.

Parameters
rValuesThe constitutive law parameters and flags

◆ CalculateValue() [1/5]

bool & Kratos::SerialParallelRuleOfMixturesLaw::CalculateValue ( Parameters rParameterValues,
const Variable< bool > &  rThisVariable,
bool rValue 
)
overridevirtual

Calculates the value of a specified variable (bool)

Parameters
rParameterValuesthe needed parameters for the CL calculation
rThisVariablethe variable to be returned
rValuea reference to the returned value
rValueoutput: the value of the specified variable

Reimplemented from Kratos::ConstitutiveLaw.

◆ CalculateValue() [2/5]

double & Kratos::SerialParallelRuleOfMixturesLaw::CalculateValue ( Parameters rParameterValues,
const Variable< double > &  rThisVariable,
double rValue 
)
overridevirtual

Calculates the value of a specified variable (double)

Parameters
rParameterValuesthe needed parameters for the CL calculation
rThisVariablethe variable to be returned
rValuea reference to the returned value
rValueoutput: the value of the specified variable

Reimplemented from Kratos::ConstitutiveLaw.

◆ CalculateValue() [3/5]

int & Kratos::SerialParallelRuleOfMixturesLaw::CalculateValue ( Parameters rParameterValues,
const Variable< int > &  rThisVariable,
int rValue 
)
overridevirtual

Calculates the value of a specified variable (integer)

Parameters
rParameterValuesthe needed parameters for the CL calculation
rThisVariablethe variable to be returned
rValuea reference to the returned value
rValueoutput: the value of the specified variable

Reimplemented from Kratos::ConstitutiveLaw.

◆ CalculateValue() [4/5]

Matrix & Kratos::SerialParallelRuleOfMixturesLaw::CalculateValue ( ConstitutiveLaw::Parameters rParameterValues,
const Variable< Matrix > &  rThisVariable,
Matrix rValue 
)
overridevirtual

Calculates the value of a specified variable (Matrix)

Parameters
rParameterValuesthe needed parameters for the CL calculation
rThisVariablethe variable to be returned
rValuea reference to the returned value
rValueoutput: the value of the specified variable

Reimplemented from Kratos::ConstitutiveLaw.

◆ CalculateValue() [5/5]

Vector & Kratos::SerialParallelRuleOfMixturesLaw::CalculateValue ( Parameters rParameterValues,
const Variable< Vector > &  rThisVariable,
Vector rValue 
)
overridevirtual

Calculates the value of a specified variable (Vector)

Parameters
rParameterValuesthe needed parameters for the CL calculation
rThisVariablethe variable to be returned
rValuea reference to the returned value
rValueoutput: the value of the specified variable

Reimplemented from Kratos::ConstitutiveLaw.

◆ Check()

int Kratos::SerialParallelRuleOfMixturesLaw::Check ( const Properties rMaterialProperties,
const GeometryType rElementGeometry,
const ProcessInfo rCurrentProcessInfo 
) const
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.

Parameters
rMaterialProperties
rElementGeometry
rCurrentProcessInfo
Returns
0 if OK, 1 otherwise

Reimplemented from Kratos::ConstitutiveLaw.

◆ CheckStressEquilibrium()

void Kratos::SerialParallelRuleOfMixturesLaw::CheckStressEquilibrium ( ConstitutiveLaw::Parameters rValues,
const Vector rStrainVector,
const Matrix rSerialProjector,
const Vector rMatrixStressVector,
const Vector rFiberStressVector,
Vector rStressResidual,
bool rIsConverged,
const Matrix rConstitutiveTensorMatrixSS,
const Matrix rConstitutiveTensorFiberSS 
)

This method checks wether the serial stresses are in equilibrium

Parameters
rStrainVectorThe total strain of the composite
rSerialProjectorThe Serial behaviour projector
rMatrixStressVectorthe stress vector of the matrix
rFiberStressVectorthe stress vector of the fiber
rStressResidualthe stress residual between the serial stresses
rIsConvergedboolean indicator, true if equilibrium is achieved
rConstitutiveTensorMatrixSSthe serial-serial components of the constitutive tensor of the matrix
rConstitutiveTensorFiberSSthe serial-serial components of the constitutive tensor of the fiber

◆ Clone()

ConstitutiveLaw::Pointer Kratos::SerialParallelRuleOfMixturesLaw::Clone ( ) const
inlineoverridevirtual

Clone.

Reimplemented from Kratos::ConstitutiveLaw.

◆ CorrectSerialStrainMatrix()

void Kratos::SerialParallelRuleOfMixturesLaw::CorrectSerialStrainMatrix ( ConstitutiveLaw::Parameters rValues,
const Vector rResidualStresses,
Vector rSerialStrainMatrix,
const Matrix rSerialProjector,
const ConstitutiveLaw::StressMeasure rStressMeasure 
)

This method updates the serial strain of the matrix in order to reach equilibrium

Parameters
rValuesthe needed parameters for the CL calculation
rResidualStressesthe stress residual between the serial stresses
rSerialStrainMatrixthe serial component of the matrix strain vector
rSerialProjectorThe Serial behaviour projector

◆ Create()

ConstitutiveLaw::Pointer Kratos::SerialParallelRuleOfMixturesLaw::Create ( Kratos::Parameters  NewParameters) const
overridevirtual

creates a new constitutive law pointer

Parameters
NewParametersThe configuration parameters of the new constitutive law
Returns
a Pointer to the new constitutive law

Reimplemented from Kratos::ConstitutiveLaw.

◆ FinalizeMaterialResponseCauchy()

void Kratos::SerialParallelRuleOfMixturesLaw::FinalizeMaterialResponseCauchy ( ConstitutiveLaw::Parameters rValues)
overridevirtual

Finalize the material response in terms of Cauchy stresses

See also
Parameters

Reimplemented from Kratos::ConstitutiveLaw.

◆ FinalizeMaterialResponseKirchhoff()

void Kratos::SerialParallelRuleOfMixturesLaw::FinalizeMaterialResponseKirchhoff ( ConstitutiveLaw::Parameters rValues)
overridevirtual

Finalize the material response in terms of Kirchhoff stresses

See also
Parameters

Reimplemented from Kratos::ConstitutiveLaw.

◆ FinalizeMaterialResponsePK1()

void Kratos::SerialParallelRuleOfMixturesLaw::FinalizeMaterialResponsePK1 ( ConstitutiveLaw::Parameters rValues)
overridevirtual

Finalize the material response in terms of 1st Piola-Kirchhoff stresses

See also
Parameters

Reimplemented from Kratos::ConstitutiveLaw.

◆ FinalizeMaterialResponsePK2()

void Kratos::SerialParallelRuleOfMixturesLaw::FinalizeMaterialResponsePK2 ( ConstitutiveLaw::Parameters rValues)
overridevirtual

Finalize the material response in terms of 2nd Piola-Kirchhoff stresses

See also
Parameters

Reimplemented from Kratos::ConstitutiveLaw.

◆ GetFiberConstitutiveLaw()

ConstitutiveLaw::Pointer Kratos::SerialParallelRuleOfMixturesLaw::GetFiberConstitutiveLaw ( )
inlineprotected

This method the constitutive law of the fiber material.

◆ GetMatrixConstitutiveLaw()

ConstitutiveLaw::Pointer Kratos::SerialParallelRuleOfMixturesLaw::GetMatrixConstitutiveLaw ( )
inlineprotected

This method the constitutive law of the matrix material.

◆ GetNumberOfSerialComponents()

int Kratos::SerialParallelRuleOfMixturesLaw::GetNumberOfSerialComponents ( )
inlineprotected

This method returns the number of directions with serial behaviour (iso-stress behaviour)

◆ GetStrainSize()

SizeType Kratos::SerialParallelRuleOfMixturesLaw::GetStrainSize ( ) const
inlineoverridevirtual

Voigt tensor size:

Reimplemented from Kratos::ConstitutiveLaw.

◆ GetValue() [1/5]

bool & Kratos::SerialParallelRuleOfMixturesLaw::GetValue ( const Variable< bool > &  rThisVariable,
bool rValue 
)
overridevirtual

Returns the value of a specified variable (bool)

Parameters
rThisVariablethe variable to be returned
rValuea reference to the returned value
Returns
rValue output: the value of the specified variable

Reimplemented from Kratos::ConstitutiveLaw.

◆ GetValue() [2/5]

double & Kratos::SerialParallelRuleOfMixturesLaw::GetValue ( const Variable< double > &  rThisVariable,
double rValue 
)
overridevirtual

Returns the value of a specified variable (double)

Parameters
rThisVariablethe variable to be returned
rValuea reference to the returned value
Returns
rValue output: the value of the specified variable

Reimplemented from Kratos::ConstitutiveLaw.

◆ GetValue() [3/5]

int & Kratos::SerialParallelRuleOfMixturesLaw::GetValue ( const Variable< int > &  rThisVariable,
int rValue 
)
overridevirtual

Returns the value of a specified variable (integer)

Parameters
rThisVariablethe variable to be returned
rValuea reference to the returned value
Returns
rValue output: the value of the specified variable

Reimplemented from Kratos::ConstitutiveLaw.

◆ GetValue() [4/5]

Matrix & Kratos::SerialParallelRuleOfMixturesLaw::GetValue ( const Variable< Matrix > &  rThisVariable,
Matrix rValue 
)
overridevirtual

Returns the value of a specified variable (Matrix)

Parameters
rThisVariablethe variable to be returned
Returns
rValue output: the value of the specified variable

Reimplemented from Kratos::ConstitutiveLaw.

◆ GetValue() [5/5]

Vector & Kratos::SerialParallelRuleOfMixturesLaw::GetValue ( const Variable< Vector > &  rThisVariable,
Vector rValue 
)
overridevirtual

Returns the value of a specified variable (Vector)

Parameters
rThisVariablethe variable to be returned
rValuea reference to the returned value
Returns
rValue output: the value of the specified variable

Reimplemented from Kratos::ConstitutiveLaw.

◆ Has() [1/5]

bool Kratos::SerialParallelRuleOfMixturesLaw::Has ( const Variable< bool > &  rThisVariable)
overridevirtual

Returns whether this constitutive Law has specified variable (boolean)

Parameters
rThisVariablethe variable to be checked for
Returns
true if the variable is defined in the constitutive law

Reimplemented from Kratos::ConstitutiveLaw.

◆ Has() [2/5]

bool Kratos::SerialParallelRuleOfMixturesLaw::Has ( const Variable< double > &  rThisVariable)
overridevirtual

Returns whether this constitutive Law has specified variable (double)

Parameters
rThisVariablethe variable to be checked for
Returns
true if the variable is defined in the constitutive law

Reimplemented from Kratos::ConstitutiveLaw.

◆ Has() [3/5]

bool Kratos::SerialParallelRuleOfMixturesLaw::Has ( const Variable< int > &  rThisVariable)
overridevirtual

Returns whether this constitutive Law has specified variable (integer)

Parameters
rThisVariablethe variable to be checked for
Returns
true if the variable is defined in the constitutive law

Reimplemented from Kratos::ConstitutiveLaw.

◆ Has() [4/5]

bool Kratos::SerialParallelRuleOfMixturesLaw::Has ( const Variable< Matrix > &  rThisVariable)
overridevirtual

Returns whether this constitutive Law has specified variable (Matrix)

Parameters
rThisVariablethe variable to be checked for
Returns
true if the variable is defined in the constitutive law

Reimplemented from Kratos::ConstitutiveLaw.

◆ Has() [5/5]

bool Kratos::SerialParallelRuleOfMixturesLaw::Has ( const Variable< Vector > &  rThisVariable)
overridevirtual

Returns whether this constitutive Law has specified variable (Vector)

Parameters
rThisVariablethe variable to be checked for
Returns
true if the variable is defined in the constitutive law

Reimplemented from Kratos::ConstitutiveLaw.

◆ InitializeMaterial()

void Kratos::SerialParallelRuleOfMixturesLaw::InitializeMaterial ( const Properties rMaterialProperties,
const GeometryType rElementGeometry,
const Vector rShapeFunctionsValues 
)
overridevirtual

This is to be called at the very beginning of the calculation (e.g. from InitializeElement) in order to initialize all relevant attributes of the constitutive law

Parameters
rMaterialPropertiesthe Properties instance of the current element
rElementGeometrythe geometry of the current element
rShapeFunctionsValuesthe shape functions values in the current integration point

Reimplemented from Kratos::ConstitutiveLaw.

◆ InitializeMaterialResponseCauchy()

void Kratos::SerialParallelRuleOfMixturesLaw::InitializeMaterialResponseCauchy ( ConstitutiveLaw::Parameters rValues)
overridevirtual

Initialize the material response in terms of Cauchy stresses

See also
Parameters

Reimplemented from Kratos::ConstitutiveLaw.

◆ InitializeMaterialResponseKirchhoff()

void Kratos::SerialParallelRuleOfMixturesLaw::InitializeMaterialResponseKirchhoff ( ConstitutiveLaw::Parameters rValues)
overridevirtual

Initialize the material response in terms of Kirchhoff stresses

See also
Parameters

Reimplemented from Kratos::ConstitutiveLaw.

◆ InitializeMaterialResponsePK1()

void Kratos::SerialParallelRuleOfMixturesLaw::InitializeMaterialResponsePK1 ( ConstitutiveLaw::Parameters rValues)
overridevirtual

Initialize the material response in terms of 1st Piola-Kirchhoff stresses

See also
Parameters

Reimplemented from Kratos::ConstitutiveLaw.

◆ InitializeMaterialResponsePK2()

void Kratos::SerialParallelRuleOfMixturesLaw::InitializeMaterialResponsePK2 ( ConstitutiveLaw::Parameters rValues)
overridevirtual

Initialize the material response in terms of 2nd Piola-Kirchhoff stresses

See also
Parameters

Reimplemented from Kratos::ConstitutiveLaw.

◆ IntegrateStrainSerialParallelBehaviour()

void Kratos::SerialParallelRuleOfMixturesLaw::IntegrateStrainSerialParallelBehaviour ( const Vector rStrainVector,
Vector FiberStressVector,
Vector MatrixStressVector,
const Properties rMaterialProperties,
ConstitutiveLaw::Parameters rValues,
Vector rSerialStrainMatrix,
const ConstitutiveLaw::StressMeasure rStressMeasure = ConstitutiveLaw::StressMeasure_Cauchy 
)

This method computes the stresses in the matrix and fiber according to the Serial-Parallel RoM

Parameters
rStrainVectorThe total strain of the composite
FiberStressVectorthe Stress of the Fiber
MatrixStressVectorthe Stress of the Matrix
rMaterialPropertiesthe Properties instance of the current element
rValuesthe needed parameters for the CL calculation
rSerialStrainMatrixthe serial component of the matrix strain vector

◆ IntegrateStressesOfFiberAndMatrix()

void Kratos::SerialParallelRuleOfMixturesLaw::IntegrateStressesOfFiberAndMatrix ( ConstitutiveLaw::Parameters rValues,
Vector rMatrixStrainVector,
Vector rFiberStrainVector,
Vector rMatrixStressVector,
Vector rFiberStressVector,
const ConstitutiveLaw::StressMeasure rStressMeasure 
)

This method computes the stresses of the matrix/fiber according to its own CL

Parameters
rValuesthe needed parameters for the CL calculation
rMatrixStrainVectorthe strain vector of the matrix
rMatrixStressVectorthe stress vector of the matrix
rFiberStressVectorthe stress vector of the fiber

◆ KRATOS_CLASS_POINTER_DEFINITION()

Kratos::SerialParallelRuleOfMixturesLaw::KRATOS_CLASS_POINTER_DEFINITION ( SerialParallelRuleOfMixturesLaw  )

Counted pointer of SerialParallelRuleOfMixturesLaw.

◆ RequiresFinalizeMaterialResponse()

bool Kratos::SerialParallelRuleOfMixturesLaw::RequiresFinalizeMaterialResponse ( )
inlineoverridevirtual

If the CL requires to initialize the material response, called by the element in InitializeSolutionStep.

Reimplemented from Kratos::ConstitutiveLaw.

◆ RequiresInitializeMaterialResponse()

bool Kratos::SerialParallelRuleOfMixturesLaw::RequiresInitializeMaterialResponse ( )
inlineoverridevirtual

If the CL requires to initialize the material response, called by the element in InitializeSolutionStep.

Reimplemented from Kratos::ConstitutiveLaw.

◆ SetFiberConstitutiveLaw()

void Kratos::SerialParallelRuleOfMixturesLaw::SetFiberConstitutiveLaw ( ConstitutiveLaw::Pointer  pFiberConstitutiveLaw)
inlineprotected

This method sets the constitutive law of the fiber material.

◆ SetMatrixConstitutiveLaw()

void Kratos::SerialParallelRuleOfMixturesLaw::SetMatrixConstitutiveLaw ( ConstitutiveLaw::Pointer  pMatrixConstitutiveLaw)
inlineprotected

This method sets the constitutive law of the matrix material.

◆ SetValue() [1/3]

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

Sets the value of a specified variable (bool)

Parameters
rThisVariablethe variable to be returned
rValuenew value of the specified variable
rCurrentProcessInfothe process info

Reimplemented from Kratos::ConstitutiveLaw.

◆ SetValue() [2/3]

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

Sets the value of a specified variable (double)

Parameters
rThisVariablethe variable to be returned
rValuenew value of the specified variable
rCurrentProcessInfothe process info

Reimplemented from Kratos::ConstitutiveLaw.

◆ SetValue() [3/3]

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

Sets the value of a specified variable (integer)

Parameters
rThisVariablethe variable to be returned
rValuenew value of the specified variable
rCurrentProcessInfothe process info

Reimplemented from Kratos::ConstitutiveLaw.

◆ WorkingSpaceDimension()

SizeType Kratos::SerialParallelRuleOfMixturesLaw::WorkingSpaceDimension ( )
inlineoverridevirtual

Dimension of the law:

Reimplemented from Kratos::ConstitutiveLaw.

Friends And Related Function Documentation

◆ Serializer

friend class Serializer
friend

Member Data Documentation

◆ machine_tolerance

constexpr double Kratos::SerialParallelRuleOfMixturesLaw::machine_tolerance = std::numeric_limits<double>::epsilon()
staticconstexpr

Definition of the machine precision tolerance.


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