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::ThermalTrescaYieldSurface< TPlasticPotentialType > Class Template Reference

#include <thermal_tresca_yield_surface.h>

Collaboration diagram for Kratos::ThermalTrescaYieldSurface< TPlasticPotentialType >:

Public Member Functions

Life Cycle
 ThermalTrescaYieldSurface ()
 Initialization constructor. More...
 
 ThermalTrescaYieldSurface (ThermalTrescaYieldSurface const &rOther)
 Copy constructor. More...
 
ThermalTrescaYieldSurfaceoperator= (ThermalTrescaYieldSurface const &rOther)
 Assignment operator. More...
 
virtual ~ThermalTrescaYieldSurface ()
 Destructor. More...
 

Static Public Member Functions

Operations
static void CalculateEquivalentStress (const array_1d< double, VoigtSize > &rStressVector, const Vector &rStrainVector, double &rEquivalentStress, ConstitutiveLaw::Parameters &rValues)
 This method the uniaxial equivalent stress. More...
 
static void GetInitialUniaxialThreshold (ConstitutiveLaw::Parameters &rValues, double &rThreshold)
 This method returns the initial uniaxial stress threshold. More...
 
static void CalculateDamageParameter (ConstitutiveLaw::Parameters &rValues, double &rAParameter, const double CharacteristicLength)
 This method returns the damage parameter needed in the exp/linear expressions of damage. More...
 
static void CalculatePlasticPotentialDerivative (const array_1d< double, VoigtSize > &rStressVector, const array_1d< double, VoigtSize > &rDeviator, const double J2, array_1d< double, VoigtSize > &rDerivativePlasticPotential, ConstitutiveLaw::Parameters &rValues)
 This method calculates the derivative of the plastic potential DG/DS. More...
 
static void CalculateYieldSurfaceDerivative (const array_1d< double, VoigtSize > &rStressVector, const array_1d< double, VoigtSize > &rDeviator, const double J2, array_1d< double, VoigtSize > &rFFlux, ConstitutiveLaw::Parameters &rValues)
 This script calculates the derivatives of the Yield Surf according to NAYAK-ZIENKIEWICZ paper International journal for numerical methods in engineering vol 113-135 1972. As: DF/DS = c1*V1 + c2*V2 + c3*V3. More...
 
static int Check (const Properties &rMaterialProperties)
 This method defines the check to be performed in the yield surface. More...
 
static bool IsWorkingWithTensionThreshold ()
 This method returns true if the yield surfacecompares with the tension tield stress. More...
 
static double GetScaleFactorTension (const Properties &rMaterialProperties)
 This method returns the scaling factor of the yield surface surfacecompares with the tension tield stress. More...
 

Type Definitions

using PlasticPotentialType = TPlasticPotentialType
 The type of potential plasticity. More...
 
using BaseType = TrescaYieldSurface< TPlasticPotentialType >
 
using ThermalVonMisesType = ThermalVonMisesYieldSurface< TPlasticPotentialType >
 
static constexpr SizeType Dimension = PlasticPotentialType::Dimension
 The Plastic potential already defines the working simension size. More...
 
static constexpr SizeType VoigtSize = PlasticPotentialType::VoigtSize
 The Plastic potential already defines the Voigt size. More...
 
static constexpr double tolerance = std::numeric_limits<double>::epsilon()
 The machine precision zero tolerance. More...
 
 KRATOS_CLASS_POINTER_DEFINITION (ThermalTrescaYieldSurface)
 Counted pointer of TrescaYieldSurface. More...
 

Member Typedef Documentation

◆ BaseType

template<class TPlasticPotentialType >
using Kratos::ThermalTrescaYieldSurface< TPlasticPotentialType >::BaseType = TrescaYieldSurface<TPlasticPotentialType>

◆ PlasticPotentialType

template<class TPlasticPotentialType >
using Kratos::ThermalTrescaYieldSurface< TPlasticPotentialType >::PlasticPotentialType = TPlasticPotentialType

The type of potential plasticity.

◆ ThermalVonMisesType

template<class TPlasticPotentialType >
using Kratos::ThermalTrescaYieldSurface< TPlasticPotentialType >::ThermalVonMisesType = ThermalVonMisesYieldSurface<TPlasticPotentialType>

Constructor & Destructor Documentation

◆ ThermalTrescaYieldSurface() [1/2]

template<class TPlasticPotentialType >
Kratos::ThermalTrescaYieldSurface< TPlasticPotentialType >::ThermalTrescaYieldSurface ( )
inline

Initialization constructor.

◆ ThermalTrescaYieldSurface() [2/2]

template<class TPlasticPotentialType >
Kratos::ThermalTrescaYieldSurface< TPlasticPotentialType >::ThermalTrescaYieldSurface ( ThermalTrescaYieldSurface< TPlasticPotentialType > const &  rOther)
inline

Copy constructor.

◆ ~ThermalTrescaYieldSurface()

template<class TPlasticPotentialType >
virtual Kratos::ThermalTrescaYieldSurface< TPlasticPotentialType >::~ThermalTrescaYieldSurface ( )
inlinevirtual

Destructor.

Member Function Documentation

◆ CalculateDamageParameter()

template<class TPlasticPotentialType >
static void Kratos::ThermalTrescaYieldSurface< TPlasticPotentialType >::CalculateDamageParameter ( ConstitutiveLaw::Parameters rValues,
double rAParameter,
const double  CharacteristicLength 
)
inlinestatic

This method returns the damage parameter needed in the exp/linear expressions of damage.

Parameters
rAParameterThe damage parameter
rValuesParameters of the constitutive law
CharacteristicLengthThe equivalent length of the FE

◆ CalculateEquivalentStress()

template<class TPlasticPotentialType >
static void Kratos::ThermalTrescaYieldSurface< TPlasticPotentialType >::CalculateEquivalentStress ( const array_1d< double, VoigtSize > &  rStressVector,
const Vector rStrainVector,
double rEquivalentStress,
ConstitutiveLaw::Parameters rValues 
)
inlinestatic

This method the uniaxial equivalent stress.

Parameters
rStressVectorThe predictive stress vector S = C:(E-Ep)
rStrainVectorThe StrainVector vector
rValuesParameters of the constitutive law
rEquivalentStressThe effective stress or equivalent uniaxial stress is a scalar. It is an invariant value which measures the “intensity” of a 3D stress state.

◆ CalculatePlasticPotentialDerivative()

template<class TPlasticPotentialType >
static void Kratos::ThermalTrescaYieldSurface< TPlasticPotentialType >::CalculatePlasticPotentialDerivative ( const array_1d< double, VoigtSize > &  rStressVector,
const array_1d< double, VoigtSize > &  rDeviator,
const double  J2,
array_1d< double, VoigtSize > &  rDerivativePlasticPotential,
ConstitutiveLaw::Parameters rValues 
)
inlinestatic

This method calculates the derivative of the plastic potential DG/DS.

Parameters
rStressVectorThe stress vector
rDeviatorThe deviatoric part of the stress vector
J2The second invariant of the Deviator
rDerivativePlasticPotentialThe derivative of the plastic potential
rValuesParameters of the constitutive law

◆ CalculateYieldSurfaceDerivative()

template<class TPlasticPotentialType >
static void Kratos::ThermalTrescaYieldSurface< TPlasticPotentialType >::CalculateYieldSurfaceDerivative ( const array_1d< double, VoigtSize > &  rStressVector,
const array_1d< double, VoigtSize > &  rDeviator,
const double  J2,
array_1d< double, VoigtSize > &  rFFlux,
ConstitutiveLaw::Parameters rValues 
)
inlinestatic

This script calculates the derivatives of the Yield Surf according to NAYAK-ZIENKIEWICZ paper International journal for numerical methods in engineering vol 113-135 1972. As: DF/DS = c1*V1 + c2*V2 + c3*V3.

Parameters
rStressVectorThe stress vector
rDeviatorThe deviatoric part of the stress vector
J2The second invariant of the Deviator
rFFluxThe derivative of the yield surface
rValuesParameters of the constitutive law

◆ Check()

template<class TPlasticPotentialType >
static int Kratos::ThermalTrescaYieldSurface< TPlasticPotentialType >::Check ( const Properties rMaterialProperties)
inlinestatic

This method defines the check to be performed in the yield surface.

Returns
0 if OK, 1 otherwise

◆ GetInitialUniaxialThreshold()

template<class TPlasticPotentialType >
static void Kratos::ThermalTrescaYieldSurface< TPlasticPotentialType >::GetInitialUniaxialThreshold ( ConstitutiveLaw::Parameters rValues,
double rThreshold 
)
inlinestatic

This method returns the initial uniaxial stress threshold.

Parameters
rThresholdThe uniaxial stress threshold
rValuesParameters of the constitutive law

◆ GetScaleFactorTension()

template<class TPlasticPotentialType >
static double Kratos::ThermalTrescaYieldSurface< TPlasticPotentialType >::GetScaleFactorTension ( const Properties rMaterialProperties)
inlinestatic

This method returns the scaling factor of the yield surface surfacecompares with the tension tield stress.

◆ IsWorkingWithTensionThreshold()

template<class TPlasticPotentialType >
static bool Kratos::ThermalTrescaYieldSurface< TPlasticPotentialType >::IsWorkingWithTensionThreshold ( )
inlinestatic

This method returns true if the yield surfacecompares with the tension tield stress.

◆ KRATOS_CLASS_POINTER_DEFINITION()

template<class TPlasticPotentialType >
Kratos::ThermalTrescaYieldSurface< TPlasticPotentialType >::KRATOS_CLASS_POINTER_DEFINITION ( ThermalTrescaYieldSurface< TPlasticPotentialType >  )

Counted pointer of TrescaYieldSurface.

◆ operator=()

template<class TPlasticPotentialType >
ThermalTrescaYieldSurface& Kratos::ThermalTrescaYieldSurface< TPlasticPotentialType >::operator= ( ThermalTrescaYieldSurface< TPlasticPotentialType > const &  rOther)
inline

Assignment operator.

Member Data Documentation

◆ Dimension

template<class TPlasticPotentialType >
constexpr SizeType Kratos::ThermalTrescaYieldSurface< TPlasticPotentialType >::Dimension = PlasticPotentialType::Dimension
staticconstexpr

The Plastic potential already defines the working simension size.

◆ tolerance

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

The machine precision zero tolerance.

◆ VoigtSize

template<class TPlasticPotentialType >
constexpr SizeType Kratos::ThermalTrescaYieldSurface< TPlasticPotentialType >::VoigtSize = PlasticPotentialType::VoigtSize
staticconstexpr

The Plastic potential already defines the Voigt size.


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