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::GenericSmallStrainHighCycleFatigueLaw< TConstLawIntegratorType > Class Template Reference

This class is the base class which defines the constitutive law used for high cycle fatigue (HCF) in small deformation. More...

#include <generic_small_strain_high_cycle_fatigue_law.h>

Inheritance diagram for Kratos::GenericSmallStrainHighCycleFatigueLaw< TConstLawIntegratorType >:
Collaboration diagram for Kratos::GenericSmallStrainHighCycleFatigueLaw< TConstLawIntegratorType >:

Public Member Functions

Life Cycle
 GenericSmallStrainHighCycleFatigueLaw ()
 
 GenericSmallStrainHighCycleFatigueLaw (const double FatigueReductionFactor, const double PreviousStress0, const double PreviousStress1, const double MaxStress, const double MinStress, const unsigned int NumberOfCyclesGlobal, const double FatigueReductionParameter)
 
ConstitutiveLaw::Pointer Clone () const override
 
 GenericSmallStrainHighCycleFatigueLaw (const GenericSmallStrainHighCycleFatigueLaw &rOther)
 
 ~GenericSmallStrainHighCycleFatigueLaw () override
 
Operations
void InitializeMaterialResponsePK1 (ConstitutiveLaw::Parameters &rValues) override
 Initialize the material response in terms of 1st Piola-Kirchhoff stresses. More...
 
void InitializeMaterialResponsePK2 (ConstitutiveLaw::Parameters &rValues) override
 Initialize the material response in terms of 2nd Piola-Kirchhoff stresses. More...
 
void InitializeMaterialResponseKirchhoff (ConstitutiveLaw::Parameters &rValues) override
 Initialize the material response in terms of Kirchhoff stresses. More...
 
void InitializeMaterialResponseCauchy (ConstitutiveLaw::Parameters &rValues) override
 Initialize the material response in terms of Cauchy stresses. More...
 
void CalculateMaterialResponsePK1 (ConstitutiveLaw::Parameters &rValues) override
 Computes the material response in terms of 1st Piola-Kirchhoff stresses and constitutive tensor. More...
 
void CalculateMaterialResponsePK2 (ConstitutiveLaw::Parameters &rValues) override
 Computes the material response in terms of 2nd Piola-Kirchhoff stresses and constitutive tensor. More...
 
void CalculateMaterialResponseKirchhoff (ConstitutiveLaw::Parameters &rValues) override
 Computes the material response in terms of Kirchhoff stresses and constitutive tensor. More...
 
void CalculateMaterialResponseCauchy (ConstitutiveLaw::Parameters &rValues) override
 Computes the material response in terms of Cauchy stresses and constitutive tensor. More...
 
bool Has (const Variable< bool > &rThisVariable) override
 
bool Has (const Variable< double > &rThisVariable) override
 Returns whether this constitutive Law has specified variable (double) More...
 
bool Has (const Variable< int > &rThisVariable) override
 
void SetValue (const Variable< bool > &rThisVariable, const bool &Value, 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
 
void SetValue (const Variable< double > &rThisVariable, const double &rValue, const ProcessInfo &rCurrentProcessInfo) override
 Sets the value of a specified variable (double) More...
 
boolGetValue (const Variable< bool > &rThisVariable, bool &rValue) override
 
intGetValue (const Variable< int > &rThisVariable, int &rValue) override
 
doubleGetValue (const Variable< double > &rThisVariable, double &rValue) override
 Returns the value of a specified variable (double) More...
 
doubleCalculateValue (ConstitutiveLaw::Parameters &rParameterValues, const Variable< double > &rThisVariable, double &rValue) override
 Returns the value of a specified variable (double) More...
 
MatrixCalculateValue (ConstitutiveLaw::Parameters &rParameterValues, const Variable< Matrix > &rThisVariable, Matrix &rValue) override
 Returns the value of a specified variable (matrix) 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...
 
void FinalizeMaterialResponseCauchy (ConstitutiveLaw::Parameters &rValues) override
 
void FinalizeMaterialResponsePK1 (ConstitutiveLaw::Parameters &rValues) override
 Finalize the material response in terms of 1st Piola-Kirchhoff stresses. More...
 
void FinalizeMaterialResponsePK2 (ConstitutiveLaw::Parameters &rValues) override
 Finalize the material response in terms of 2nd Piola-Kirchhoff stresses. More...
 
void FinalizeMaterialResponseKirchhoff (ConstitutiveLaw::Parameters &rValues) override
 Finalize the material response in terms of Kirchhoff stresses. More...
 
virtual bool Has (const Variable< bool > &rThisVariable)
 Returns whether this constitutive Law has specified variable (integer) More...
 
virtual bool Has (const Variable< int > &rThisVariable)
 Returns whether this constitutive Law has specified variable (integer) More...
 
virtual bool Has (const Variable< double > &rThisVariable)
 Returns whether this constitutive Law has specified variable (integer) More...
 
virtual bool Has (const Variable< Vector > &rThisVariable)
 Returns whether this constitutive Law has specified variable (integer) More...
 
virtual bool Has (const Variable< Matrix > &rThisVariable)
 Returns whether this constitutive Law has specified variable (integer) More...
 
virtual bool Has (const Variable< array_1d< double, 3 > > &rThisVariable)
 Returns whether this constitutive Law has specified variable (integer) More...
 
virtual bool Has (const Variable< array_1d< double, 6 > > &rThisVariable)
 Returns whether this constitutive Law has specified variable (integer) More...
 
virtual void SetValue (const Variable< bool > &rVariable, const bool &Value, const ProcessInfo &rCurrentProcessInfo)
 Sets the value of a specified variable (integer) More...
 
virtual void SetValue (const Variable< int > &rVariable, const int &Value, const ProcessInfo &rCurrentProcessInfo)
 Sets the value of a specified variable (integer) More...
 
virtual void SetValue (const Variable< double > &rVariable, const double &rValue, const ProcessInfo &rCurrentProcessInfo)
 Sets the value of a specified variable (integer) More...
 
virtual void SetValue (const Variable< Vector > &rVariable, const Vector &rValue, const ProcessInfo &rCurrentProcessInfo)
 Sets the value of a specified variable (integer) More...
 
virtual void SetValue (const Variable< Matrix > &rVariable, const Matrix &rValue, const ProcessInfo &rCurrentProcessInfo)
 Sets the value of a specified variable (integer) More...
 
virtual void SetValue (const Variable< array_1d< double, 3 > > &rVariable, const array_1d< double, 3 > &rValue, const ProcessInfo &rCurrentProcessInfo)
 Sets the value of a specified variable (integer) 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 (integer) More...
 
virtual boolGetValue (const Variable< bool > &rThisVariable, bool &rValue)
 Returns the value of a specified variable (integer) More...
 
virtual intGetValue (const Variable< int > &rThisVariable, int &rValue)
 Returns the value of a specified variable (integer) More...
 
virtual doubleGetValue (const Variable< double > &rThisVariable, double &rValue)
 Returns the value of a specified variable (integer) More...
 
virtual VectorGetValue (const Variable< Vector > &rThisVariable, Vector &rValue)
 Returns the value of a specified variable (integer) More...
 
virtual MatrixGetValue (const Variable< Matrix > &rThisVariable, Matrix &rValue)
 Returns the value of a specified variable (integer) 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 (integer) 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 (integer) More...
 
- Public Member Functions inherited from Kratos::GenericSmallStrainIsotropicDamage< TConstLawIntegratorType >
 GenericSmallStrainIsotropicDamage ()
 
ConstitutiveLaw::Pointer Clone () const override
 
 GenericSmallStrainIsotropicDamage (const GenericSmallStrainIsotropicDamage &rOther)
 
 ~GenericSmallStrainIsotropicDamage () override
 
void CalculateMaterialResponsePK1 (ConstitutiveLaw::Parameters &rValues) override
 Computes the material response in terms of 1st Piola-Kirchhoff stresses and constitutive tensor. More...
 
void CalculateMaterialResponsePK2 (ConstitutiveLaw::Parameters &rValues) override
 Computes the material response in terms of 2nd Piola-Kirchhoff stresses and constitutive tensor. More...
 
void CalculateMaterialResponseKirchhoff (ConstitutiveLaw::Parameters &rValues) override
 Computes the material response in terms of Kirchhoff stresses and constitutive tensor. More...
 
void CalculateMaterialResponseCauchy (ConstitutiveLaw::Parameters &rValues) override
 Computes the material response in terms of Cauchy stresses and constitutive tensor. More...
 
void InitializeMaterial (const Properties &rMaterialProperties, const GeometryType &rElementGeometry, const Vector &rShapeFunctionsValues) override
 This is to be called at the very beginning of the calculation. More...
 
void FinalizeMaterialResponsePK1 (ConstitutiveLaw::Parameters &rValues) override
 Finalize the material response in terms of 1st Piola-Kirchhoff stresses. More...
 
void FinalizeMaterialResponsePK2 (ConstitutiveLaw::Parameters &rValues) override
 Finalize the material response in terms of 2nd Piola-Kirchhoff stresses. More...
 
void FinalizeMaterialResponseKirchhoff (ConstitutiveLaw::Parameters &rValues) override
 Finalize the material response in terms of Kirchhoff stresses. More...
 
void FinalizeMaterialResponseCauchy (ConstitutiveLaw::Parameters &rValues) override
 
bool Has (const Variable< double > &rThisVariable) override
 Returns whether this constitutive Law has specified variable (double) More...
 
bool Has (const Variable< Vector > &rThisVariable) override
 Returns whether this constitutive Law has specified variable (Vector) More...
 
bool Has (const Variable< Matrix > &rThisVariable) override
 Returns whether this constitutive Law has specified variable (Matrix) More...
 
void SetValue (const Variable< double > &rThisVariable, const double &rValue, const ProcessInfo &rCurrentProcessInfo) override
 Sets the value of a specified variable (double) More...
 
void SetValue (const Variable< Vector > &rThisVariable, const Vector &rValue, const ProcessInfo &rCurrentProcessInfo) override
 Sets the value of a specified variable (Vector) More...
 
doubleGetValue (const Variable< double > &rThisVariable, double &rValue) override
 Returns the value of a specified variable (double) More...
 
VectorGetValue (const Variable< Vector > &rThisVariable, Vector &rValue) override
 Returns the value of a specified variable (Vector) More...
 
bool RequiresFinalizeMaterialResponse () override
 If the CL requires to initialize the material response, called by the element in InitializeSolutionStep. More...
 
bool RequiresInitializeMaterialResponse () override
 If the CL requires to initialize the material response, called by the element in InitializeSolutionStep. More...
 
doubleCalculateValue (ConstitutiveLaw::Parameters &rParameterValues, const Variable< double > &rThisVariable, double &rValue) override
 Returns the value of a specified variable (double) More...
 
VectorCalculateValue (ConstitutiveLaw::Parameters &rParameterValues, const Variable< Vector > &rThisVariable, Vector &rValue) override
 Returns the value of a specified variable (vector) More...
 
MatrixCalculateValue (ConstitutiveLaw::Parameters &rParameterValues, const Variable< Matrix > &rThisVariable, Matrix &rValue) override
 Returns the value of a specified variable (matrix) More...
 
int Check (const Properties &rMaterialProperties, const GeometryType &rElementGeometry, const ProcessInfo &rCurrentProcessInfo) const override
 This function provides the place to perform checks on the completeness of the input. More...
 
void CalculateTangentTensor (ConstitutiveLaw::Parameters &rValues)
 This method computes the tangent tensor. More...
 
 KRATOS_CLASS_POINTER_DEFINITION (GenericSmallStrainIsotropicDamage)
 Counted pointer of GenericYieldSurface. More...
 

Type Definitions

typedef Node NodeType
 The node definition. More...
 
typedef Geometry< NodeTypeGeometryType
 The geometry definition. More...
 
typedef GenericSmallStrainIsotropicDamage< TConstLawIntegratorType > BaseType
 Definition of the base class. More...
 
static constexpr SizeType Dimension = TConstLawIntegratorType::Dimension
 The define the working dimension size, already defined in the integrator. More...
 
static constexpr SizeType VoigtSize = TConstLawIntegratorType::VoigtSize
 The define the Voigt size, already defined in the integrator. More...
 
static constexpr double tolerance = std::numeric_limits<double>::epsilon()
 Definition of the machine precision tolerance. More...
 
static constexpr double threshold_tolerance = 1.0e-5
 
 KRATOS_CLASS_POINTER_DEFINITION (GenericSmallStrainHighCycleFatigueLaw)
 Counted pointer of GenericYieldSurface. More...
 

Private Operations

class Serializer
 

Additional Inherited Members

- Public Types inherited from Kratos::GenericSmallStrainIsotropicDamage< TConstLawIntegratorType >
typedef std::conditional< VoigtSize==6, ElasticIsotropic3D, LinearPlaneStrain >::type BaseType
 Definition of the base class. More...
 
typedef array_1d< double, VoigtSizeBoundedArrayType
 
typedef Node NodeType
 The node definition. More...
 
typedef Geometry< NodeTypeGeometryType
 The geometry definition. More...
 
- Static Public Attributes inherited from Kratos::GenericSmallStrainIsotropicDamage< TConstLawIntegratorType >
static constexpr SizeType Dimension = TConstLawIntegratorType::Dimension
 The define the working dimension size, already defined in the integrator. More...
 
static constexpr SizeType VoigtSize = TConstLawIntegratorType::VoigtSize
 The define the Voigt size, already defined in the integrator. More...
 
static constexpr double tolerance = std::numeric_limits<double>::epsilon()
 Definition of the machine precision tolerance. More...
 
static constexpr double threshold_tolerance = 1.0e-5
 
- Protected Member Functions inherited from Kratos::GenericSmallStrainIsotropicDamage< TConstLawIntegratorType >
doubleGetThreshold ()
 
doubleGetDamage ()
 
void SetThreshold (const double toThreshold)
 
void SetDamage (const double toDamage)
 

Detailed Description

template<class TConstLawIntegratorType>
class Kratos::GenericSmallStrainHighCycleFatigueLaw< TConstLawIntegratorType >

This class is the base class which defines the constitutive law used for high cycle fatigue (HCF) in small deformation.

This class uses the GenericSmallStrainIsotropicDamage class once the load is applied Nf cycles. The code has been written following the approach proposed by S. Oller et al. in A continuum mechanics model for mechanical fatigue analysis (2005)

Template Parameters
TConstLawIntegratorTypeThe constitutive law integrator considered
Author
Sergio Jiménez/Alejandro Cornejo/Lucia Barbu

Member Typedef Documentation

◆ BaseType

template<class TConstLawIntegratorType >
typedef GenericSmallStrainIsotropicDamage<TConstLawIntegratorType> Kratos::GenericSmallStrainHighCycleFatigueLaw< TConstLawIntegratorType >::BaseType

Definition of the base class.

◆ GeometryType

template<class TConstLawIntegratorType >
typedef Geometry<NodeType> Kratos::GenericSmallStrainHighCycleFatigueLaw< TConstLawIntegratorType >::GeometryType

The geometry definition.

◆ NodeType

template<class TConstLawIntegratorType >
typedef Node Kratos::GenericSmallStrainHighCycleFatigueLaw< TConstLawIntegratorType >::NodeType

The node definition.

Constructor & Destructor Documentation

◆ GenericSmallStrainHighCycleFatigueLaw() [1/3]

template<class TConstLawIntegratorType >
Kratos::GenericSmallStrainHighCycleFatigueLaw< TConstLawIntegratorType >::GenericSmallStrainHighCycleFatigueLaw ( )
inline

Default constructor.

◆ GenericSmallStrainHighCycleFatigueLaw() [2/3]

template<class TConstLawIntegratorType >
Kratos::GenericSmallStrainHighCycleFatigueLaw< TConstLawIntegratorType >::GenericSmallStrainHighCycleFatigueLaw ( const double  FatigueReductionFactor,
const double  PreviousStress0,
const double  PreviousStress1,
const double  MaxStress,
const double  MinStress,
const unsigned int  NumberOfCyclesGlobal,
const double  FatigueReductionParameter 
)
inline

◆ GenericSmallStrainHighCycleFatigueLaw() [3/3]

template<class TConstLawIntegratorType >
Kratos::GenericSmallStrainHighCycleFatigueLaw< TConstLawIntegratorType >::GenericSmallStrainHighCycleFatigueLaw ( const GenericSmallStrainHighCycleFatigueLaw< TConstLawIntegratorType > &  rOther)
inline

Copy constructor.

◆ ~GenericSmallStrainHighCycleFatigueLaw()

template<class TConstLawIntegratorType >
Kratos::GenericSmallStrainHighCycleFatigueLaw< TConstLawIntegratorType >::~GenericSmallStrainHighCycleFatigueLaw ( )
inlineoverride

Destructor.

Member Function Documentation

◆ CalculateMaterialResponseCauchy()

template<class TConstLawIntegratorType >
void Kratos::GenericSmallStrainHighCycleFatigueLaw< TConstLawIntegratorType >::CalculateMaterialResponseCauchy ( ConstitutiveLaw::Parameters rValues)
override

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

See also
Parameters

◆ CalculateMaterialResponseKirchhoff()

template<class TConstLawIntegratorType >
void Kratos::GenericSmallStrainHighCycleFatigueLaw< TConstLawIntegratorType >::CalculateMaterialResponseKirchhoff ( ConstitutiveLaw::Parameters rValues)
override

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

See also
Parameters

◆ CalculateMaterialResponsePK1()

template<class TConstLawIntegratorType >
void Kratos::GenericSmallStrainHighCycleFatigueLaw< TConstLawIntegratorType >::CalculateMaterialResponsePK1 ( ConstitutiveLaw::Parameters rValues)
override

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

See also
Parameters

◆ CalculateMaterialResponsePK2()

template<class TConstLawIntegratorType >
void Kratos::GenericSmallStrainHighCycleFatigueLaw< TConstLawIntegratorType >::CalculateMaterialResponsePK2 ( ConstitutiveLaw::Parameters rValues)
override

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

See also
Parameters

◆ CalculateValue() [1/2]

template<class TConstLawIntegratorType >
double & Kratos::GenericSmallStrainHighCycleFatigueLaw< TConstLawIntegratorType >::CalculateValue ( ConstitutiveLaw::Parameters rParameterValues,
const Variable< double > &  rThisVariable,
double rValue 
)
override

Returns 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

◆ CalculateValue() [2/2]

template<class TConstLawIntegratorType >
Matrix & Kratos::GenericSmallStrainHighCycleFatigueLaw< TConstLawIntegratorType >::CalculateValue ( ConstitutiveLaw::Parameters rParameterValues,
const Variable< Matrix > &  rThisVariable,
Matrix rValue 
)
override

Returns 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

◆ Clone()

template<class TConstLawIntegratorType >
ConstitutiveLaw::Pointer Kratos::GenericSmallStrainHighCycleFatigueLaw< TConstLawIntegratorType >::Clone ( ) const
inlineoverride

Clone.

◆ FinalizeMaterialResponseCauchy()

template<class TConstLawIntegratorType >
void Kratos::GenericSmallStrainHighCycleFatigueLaw< TConstLawIntegratorType >::FinalizeMaterialResponseCauchy ( ConstitutiveLaw::Parameters rValues)
override

Finalize the material response in terms of Cauchy stresses

See also
Parameters

◆ FinalizeMaterialResponseKirchhoff()

template<class TConstLawIntegratorType >
void Kratos::GenericSmallStrainHighCycleFatigueLaw< TConstLawIntegratorType >::FinalizeMaterialResponseKirchhoff ( ConstitutiveLaw::Parameters rValues)
override

Finalize the material response in terms of Kirchhoff stresses.

See also
Parameters

◆ FinalizeMaterialResponsePK1()

template<class TConstLawIntegratorType >
void Kratos::GenericSmallStrainHighCycleFatigueLaw< TConstLawIntegratorType >::FinalizeMaterialResponsePK1 ( ConstitutiveLaw::Parameters rValues)
override

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

See also
Parameters

◆ FinalizeMaterialResponsePK2()

template<class TConstLawIntegratorType >
void Kratos::GenericSmallStrainHighCycleFatigueLaw< TConstLawIntegratorType >::FinalizeMaterialResponsePK2 ( ConstitutiveLaw::Parameters rValues)
override

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

See also
Parameters

◆ GetValue() [1/10]

template<class TConstLawIntegratorType >
array_1d< double, 3 > & Kratos::ConstitutiveLaw::GetValue

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

◆ GetValue() [2/10]

template<class TConstLawIntegratorType >
array_1d< double, 6 > & Kratos::ConstitutiveLaw::GetValue

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

◆ GetValue() [3/10]

template<class TConstLawIntegratorType >
bool & Kratos::ConstitutiveLaw::GetValue

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

◆ GetValue() [4/10]

template<class TConstLawIntegratorType >
bool & Kratos::GenericSmallStrainHighCycleFatigueLaw< TConstLawIntegratorType >::GetValue ( const Variable< bool > &  rThisVariable,
bool rValue 
)
override

returns the value of a specified variable

Parameters
rThisVariablethe variable to be returned
rValuea reference to the returned value
rValueoutput: the value of the specified variable

◆ GetValue() [5/10]

template<class TConstLawIntegratorType >
double & Kratos::ConstitutiveLaw::GetValue

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

◆ GetValue() [6/10]

template<class TConstLawIntegratorType >
double & Kratos::GenericSmallStrainHighCycleFatigueLaw< TConstLawIntegratorType >::GetValue ( const Variable< double > &  rThisVariable,
double rValue 
)
override

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

◆ GetValue() [7/10]

template<class TConstLawIntegratorType >
int & Kratos::ConstitutiveLaw::GetValue

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

◆ GetValue() [8/10]

template<class TConstLawIntegratorType >
int & Kratos::GenericSmallStrainHighCycleFatigueLaw< TConstLawIntegratorType >::GetValue ( const Variable< int > &  rThisVariable,
int rValue 
)
override

◆ GetValue() [9/10]

template<class TConstLawIntegratorType >
Matrix & Kratos::ConstitutiveLaw::GetValue

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

◆ GetValue() [10/10]

template<class TConstLawIntegratorType >
Vector & Kratos::ConstitutiveLaw::GetValue

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

◆ Has() [1/10]

template<class TConstLawIntegratorType >
bool Kratos::ConstitutiveLaw::Has

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

◆ Has() [2/10]

template<class TConstLawIntegratorType >
bool Kratos::ConstitutiveLaw::Has

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

◆ Has() [3/10]

template<class TConstLawIntegratorType >
bool Kratos::ConstitutiveLaw::Has

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

◆ Has() [4/10]

template<class TConstLawIntegratorType >
bool Kratos::GenericSmallStrainHighCycleFatigueLaw< TConstLawIntegratorType >::Has ( const Variable< bool > &  rThisVariable)
override

returns whether this constitutive Law has specified variable

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

◆ Has() [5/10]

template<class TConstLawIntegratorType >
bool Kratos::ConstitutiveLaw::Has

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

◆ Has() [6/10]

template<class TConstLawIntegratorType >
bool Kratos::GenericSmallStrainHighCycleFatigueLaw< TConstLawIntegratorType >::Has ( const Variable< double > &  rThisVariable)
override

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

◆ Has() [7/10]

template<class TConstLawIntegratorType >
bool Kratos::ConstitutiveLaw::Has

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

◆ Has() [8/10]

template<class TConstLawIntegratorType >
bool Kratos::GenericSmallStrainHighCycleFatigueLaw< TConstLawIntegratorType >::Has ( const Variable< int > &  rThisVariable)
override

◆ Has() [9/10]

template<class TConstLawIntegratorType >
bool Kratos::ConstitutiveLaw::Has

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

◆ Has() [10/10]

template<class TConstLawIntegratorType >
bool Kratos::ConstitutiveLaw::Has

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

◆ InitializeMaterialResponseCauchy()

template<class TConstLawIntegratorType >
void Kratos::GenericSmallStrainHighCycleFatigueLaw< TConstLawIntegratorType >::InitializeMaterialResponseCauchy ( ConstitutiveLaw::Parameters rValues)
override

Initialize the material response in terms of Cauchy stresses.

See also
Parameters

◆ InitializeMaterialResponseKirchhoff()

template<class TConstLawIntegratorType >
void Kratos::GenericSmallStrainHighCycleFatigueLaw< TConstLawIntegratorType >::InitializeMaterialResponseKirchhoff ( ConstitutiveLaw::Parameters rValues)
override

Initialize the material response in terms of Kirchhoff stresses.

See also
Parameters

◆ InitializeMaterialResponsePK1()

template<class TConstLawIntegratorType >
void Kratos::GenericSmallStrainHighCycleFatigueLaw< TConstLawIntegratorType >::InitializeMaterialResponsePK1 ( ConstitutiveLaw::Parameters rValues)
override

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

See also
Parameters

◆ InitializeMaterialResponsePK2()

template<class TConstLawIntegratorType >
void Kratos::GenericSmallStrainHighCycleFatigueLaw< TConstLawIntegratorType >::InitializeMaterialResponsePK2 ( ConstitutiveLaw::Parameters rValues)
override

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

See also
Parameters

◆ KRATOS_CLASS_POINTER_DEFINITION()

template<class TConstLawIntegratorType >
Kratos::GenericSmallStrainHighCycleFatigueLaw< TConstLawIntegratorType >::KRATOS_CLASS_POINTER_DEFINITION ( GenericSmallStrainHighCycleFatigueLaw< TConstLawIntegratorType >  )

Counted pointer of GenericYieldSurface.

◆ RequiresFinalizeMaterialResponse()

template<class TConstLawIntegratorType >
bool Kratos::GenericSmallStrainHighCycleFatigueLaw< TConstLawIntegratorType >::RequiresFinalizeMaterialResponse ( )
inlineoverride

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

◆ RequiresInitializeMaterialResponse()

template<class TConstLawIntegratorType >
bool Kratos::GenericSmallStrainHighCycleFatigueLaw< TConstLawIntegratorType >::RequiresInitializeMaterialResponse ( )
inlineoverride

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

◆ SetValue() [1/10]

template<class TConstLawIntegratorType >
void Kratos::ConstitutiveLaw::SetValue

Sets the value of a specified variable (integer)

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

◆ SetValue() [2/10]

template<class TConstLawIntegratorType >
void Kratos::ConstitutiveLaw::SetValue

Sets the value of a specified variable (integer)

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

◆ SetValue() [3/10]

template<class TConstLawIntegratorType >
void Kratos::GenericSmallStrainHighCycleFatigueLaw< TConstLawIntegratorType >::SetValue ( const Variable< bool > &  rThisVariable,
const bool Value,
const ProcessInfo rCurrentProcessInfo 
)
override

Sets the value of a specified variable (bool)

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

◆ SetValue() [4/10]

template<class TConstLawIntegratorType >
void Kratos::ConstitutiveLaw::SetValue

Sets the value of a specified variable (integer)

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

◆ SetValue() [5/10]

template<class TConstLawIntegratorType >
void Kratos::GenericSmallStrainHighCycleFatigueLaw< TConstLawIntegratorType >::SetValue ( const Variable< double > &  rThisVariable,
const double rValue,
const ProcessInfo rCurrentProcessInfo 
)
override

Sets the value of a specified variable (double)

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

◆ SetValue() [6/10]

template<class TConstLawIntegratorType >
void Kratos::ConstitutiveLaw::SetValue

Sets the value of a specified variable (integer)

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

◆ SetValue() [7/10]

template<class TConstLawIntegratorType >
void Kratos::GenericSmallStrainHighCycleFatigueLaw< TConstLawIntegratorType >::SetValue ( const Variable< int > &  rThisVariable,
const int rValue,
const ProcessInfo rCurrentProcessInfo 
)
override

◆ SetValue() [8/10]

template<class TConstLawIntegratorType >
void Kratos::ConstitutiveLaw::SetValue

Sets the value of a specified variable (integer)

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

◆ SetValue() [9/10]

template<class TConstLawIntegratorType >
void Kratos::ConstitutiveLaw::SetValue

Sets the value of a specified variable (integer)

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

◆ SetValue() [10/10]

template<class TConstLawIntegratorType >
void Kratos::ConstitutiveLaw::SetValue

Sets the value of a specified variable (integer)

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

Friends And Related Function Documentation

◆ Serializer

template<class TConstLawIntegratorType >
friend class Serializer
friend

Member Data Documentation

◆ Dimension

template<class TConstLawIntegratorType >
constexpr SizeType Kratos::GenericSmallStrainHighCycleFatigueLaw< TConstLawIntegratorType >::Dimension = TConstLawIntegratorType::Dimension
staticconstexpr

The define the working dimension size, already defined in the integrator.

◆ threshold_tolerance

template<class TConstLawIntegratorType >
constexpr double Kratos::GenericSmallStrainHighCycleFatigueLaw< TConstLawIntegratorType >::threshold_tolerance = 1.0e-5
staticconstexpr

◆ tolerance

template<class TConstLawIntegratorType >
constexpr double Kratos::GenericSmallStrainHighCycleFatigueLaw< TConstLawIntegratorType >::tolerance = std::numeric_limits<double>::epsilon()
staticconstexpr

Definition of the machine precision tolerance.

◆ VoigtSize

template<class TConstLawIntegratorType >
constexpr SizeType Kratos::GenericSmallStrainHighCycleFatigueLaw< TConstLawIntegratorType >::VoigtSize = TConstLawIntegratorType::VoigtSize
staticconstexpr

The define the Voigt size, already defined in the integrator.


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