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

#include <generic_small_strain_thermal_isotropic_damage_plane_stress.h>

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

Public Member Functions

Life Cycle
 GenericSmallStrainThermalIsotropicDamagePlaneStress ()
 
ConstitutiveLaw::Pointer Clone () const override
 
 GenericSmallStrainThermalIsotropicDamagePlaneStress (const GenericSmallStrainThermalIsotropicDamagePlaneStress &rOther)
 
 ~GenericSmallStrainThermalIsotropicDamagePlaneStress () override
 
Operations
void CalculateMaterialResponseCauchy (ConstitutiveLaw::Parameters &rValues) override
 Computes the material response in terms of Cauchy stresses and constitutive tensor. More...
 
void FinalizeMaterialResponseCauchy (ConstitutiveLaw::Parameters &rValues) override
 
- Public Member Functions inherited from Kratos::GenericSmallStrainThermalIsotropicDamage< TConstLawIntegratorType >
 GenericSmallStrainThermalIsotropicDamage ()
 
ConstitutiveLaw::Pointer Clone () const override
 
 GenericSmallStrainThermalIsotropicDamage (const GenericSmallStrainThermalIsotropicDamage &rOther)
 
 ~GenericSmallStrainThermalIsotropicDamage () override
 
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 FinalizeMaterialResponseCauchy (ConstitutiveLaw::Parameters &rValues) override
 
bool Has (const Variable< double > &rThisVariable) override
 Returns whether this constitutive Law has specified variable (double) More...
 
void SetValue (const Variable< double > &rThisVariable, const double &rValue, const ProcessInfo &rCurrentProcessInfo) override
 Sets the value of a specified variable (double) More...
 
doubleGetValue (const Variable< double > &rThisVariable, double &rValue) override
 Returns the value of a specified variable (double) 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...
 
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...
 
 KRATOS_CLASS_POINTER_DEFINITION (GenericSmallStrainThermalIsotropicDamage)
 Counted pointer of GenericYieldSurface. 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

using BaseType = GenericSmallStrainThermalIsotropicDamage< TConstLawIntegratorType >
 Definition of the base class. More...
 
using CLutils = ConstitutiveLawUtilities< VoigtSize >
 Advanced and basic contitutive laws utilities for the corresponding Voigt size. More...
 
using AdvCLutils = AdvancedConstitutiveLawUtilities< VoigtSize >
 
using BoundedArrayType = array_1d< double, VoigtSize >
 Bounded vector for stresses/strains. More...
 
static constexpr SizeType Dimension = BaseType::Dimension
 The define the working dimension size, already defined in the integrator. More...
 
static constexpr SizeType VoigtSize = BaseType::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 (GenericSmallStrainThermalIsotropicDamagePlaneStress)
 Counted pointer of GenericYieldSurface. More...
 

Un accessible methods

class Serializer
 

Additional Inherited Members

- Public Types inherited from Kratos::GenericSmallStrainThermalIsotropicDamage< TConstLawIntegratorType >
using BaseType = GenericSmallStrainIsotropicDamage< TConstLawIntegratorType >
 Definition of the base class. More...
 
using BoundedArrayType = array_1d< double, VoigtSize >
 Bounded vector for stresses/strains. More...
 
using GeometryType = Geometry< Node >
 The geometry definition. More...
 
using CLutils = ConstitutiveLawUtilities< VoigtSize >
 Advanced and basic contitutive laws utilities for the corresponding Voigt size. More...
 
using AdvCLutils = AdvancedConstitutiveLawUtilities< VoigtSize >
 
- 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::GenericSmallStrainThermalIsotropicDamage< 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
 
- 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::GenericSmallStrainThermalIsotropicDamage< TConstLawIntegratorType >
doubleGetReferenceTemperature ()
 Retrieve the reference temperature. More...
 
void SetReferenceTemperature (const double ToRefTemperature)
 Sets the reference temperature. More...
 
- Protected Member Functions inherited from Kratos::GenericSmallStrainIsotropicDamage< TConstLawIntegratorType >
doubleGetThreshold ()
 
doubleGetDamage ()
 
void SetThreshold (const double toThreshold)
 
void SetDamage (const double toDamage)
 

Member Typedef Documentation

◆ AdvCLutils

template<class TConstLawIntegratorType >
using Kratos::GenericSmallStrainThermalIsotropicDamagePlaneStress< TConstLawIntegratorType >::AdvCLutils = AdvancedConstitutiveLawUtilities<VoigtSize>

◆ BaseType

template<class TConstLawIntegratorType >
using Kratos::GenericSmallStrainThermalIsotropicDamagePlaneStress< TConstLawIntegratorType >::BaseType = GenericSmallStrainThermalIsotropicDamage<TConstLawIntegratorType>

Definition of the base class.

◆ BoundedArrayType

template<class TConstLawIntegratorType >
using Kratos::GenericSmallStrainThermalIsotropicDamagePlaneStress< TConstLawIntegratorType >::BoundedArrayType = array_1d<double, VoigtSize>

Bounded vector for stresses/strains.

◆ CLutils

template<class TConstLawIntegratorType >
using Kratos::GenericSmallStrainThermalIsotropicDamagePlaneStress< TConstLawIntegratorType >::CLutils = ConstitutiveLawUtilities<VoigtSize>

Advanced and basic contitutive laws utilities for the corresponding Voigt size.

Constructor & Destructor Documentation

◆ GenericSmallStrainThermalIsotropicDamagePlaneStress() [1/2]

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

Default constructor.

◆ GenericSmallStrainThermalIsotropicDamagePlaneStress() [2/2]

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

Copy constructor.

◆ ~GenericSmallStrainThermalIsotropicDamagePlaneStress()

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

Destructor.

Member Function Documentation

◆ CalculateMaterialResponseCauchy()

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

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

See also
Parameters

◆ Clone()

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

Clone.

◆ FinalizeMaterialResponseCauchy()

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

Finalize the material response in terms of Cauchy stresses

See also
Parameters

◆ KRATOS_CLASS_POINTER_DEFINITION()

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

Counted pointer of GenericYieldSurface.

Friends And Related Function Documentation

◆ Serializer

template<class TConstLawIntegratorType >
friend class Serializer
friend

Member Data Documentation

◆ Dimension

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

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

◆ threshold_tolerance

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

◆ tolerance

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

Definition of the machine precision tolerance.

◆ VoigtSize

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

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


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