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.
|
Updated Lagrangian Large Displacement Lagrangian U-wP Element for 3D and 2D geometries. Linear Triangles and Tetrahedra (base class) More...
#include <updated_lagrangian_U_wP_element.hpp>
Public Member Functions | |
Life Cycle | |
UpdatedLagrangianUwPElement () | |
Empty constructor needed for serialization. More... | |
UpdatedLagrangianUwPElement (IndexType NewId, GeometryType::Pointer pGeometry) | |
Default constructors. More... | |
UpdatedLagrangianUwPElement (IndexType NewId, GeometryType::Pointer pGeometry, PropertiesType::Pointer pProperties) | |
UpdatedLagrangianUwPElement (UpdatedLagrangianUwPElement const &rOther) | |
Copy constructor. More... | |
virtual | ~UpdatedLagrangianUwPElement () |
Destructor. More... | |
Operators | |
UpdatedLagrangianUwPElement & | operator= (UpdatedLagrangianUwPElement const &rOther) |
Assignment operator. More... | |
Operations | |
Element::Pointer | Create (IndexType NewId, NodesArrayType const &ThisNodes, PropertiesType::Pointer pProperties) const override |
Element::Pointer | Clone (IndexType NewId, NodesArrayType const &ThisNodes) const override |
void | GetValueOnIntegrationPoints (const Variable< double > &rVariable, std::vector< double > &rValues, const ProcessInfo &rCurrentProcessInfo) override |
void | GetValueOnIntegrationPoints (const Variable< Vector > &rVariable, std::vector< Vector > &rValues, const ProcessInfo &rCurrentProcessInfo) override |
void | GetValueOnIntegrationPoints (const Variable< Matrix > &rVariable, std::vector< Matrix > &rValue, const ProcessInfo &rCurrentProcessInfo) override |
void | GetDofList (DofsVectorType &rElementalDofList, ProcessInfo &rCurrentProcessInfo) override |
void | EquationIdVector (EquationIdVectorType &rResult, ProcessInfo &rCurrentProcessInfo) override |
void | GetValuesVector (Vector &rValues, int Step=0) const override |
void | GetFirstDerivativesVector (Vector &rValues, int Step=0) const override |
void | GetSecondDerivativesVector (Vector &rValues, int Step=0) const override |
int | Check (const ProcessInfo &rCurrentProcessInfo) override |
Public Member Functions inherited from Kratos::UpdatedLagrangianElement< TDim > | |
UpdatedLagrangianElement (IndexType NewId=0) | |
Default constuctor. More... | |
UpdatedLagrangianElement (IndexType NewId, const NodesArrayType &ThisNodes) | |
Constructor using an array of nodes. More... | |
UpdatedLagrangianElement (IndexType NewId, GeometryType::Pointer pGeometry) | |
Constructor using a geometry object. More... | |
UpdatedLagrangianElement (IndexType NewId, GeometryType::Pointer pGeometry, PropertiesType::Pointer pProperties) | |
Constuctor using geometry and properties. More... | |
UpdatedLagrangianElement (UpdatedLagrangianElement const &rOther) | |
copy constructor More... | |
virtual | ~UpdatedLagrangianElement () |
Destructor. More... | |
UpdatedLagrangianElement (IndexType NewId, GeometryType::Pointer pGeometry) | |
Default constructors. More... | |
UpdatedLagrangianElement (IndexType NewId, GeometryType::Pointer pGeometry, PropertiesType::Pointer pProperties) | |
UpdatedLagrangianElement (UpdatedLagrangianElement const &rOther) | |
Copy constructor. More... | |
~UpdatedLagrangianElement () override | |
Destructor. More... | |
virtual void | Initialize (const ProcessInfo &rCurrentProcessInfo) override |
virtual void | InitializeSolutionStep (const ProcessInfo &rCurrentProcessInfo) override |
Initializes the element and all geometric information required for the problem. More... | |
virtual void | InitializeNonLinearIteration (const ProcessInfo &rCurrentProcessInfo) override |
virtual void | Calculate (const Variable< array_1d< double, 3 >> &rVariable, array_1d< double, 3 > &rOutput, const ProcessInfo &rCurrentProcessInfo) override |
virtual void | CalculateLocalSystem (MatrixType &rLeftHandSideMatrix, VectorType &rRightHandSideVector, const ProcessInfo &rCurrentProcessInfo) override |
Calculate the element's local contribution to the system for the current step. More... | |
void | CalculateLeftHandSide (MatrixType &rLeftHandSideMatrix, const ProcessInfo &rCurrentProcessInfo) override |
void | CalculateRightHandSide (VectorType &rRightHandSideVector, const ProcessInfo &rCurrentProcessInfo) override |
void | EquationIdVector (EquationIdVectorType &rResult, const ProcessInfo &rCurrentProcessInfo) const override |
Provides the global indices for each one of this element's local rows. More... | |
void | GetDofList (DofsVectorType &rElementalDofList, const ProcessInfo &rCurrentProcessInfo) const override |
Returns a list of the element's Dofs. More... | |
GeometryData::IntegrationMethod | GetIntegrationMethod () const override |
virtual void | UpdateCauchyStress (unsigned int g, const ProcessInfo &rCurrentProcessInfo) |
virtual void | InitializeElementalVariables (ElementalVariables &rElementalVariables) |
void | CalculateDeltaPosition (Matrix &rDeltaPosition) |
Element::Pointer | Create (IndexType NewId, NodesArrayType const &ThisNodes, PropertiesType::Pointer pProperties) const override |
Element::Pointer | Clone (IndexType NewId, NodesArrayType const &ThisNodes) const override |
void | SetValuesOnIntegrationPoints (const Variable< double > &rVariable, const std::vector< double > &rValues, const ProcessInfo &rCurrentProcessInfo) override |
void | CalculateOnIntegrationPoints (const Variable< double > &rVariable, std::vector< double > &rValues, const ProcessInfo &rCurrentProcessInfo) override |
void | Initialize (const ProcessInfo &rCurrentProcessInfo) override |
int | Check (const ProcessInfo &rCurrentProcessInfo) const override |
int | Check (const ProcessInfo &rCurrentProcessInfo) const override |
Checks the input and that all required Kratos variables have been registered. More... | |
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... | |
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... | |
UpdatedLagrangianElement & | operator= (UpdatedLagrangianElement const &rOther) |
Assignment operator. More... | |
KRATOS_CLASS_INTRUSIVE_POINTER_DEFINITION (UpdatedLagrangianElement) | |
Pointer definition of UpdatedLagrangianElement. More... | |
KRATOS_CLASS_INTRUSIVE_POINTER_DEFINITION (UpdatedLagrangianElement) | |
Counted pointer of UpdatedLagrangianElement. More... | |
Public Member Functions inherited from Kratos::Element | |
Element (IndexType NewId=0) | |
Element (IndexType NewId, const NodesArrayType &ThisNodes) | |
Element (IndexType NewId, GeometryType::Pointer pGeometry) | |
Element (IndexType NewId, GeometryType::Pointer pGeometry, PropertiesType::Pointer pProperties) | |
Element (Element const &rOther) | |
Copy constructor. More... | |
~Element () override | |
Destructor. More... | |
Element & | operator= (Element const &rOther) |
Assignment operator. More... | |
virtual Pointer | Create (IndexType NewId, GeometryType::Pointer pGeom, PropertiesType::Pointer pProperties) const |
It creates a new element pointer. More... | |
virtual void | CalculateFirstDerivativesLHS (MatrixType &rLeftHandSideMatrix, const ProcessInfo &rCurrentProcessInfo) |
virtual void | CalculateFirstDerivativesRHS (VectorType &rRightHandSideVector, const ProcessInfo &rCurrentProcessInfo) |
virtual void | CalculateLumpedMassVector (VectorType &rLumpedMassVector, const ProcessInfo &rCurrentProcessInfo) const |
virtual void | AddExplicitContribution (const ProcessInfo &rCurrentProcessInfo) |
virtual void | AddExplicitContribution (const VectorType &rRHSVector, const Variable< VectorType > &rRHSVariable, const Variable< double > &rDestinationVariable, const ProcessInfo &rCurrentProcessInfo) |
This function is designed to make the element to assemble an rRHS vector identified by a variable rRHSVariable by assembling it to the nodes on the variable rDestinationVariable. (This is the double version) More... | |
virtual void | AddExplicitContribution (const MatrixType &rLHSMatrix, const Variable< MatrixType > &rLHSVariable, const Variable< Matrix > &rDestinationVariable, const ProcessInfo &rCurrentProcessInfo) |
This function is designed to make the element to assemble an rRHS vector identified by a variable rRHSVariable by assembling it to the nodes on the variable rDestinationVariable. (This is the matrix version) More... | |
virtual void | Calculate (const Variable< double > &rVariable, double &Output, const ProcessInfo &rCurrentProcessInfo) |
virtual void | Calculate (const Variable< array_1d< double, 3 > > &rVariable, array_1d< double, 3 > &Output, const ProcessInfo &rCurrentProcessInfo) |
virtual void | Calculate (const Variable< Vector > &rVariable, Vector &Output, const ProcessInfo &rCurrentProcessInfo) |
virtual void | Calculate (const Variable< Matrix > &rVariable, Matrix &Output, const ProcessInfo &rCurrentProcessInfo) |
virtual void | CalculateOnIntegrationPoints (const Variable< bool > &rVariable, std::vector< bool > &rOutput, const ProcessInfo &rCurrentProcessInfo) |
virtual void | CalculateOnIntegrationPoints (const Variable< int > &rVariable, std::vector< int > &rOutput, const ProcessInfo &rCurrentProcessInfo) |
virtual void | CalculateOnIntegrationPoints (const Variable< array_1d< double, 3 >> &rVariable, std::vector< array_1d< double, 3 >> &rOutput, const ProcessInfo &rCurrentProcessInfo) |
virtual void | CalculateOnIntegrationPoints (const Variable< array_1d< double, 4 >> &rVariable, std::vector< array_1d< double, 4 >> &rOutput, const ProcessInfo &rCurrentProcessInfo) |
virtual void | CalculateOnIntegrationPoints (const Variable< array_1d< double, 6 >> &rVariable, std::vector< array_1d< double, 6 >> &rOutput, const ProcessInfo &rCurrentProcessInfo) |
virtual void | CalculateOnIntegrationPoints (const Variable< array_1d< double, 9 >> &rVariable, std::vector< array_1d< double, 9 >> &rOutput, const ProcessInfo &rCurrentProcessInfo) |
virtual void | SetValuesOnIntegrationPoints (const Variable< bool > &rVariable, const std::vector< bool > &rValues, const ProcessInfo &rCurrentProcessInfo) |
virtual void | SetValuesOnIntegrationPoints (const Variable< int > &rVariable, const std::vector< int > &rValues, const ProcessInfo &rCurrentProcessInfo) |
virtual void | SetValuesOnIntegrationPoints (const Variable< array_1d< double, 3 >> &rVariable, const std::vector< array_1d< double, 3 >> &rValues, const ProcessInfo &rCurrentProcessInfo) |
virtual void | SetValuesOnIntegrationPoints (const Variable< array_1d< double, 4 >> &rVariable, const std::vector< array_1d< double, 4 >> &rValues, const ProcessInfo &rCurrentProcessInfo) |
virtual void | SetValuesOnIntegrationPoints (const Variable< array_1d< double, 6 >> &rVariable, const std::vector< array_1d< double, 6 >> &rValues, const ProcessInfo &rCurrentProcessInfo) |
virtual void | SetValuesOnIntegrationPoints (const Variable< array_1d< double, 9 >> &rVariable, const std::vector< array_1d< double, 9 >> &rValues, const ProcessInfo &rCurrentProcessInfo) |
virtual void | MassMatrix (MatrixType &rMassMatrix, const ProcessInfo &rCurrentProcessInfo) |
virtual void | AddMassMatrix (MatrixType &rLeftHandSideMatrix, double coeff, const ProcessInfo &rCurrentProcessInfo) |
virtual void | DampMatrix (MatrixType &rDampMatrix, const ProcessInfo &rCurrentProcessInfo) |
virtual void | AddInertiaForces (VectorType &rRightHandSideVector, double coeff, const ProcessInfo &rCurrentProcessInfo) |
virtual void | CalculateLocalVelocityContribution (MatrixType &rDampingMatrix, VectorType &rRightHandSideVector, const ProcessInfo &rCurrentProcessInfo) |
virtual void | CalculateSensitivityMatrix (const Variable< double > &rDesignVariable, Matrix &rOutput, const ProcessInfo &rCurrentProcessInfo) |
virtual void | CalculateSensitivityMatrix (const Variable< array_1d< double, 3 > > &rDesignVariable, Matrix &rOutput, const ProcessInfo &rCurrentProcessInfo) |
PropertiesType::Pointer | pGetProperties () |
returns the pointer to the property of the element. Does not throw an error, to allow copying of elements which don't have any property assigned. More... | |
const PropertiesType::Pointer | pGetProperties () const |
PropertiesType & | GetProperties () |
PropertiesType const & | GetProperties () const |
void | SetProperties (PropertiesType::Pointer pProperties) |
bool | HasProperties () const |
Check that the Element has a correctly initialized pointer to a Properties instance. More... | |
virtual const Parameters | GetSpecifications () const |
This method provides the specifications/requirements of the element. More... | |
KRATOS_CLASS_INTRUSIVE_POINTER_DEFINITION (Element) | |
Public Member Functions inherited from Kratos::GeometricalObject | |
GeometricalObject (IndexType NewId=0) | |
Default constructor. More... | |
GeometricalObject (IndexType NewId, GeometryType::Pointer pGeometry) | |
Default constructor. More... | |
~GeometricalObject () override | |
Destructor. More... | |
GeometricalObject (GeometricalObject const &rOther) | |
Copy constructor. More... | |
GeometricalObject & | operator= (GeometricalObject const &rOther) |
Assignment operator. More... | |
virtual void | SetGeometry (GeometryType::Pointer pGeometry) |
Sets the pointer to the geometry. More... | |
GeometryType::Pointer | pGetGeometry () |
Returns the pointer to the geometry. More... | |
const GeometryType::Pointer | pGetGeometry () const |
Returns the pointer to the geometry (const version) More... | |
GeometryType & | GetGeometry () |
Returns the reference of the geometry. More... | |
GeometryType const & | GetGeometry () const |
Returns the reference of the geometry (const version) More... | |
Flags & | GetFlags () |
Returns the flags of the object. More... | |
Flags const & | GetFlags () const |
Returns the flags of the object (const version) More... | |
void | SetFlags (Flags const &rThisFlags) |
Sets the flags of the object. More... | |
DataValueContainer & | Data () |
DataValueContainer & | GetData () |
DataValueContainer const & | GetData () const |
void | SetData (DataValueContainer const &rThisData) |
template<class TDataType > | |
bool | Has (const Variable< TDataType > &rThisVariable) const |
template<class TVariableType > | |
void | SetValue (const TVariableType &rThisVariable, typename TVariableType::Type const &rValue) |
template<class TVariableType > | |
TVariableType::Type & | GetValue (const TVariableType &rThisVariable) |
template<class TVariableType > | |
TVariableType::Type const & | GetValue (const TVariableType &rThisVariable) const |
unsigned int | use_count () const noexcept |
KRATOS_CLASS_INTRUSIVE_POINTER_DEFINITION (GeometricalObject) | |
Pointer definition of GeometricalObject. More... | |
bool | IsActive () const |
Checks if the GeometricalObject is active. More... | |
Public Member Functions inherited from Kratos::IndexedObject | |
IndexedObject (IndexType NewId=0) | |
Default constructor. More... | |
virtual | ~IndexedObject () |
Destructor. More... | |
IndexedObject (IndexedObject const &rOther) | |
Copy constructor. More... | |
IndexedObject & | operator= (IndexedObject const &rOther) |
Assignment operator. More... | |
template<class TObjectType > | |
IndexType | operator() (TObjectType const &rThisObject) const |
IndexType | Id () const |
IndexType | GetId () const |
virtual void | SetId (IndexType NewId) |
IndexType & | DepricatedIdAccess () |
TODO: remove this function when removing data_file_io object. More... | |
KRATOS_CLASS_POINTER_DEFINITION (IndexedObject) | |
Pointer definition of IndexedObject. More... | |
Public Member Functions inherited from Kratos::Flags | |
Flags & | operator= (Flags const &rOther) |
Assignment operator. More... | |
operator bool () const | |
Flags | operator~ () const |
bool | operator! () const |
void | AssignFlags (Flags const &rOther) |
void | Set (const Flags ThisFlag) |
void | Set (const Flags ThisFlag, bool Value) |
void | Reset (const Flags ThisFlag) |
void | Flip (const Flags ThisFlag) |
void | SetPosition (IndexType Position, bool Value=true) |
bool | GetPosition (IndexType Position) const |
void | FlipPosition (IndexType Position) |
void | ClearPosition (IndexType Position) |
void | Clear () |
Flags | AsFalse () const |
bool | Is (Flags const &rOther) const |
bool | IsDefined (Flags const &rOther) const |
bool | IsNot (Flags const &rOther) const |
bool | IsNotDefined (Flags const &rOther) const |
KRATOS_CLASS_POINTER_DEFINITION (Flags) | |
Pointer definition of Flags. More... | |
const Flags & | operator|= (const Flags &Other) |
const Flags & | operator&= (const Flags &Other) |
Flags () | |
Default constructor. More... | |
Flags (Flags const &rOther) | |
Copy constructor. More... | |
virtual | ~Flags () |
Destructor. More... | |
Public Member Functions inherited from Kratos::LargeDisplacementElement | |
LargeDisplacementElement () | |
Empty constructor needed for serialization. More... | |
LargeDisplacementElement (IndexType NewId, GeometryType::Pointer pGeometry) | |
Default constructors. More... | |
LargeDisplacementElement (IndexType NewId, GeometryType::Pointer pGeometry, PropertiesType::Pointer pProperties) | |
LargeDisplacementElement (LargeDisplacementElement const &rOther) | |
Copy constructor. More... | |
~LargeDisplacementElement () override | |
Destructor. More... | |
LargeDisplacementElement & | operator= (LargeDisplacementElement const &rOther) |
Assignment operator. More... | |
void | InitializeSolutionStep (const ProcessInfo &rCurrentProcessInfo) override |
void | FinalizeSolutionStep (const ProcessInfo &rCurrentProcessInfo) override |
void | CalculateOnIntegrationPoints (const Variable< Vector > &rVariable, std::vector< Vector > &rOutput, const ProcessInfo &rCurrentProcessInfo) override |
void | CalculateOnIntegrationPoints (const Variable< Matrix > &rVariable, std::vector< Matrix > &rOutput, const ProcessInfo &rCurrentProcessInfo) override |
KRATOS_CLASS_INTRUSIVE_POINTER_DEFINITION (LargeDisplacementElement) | |
Counted pointer of LargeDisplacementElement. More... | |
Public Member Functions inherited from Kratos::SolidElement | |
SolidElement () | |
Empty constructor needed for serialization. More... | |
SolidElement (IndexType NewId, GeometryType::Pointer pGeometry) | |
Default constructors. More... | |
SolidElement (IndexType NewId, GeometryType::Pointer pGeometry, PropertiesType::Pointer pProperties) | |
SolidElement (SolidElement const &rOther) | |
Copy constructor. More... | |
~SolidElement () override | |
Destructor. More... | |
SolidElement () | |
Empty constructor needed for serialization. More... | |
SolidElement (IndexType NewId, GeometryType::Pointer pGeometry) | |
Default constructors. More... | |
SolidElement (IndexType NewId, GeometryType::Pointer pGeometry, PropertiesType::Pointer pProperties) | |
SolidElement (SolidElement const &rOther) | |
Copy constructor. More... | |
~SolidElement () override | |
Destructor. More... | |
SolidElement & | operator= (SolidElement const &rOther) |
Assignment operator. More... | |
SolidElement & | operator= (SolidElement const &rOther) |
Assignment operator. More... | |
void | GetDofList (DofsVectorType &rElementalDofList, const ProcessInfo &rCurrentProcessInfo) const override |
void | SetValuesOnIntegrationPoints (const Variable< Vector > &rVariable, const std::vector< Vector > &rValues, const ProcessInfo &rCurrentProcessInfo) override |
void | SetValuesOnIntegrationPoints (const Variable< Matrix > &rVariable, const std::vector< Matrix > &rValues, const ProcessInfo &rCurrentProcessInfo) override |
void | SetValuesOnIntegrationPoints (const Variable< ConstitutiveLaw::Pointer > &rVariable, const std::vector< ConstitutiveLaw::Pointer > &rValues, const ProcessInfo &rCurrentProcessInfo) override |
void | FinalizeNonLinearIteration (const ProcessInfo &rCurrentProcessInfo) override |
void | CalculateFirstDerivativesContributions (MatrixType &rLeftHandSideMatrix, VectorType &rRightHandSideVector, const ProcessInfo &rCurrentProcessInfo) override |
void | CalculateSecondDerivativesContributions (MatrixType &rLeftHandSideMatrix, VectorType &rRightHandSideVector, const ProcessInfo &rCurrentProcessInfo) override |
void | CalculateSecondDerivativesLHS (MatrixType &rLeftHandSideMatrix, const ProcessInfo &rCurrentProcessInfo) override |
void | CalculateSecondDerivativesRHS (VectorType &rRightHandSideVector, const ProcessInfo &rCurrentProcessInfo) override |
void | CalculateDampingMatrix (MatrixType &rDampingMatrix, const ProcessInfo &rCurrentProcessInfo) override |
void | AddExplicitContribution (const VectorType &rRHSVector, const Variable< VectorType > &rRHSVariable, const Variable< array_1d< double, 3 > > &rDestinationVariable, const ProcessInfo &rCurrentProcessInfo) override |
IntegrationMethod | GetIntegrationMethod () const override |
void | GetDofList (DofsVectorType &rElementalDofList, const ProcessInfo &rCurrentProcessInfo) const override |
void | EquationIdVector (EquationIdVectorType &rResult, const ProcessInfo &rCurrentProcessInfo) const override |
void | GetValuesVector (Vector &rValues, int Step=0) const override |
void | GetFirstDerivativesVector (Vector &rValues, int Step=0) const override |
void | GetSecondDerivativesVector (Vector &rValues, int Step=0) const override |
void | SetValuesOnIntegrationPoints (const Variable< Vector > &rVariable, const std::vector< Vector > &rValues, const ProcessInfo &rCurrentProcessInfo) override |
void | SetValuesOnIntegrationPoints (const Variable< Matrix > &rVariable, const std::vector< Matrix > &rValues, const ProcessInfo &rCurrentProcessInfo) override |
void | SetValuesOnIntegrationPoints (const Variable< ConstitutiveLaw::Pointer > &rVariable, const std::vector< ConstitutiveLaw::Pointer > &rValues, const ProcessInfo &rCurrentProcessInfo) override |
void | CalculateOnIntegrationPoints (const Variable< ConstitutiveLaw::Pointer > &rVariable, std::vector< ConstitutiveLaw::Pointer > &rValues, const ProcessInfo &rCurrentProcessInfo) override |
void | InitializeSolutionStep (const ProcessInfo &rCurrentProcessInfo) override |
void | InitializeNonLinearIteration (const ProcessInfo &rCurrentProcessInfo) override |
void | FinalizeNonLinearIteration (const ProcessInfo &rCurrentProcessInfo) override |
void | FinalizeSolutionStep (const ProcessInfo &rCurrentProcessInfo) override |
void | CalculateLocalSystem (MatrixType &rLeftHandSideMatrix, VectorType &rRightHandSideVector, const ProcessInfo &rCurrentProcessInfo) override |
void | CalculateRightHandSide (VectorType &rRightHandSideVector, const ProcessInfo &rCurrentProcessInfo) override |
void | CalculateLeftHandSide (MatrixType &rLeftHandSideMatrix, const ProcessInfo &rCurrentProcessInfo) override |
void | CalculateFirstDerivativesContributions (MatrixType &rLeftHandSideMatrix, VectorType &rRightHandSideVector, const ProcessInfo &rCurrentProcessInfo) override |
void | CalculateSecondDerivativesContributions (MatrixType &rLeftHandSideMatrix, VectorType &rRightHandSideVector, const ProcessInfo &rCurrentProcessInfo) override |
void | CalculateSecondDerivativesLHS (MatrixType &rLeftHandSideMatrix, const ProcessInfo &rCurrentProcessInfo) override |
void | CalculateSecondDerivativesRHS (VectorType &rRightHandSideVector, const ProcessInfo &rCurrentProcessInfo) override |
void | CalculateMassMatrix (MatrixType &rMassMatrix, const ProcessInfo &rCurrentProcessInfo) override |
void | CalculateDampingMatrix (MatrixType &rDampingMatrix, const ProcessInfo &rCurrentProcessInfo) override |
void | AddExplicitContribution (const VectorType &rRHSVector, const Variable< VectorType > &rRHSVariable, const Variable< array_1d< double, 3 > > &rDestinationVariable, const ProcessInfo &rCurrentProcessInfo) override |
void | CalculateOnIntegrationPoints (const Variable< Vector > &rVariable, std::vector< Vector > &rOutput, const ProcessInfo &rCurrentProcessInfo) override |
void | CalculateOnIntegrationPoints (const Variable< Matrix > &rVariable, std::vector< Matrix > &rOutput, const ProcessInfo &rCurrentProcessInfo) override |
KRATOS_CLASS_INTRUSIVE_POINTER_DEFINITION (SolidElement) | |
Counted pointer of SolidElement. More... | |
KRATOS_CLASS_INTRUSIVE_POINTER_DEFINITION (SolidElement) | |
Counted pointer of SolidElement. More... | |
Protected Member Functions | |
Protected Operations | |
void | CalculateAndAddLHS (LocalSystemComponents &rLocalSystem, ElementDataType &rVariables, double &rIntegrationWeight) override |
void | CalculateAndAddRHS (LocalSystemComponents &rLocalSystem, ElementDataType &rVariables, Vector &rVolumeForce, double &rIntegrationWeight) override |
void | InitializeElementData (ElementDataType &rVariables, const ProcessInfo &rCurrentProcessInfo) override |
void | InitializeSystemMatrices (MatrixType &rLeftHandSideMatrix, VectorType &rRightHandSideVector, Flags &rCalculationFlags) override |
void | CalculateOnIntegrationPoints (const Variable< double > &rVariable, std::vector< double > &rOutput, const ProcessInfo &rCurrentProcessInfo) override |
void | CalculateOnIntegrationPoints (const Variable< Vector > &rVariable, std::vector< Vector > &rOutput, const ProcessInfo &rCurrentProcessInfo) override |
void | CalculateOnIntegrationPoints (const Variable< Matrix > &rVariable, std::vector< Matrix > &rOutput, const ProcessInfo &rCurrentProcessInfo) override |
Protected Member Functions inherited from Kratos::UpdatedLagrangianElement< TDim > | |
void | VelocityEquationIdVector (EquationIdVectorType &rResult, const ProcessInfo &rCurrentProcessInfo) const |
void | VelocityEquationIdVector (EquationIdVectorType &rResult, const ProcessInfo &rCurrentProcessInfo) const |
void | GetVelocityDofList (DofsVectorType &rElementalDofList, const ProcessInfo &rCurrentProcessInfo) const |
void | GetVelocityDofList (DofsVectorType &rElementalDofList, const ProcessInfo &rCurrentProcessInfo) const |
void | CalcMeanVelocityNorm (double &meanVelocity, const int Step) |
void | CalcMeanVelocityNorm (double &meanVelocity, const int Step) |
void | GetDisplacementValues (Vector &rValues, const int Step) |
void | GetDisplacementValues (Vector &rValues, const int Step) |
void | GetVelocityValues (Vector &rValues, const int Step) |
void | GetVelocityValues (Vector &rValues, const int Step) |
void | GetAccelerationValues (Vector &rValues, const int Step) |
void | GetAccelerationValues (Vector &rValues, const int Step) |
void | GetPositions (Vector &rValues, const ProcessInfo &rCurrentProcessInfo, const double theta) |
void | GetPositions (Vector &rValues, const ProcessInfo &rCurrentProcessInfo, const double theta) |
void | CalcVolumetricDefRate (const ShapeFunctionDerivativesType &rDN_DX, double &volumetricDefRate, MatrixType &invGradDef, const double theta) |
void | CheckStrain1 (double &VolumetricDefRate, MatrixType &SpatialVelocityGrad) |
void | CalcMDGreenLagrangeMaterial (MatrixType &Fgrad, MatrixType &VelDefgrad, VectorType &MDGreenLagrangeMaterial) |
void | CalcMDGreenLagrangeMaterial (MatrixType &Fgrad, MatrixType &VelDefgrad, VectorType &MDGreenLagrangeMaterial) |
void | CalcSpatialDefRate (VectorType &MDGreenLagrangeMaterial, MatrixType &invFgrad, VectorType &SpatialDefRate) |
void | CalcSpatialDefRate (VectorType &MDGreenLagrangeMaterial, MatrixType &invFgrad, VectorType &SpatialDefRate) |
void | CalcDeviatoricInvariant (VectorType &SpatialDefRate, double &DeviatoricInvariant) |
void | CalcEquivalentStrainRate (VectorType &SpatialDefRate, double &EquivalentStrainRate) |
void | CalcDeviatoricInvariant (VectorType &SpatialDefRate, double &DeviatoricInvariant) |
void | CalcEquivalentStrainRate (VectorType &SpatialDefRate, double &EquivalentStrainRate) |
double | CalcNormalProjectionDefRate (const VectorType &SpatialDefRate, const array_1d< double, 3 > NormalVector) |
double | CalcNormalProjectionDefRate (const VectorType &SpatialDefRate, const array_1d< double, 3 > NormalVector) |
double | CalcNormalProjectionDefRate (VectorType &SpatialDefRate) |
double | CalcNormalProjectionDefRate (VectorType &SpatialDefRate) |
bool | CalcCompleteStrainRate (ElementalVariables &rElementalVariables, const ProcessInfo &rCurrentProcessInfo, const ShapeFunctionDerivativesType &rDN_DX, const double theta) |
bool | CalcCompleteStrainRate (ElementalVariables &rElementalVariables, const ProcessInfo &rCurrentProcessInfo, const ShapeFunctionDerivativesType &rDN_DX, const double theta) |
void | CheckStrain2 (MatrixType &SpatialVelocityGrad, MatrixType &Fgrad, MatrixType &VelDefgrad) |
bool | CheckStrain3 (VectorType &SpatialDefRate, MatrixType &SpatialVelocityGrad) |
bool | CheckStrain3 (VectorType &SpatialDefRate, MatrixType &SpatialVelocityGrad) |
void | CalcVolumetricDefRate (const ShapeFunctionDerivativesType &rDN_DX, double &volumetricDefRate, MatrixType &invGradDef, const double theta) |
void | CheckStrain1 (double &VolumetricDefRate, MatrixType &SpatialVelocityGrad) |
void | CheckStrain2 (MatrixType &SpatialVelocityGrad, MatrixType &Fgrad, MatrixType &VelDefgrad) |
void | ComputeMechanicalDissipation (ElementalVariables &rElementalVariables) |
void | ComputeMechanicalDissipation (ElementalVariables &rElementalVariables) |
virtual void | CalculateLocalMomentumEquations (MatrixType &rLeftHandSideMatrix, VectorType &rRightHandSideVector, const ProcessInfo &rCurrentProcessInfo) |
virtual void | CalculateLocalContinuityEqForPressure (MatrixType &rLeftHandSideMatrix, VectorType &rRightHandSideVector, const ProcessInfo &rCurrentProcessInfo) |
virtual void | CalculateExplicitContinuityEquation (MatrixType &rLeftHandSideMatrix, VectorType &rRightHandSideVector, const ProcessInfo &rCurrentProcessInfo) |
virtual double | GetThetaMomentum () |
virtual double | GetThetaContinuity () |
void | VelocityEquationIdVector (EquationIdVectorType &rResult, const ProcessInfo &rCurrentProcessInfo) const |
void | PressureEquationIdVector (EquationIdVectorType &rResult, const ProcessInfo &rCurrentProcessInfo) const |
void | GetVelocityDofList (DofsVectorType &rElementalDofList, const ProcessInfo &rCurrentProcessInfo) const |
void | GetPressureDofList (DofsVectorType &rElementalDofList, const ProcessInfo &rCurrentProcessInfo) const |
void | CalcMeanVelocityNorm (double &meanVelocity, const int Step) |
void | CalcMeanPressure (double &meanPressure, const int Step) |
void | GetPressureValues (Vector &rValues, const int Step=0) |
void | GetFluidFractionRateValues (Vector &rValues) |
void | GetDensityValues (Vector &rValues, const int Step=0) |
void | GetVelocityValues (Vector &rValues, const int Step=0) |
void | GetDisplacementValues (Vector &rValues, const int Step=0) |
void | GetPositions (Vector &rValues, const ProcessInfo &rCurrentProcessInfo, const double theta) |
void | GetAccelerationValues (Vector &rValues, const int Step=0) |
void | GetPressureVelocityValues (Vector &rValues, const int Step) |
void | GetElementalAcceleration (Vector &rValues, const int Step, const double TimeStep) |
virtual void | CalculateGeometryData (ShapeFunctionDerivativesArrayType &rDN_DX, Matrix &rNContainer, Vector &rGaussWeights) |
Determine integration point weights and shape funcition derivatives from the element's geometry. More... | |
void | CalculateGeometryData (Vector &rGaussWeights) |
double | ElementSize () |
double | EquivalentStrainRate (const ShapeFunctionDerivativesType &rDN_DX) const |
EquivalentStrainRate Calculate the second invariant of the strain rate tensor GammaDot = (2SijSij)^0.5. More... | |
virtual void | CalculateMassMatrix (Matrix &rMassMatrix, const ProcessInfo &rCurrentProcessInfo) override |
Add integration point contribution to the mass matrix. More... | |
virtual void | ComputeMassMatrix (Matrix &rMassMatrix, const ShapeFunctionsType &rN, const double Weight, double &MeanValue) |
virtual void | ComputeLumpedMassMatrix (Matrix &rMassMatrix, const double Weight, double &MeanValue) |
virtual void | AddExternalForces (Vector &rRHSVector, const double Density, const ShapeFunctionsType &rN, const double Weight) |
virtual void | AddInternalForces (Vector &rRHSVector, const ShapeFunctionDerivativesType &rDN_DX, ElementalVariables &rElementalVariables, const double Weight) |
virtual void | ComputeBulkMatrixLump (MatrixType &BulkMatrix, const double Weight) |
virtual void | ComputeBulkMatrixRHS (MatrixType &BulkMatrix, const double Weight) |
bool | CalcMechanicsUpdated (ElementalVariables &rElementalVariables, const ProcessInfo &rCurrentProcessInfo, const ShapeFunctionDerivativesType &rDN_DX) |
bool | CalcStrainRate (ElementalVariables &rElementalVariables, const ProcessInfo &rCurrentProcessInfo, const ShapeFunctionDerivativesType &rDN_DX, const double theta) |
bool | CalcCompleteStrainRate (ElementalVariables &rElementalVariables, const ProcessInfo &rCurrentProcessInfo, const ShapeFunctionDerivativesType &rDN_DX, const double theta) |
void | CalcVelDefGrad (const ShapeFunctionDerivativesType &rDN_DX, MatrixType &FgradVel, const double theta) |
void | CalcVelDefGradAndInverse (const ShapeFunctionDerivativesType &rDN_DX, MatrixType &FgradVel, MatrixType &invFgradVel, double &FVelJacobian, const double theta) |
void | CalcFGrad (const ShapeFunctionDerivativesType &rDN_DX, MatrixType &Fgrad, MatrixType &invFgrad, double &FJacobian, const ProcessInfo &rCurrentProcessInfo, const double theta) |
void | CalcVolumetricDefRate (const ShapeFunctionDerivativesType &rDN_DX, double &volumetricDefRate, MatrixType &invGradDef, const double theta) |
void | CalcVolDefRateFromSpatialVelGrad (double &volumetricDefRate, MatrixType &SpatialVelocityGrad) |
void | CalcSpatialVelocityGrad (MatrixType &invFgrad, MatrixType &VelDefgrad, MatrixType &SpatialVelocityGrad) |
void | CalcMDGreenLagrangeMaterial (MatrixType &Fgrad, MatrixType &VelDefgrad, VectorType &MDGreenLagrangeMaterial) |
void | CalcSpatialDefRate (VectorType &MDGreenLagrangeMaterial, MatrixType &invFgrad, VectorType &SpatialDefRate) |
void | CalcDeviatoricInvariant (VectorType &SpatialDefRate, double &DeviatoricInvariant) |
void | CalcEquivalentStrainRate (VectorType &SpatialDefRate, double &EquivalentStrainRate) |
double | CalcNormalProjectionDefRate (const VectorType &SpatialDefRate, const array_1d< double, 3 > NormalVector) |
double | CalcNormalProjectionDefRate (VectorType &SpatialDefRate) |
void | CheckStrain1 (double &VolumetricDefRate, MatrixType &SpatialVelocityGrad) |
void | CheckStrain2 (MatrixType &SpatialVelocityGrad, MatrixType &Fgrad, MatrixType &VelDefgrad) |
bool | CheckStrain3 (VectorType &SpatialDefRate, MatrixType &SpatialVelocityGrad) |
virtual void | CalcElasticPlasticCauchySplitted (ElementalVariables &rElementalVariables, const unsigned int g, const Vector &rN, const ProcessInfo &rCurrentProcessInfo, double &Density, double &DeviatoricCoeff, double &VolumetricCoeff) |
void | ComputeMechanicalDissipation (ElementalVariables &rElementalVariables) |
template<class TVariableType > | |
void | EvaluateInPoint (TVariableType &rResult, const Kratos::Variable< TVariableType > &Var, const ShapeFunctionsType &rShapeFunc) |
Write the value of a variable at a point inside the element to a double. More... | |
template<class TVariableType > | |
void | EvaluatePropertyFromANotRigidNode (TVariableType &rResult, const Kratos::Variable< TVariableType > &Var) |
template<class TVariableType > | |
void | EvaluateInPoint (TVariableType &rResult, const Kratos::Variable< TVariableType > &Var, const ShapeFunctionsType &rShapeFunc, const IndexType Step) |
Write the value of a variable at a point inside the element to a double. More... | |
template<class TVariableType > | |
void | EvaluateDifferenceInPoint (TVariableType &rResult, const Kratos::Variable< TVariableType > &Var, const ShapeFunctionsType &rShapeFunc) |
void | EvaluateGradientInPoint (array_1d< double, TDim > &rResult, const Kratos::Variable< double > &Var, const ShapeFunctionDerivativesType &rDN_DX) |
void | EvaluateGradientInPoint (array_1d< double, TDim > &rResult, const Kratos::Variable< double > &Var, const ShapeFunctionDerivativesType &rDN_DX, const IndexType Step) |
void | EvaluateGradientDifferenceInPoint (array_1d< double, TDim > &rResult, const Kratos::Variable< double > &Var, const ShapeFunctionDerivativesType &rDN_DX) |
void | EvaluateGradientDifferenceInPoint (array_1d< double, TDim > &rResult, const Kratos::Variable< double > &Var, const ShapeFunctionDerivativesType &rDN_DX, const double weight) |
void | EvaluateDivergenceInPoint (double &rResult, const Kratos::Variable< array_1d< double, 3 >> &Var, const ShapeFunctionDerivativesType &rDN_DX) |
template<class TValueType > | |
void | GetElementalValueForOutput (const Kratos::Variable< TValueType > &rVariable, std::vector< TValueType > &rOutput) |
Helper function to print results on gauss points. More... | |
void | GetOutwardsUnitNormalForTwoPoints (array_1d< double, 3 > &NormalVector, unsigned int idA, unsigned int idB, unsigned int otherId) |
void | GetOutwardsUnitNormalForTwoPoints (array_1d< double, 3 > &NormalVector, unsigned int idA, unsigned int idB, unsigned int otherId, double &edgeLength) |
void | GetOutwardsUnitNormalForThreePoints (array_1d< double, 3 > &NormalVector, unsigned int idA, unsigned int idB, unsigned int idC, unsigned int otherId) |
void | GetOutwardsUnitNormalForThreePoints (array_1d< double, 3 > &NormalVector, unsigned int idA, unsigned int idB, unsigned int idC, unsigned int otherId, double &surfaceArea) |
UpdatedLagrangianElement () | |
void | InitializeElementData (ElementDataType &rVariables, const ProcessInfo &rCurrentProcessInfo) override |
void | FinalizeStepVariables (ElementDataType &rVariables, const double &rPointNumber) override |
void | CalculateKinematics (ElementDataType &rVariables, const double &rPointNumber) override |
void | CalculateKinetics (ElementDataType &rVariables, const double &rPointNumber) override |
void | CalculateDeformationGradient (Matrix &rF, const Matrix &rDN_DX, const Matrix &rDeltaPosition) |
void | GetHistoricalVariables (ElementDataType &rVariables, const double &rPointNumber) override |
double & | CalculateVolumeChange (double &rVolumeChange, ElementDataType &rVariables) override |
Protected Member Functions inherited from Kratos::LargeDisplacementElement | |
void | CalculateAndAddKuug (MatrixType &rLeftHandSideMatrix, ElementDataType &rVariables, double &rIntegrationWeight) override |
void | SetElementData (ElementDataType &rVariables, ConstitutiveLaw::Parameters &rValues, const int &rPointNumber) override |
virtual void | CalculateGreenLagrangeStrain (const Matrix &rF, Vector &rStrainVector) |
virtual void | CalculateAlmansiStrain (const Matrix &rF, Vector &rStrainVector) |
Protected Member Functions inherited from Kratos::SolidElement | |
void | IncreaseIntegrationMethod (IntegrationMethod &rThisIntegrationMethod, unsigned int increment) const |
virtual void | CalculateElementalSystem (LocalSystemComponents &rLocalSystem, const ProcessInfo &rCurrentProcessInfo) |
virtual void | CalculateDynamicSystem (LocalSystemComponents &rLocalSystem, const ProcessInfo &rCurrentProcessInfo) |
void | PrintElementCalculation (LocalSystemComponents &rLocalSystem, ElementDataType &rVariables) |
void | CalculatePerturbedLeftHandSide (MatrixType &rLeftHandSideMatrix, const ProcessInfo &rCurrentProcessInfo) |
virtual void | CalculateAndAddDynamicLHS (MatrixType &rLeftHandSideMatrix, ElementDataType &rVariables, const ProcessInfo &rCurrentProcessInfo, double &rIntegrationWeight) |
virtual void | CalculateAndAddDynamicRHS (VectorType &rRightHandSideVector, ElementDataType &rVariables, const ProcessInfo &rCurrentProcessInfo, double &rIntegrationWeight) |
virtual void | CalculateAndAddKuum (MatrixType &rLeftHandSideMatrix, ElementDataType &rVariables, double &rIntegrationWeight) |
virtual void | CalculateAndAddExternalForces (VectorType &rRightHandSideVector, ElementDataType &rVariables, Vector &rVolumeForce, double &rIntegrationWeight) |
virtual void | CalculateAndAddInternalForces (VectorType &rRightHandSideVector, ElementDataType &rVariables, double &rIntegrationWeight) |
virtual void | CalculateMaterialResponse (ElementDataType &rVariables, ConstitutiveLaw::Parameters &rValues, const int &rPointNumber) |
virtual SizeType | GetDofsSize () const |
bool | IsSliver () |
void | InitializeConstitutiveLaw () |
void | ResetConstitutiveLaw () override |
void | InitializeExplicitContributions () |
virtual void | TransformElementData (ElementDataType &rVariables, const double &rPointNumber) |
virtual double & | CalculateIntegrationWeight (double &rIntegrationWeight) |
virtual double & | CalculateTotalMass (double &rTotalMass, const ProcessInfo &rCurrentProcessInfo) |
virtual Matrix & | CalculateTotalDeltaPosition (Matrix &rDeltaPosition) |
virtual Vector & | CalculateVolumeForce (Vector &rVolumeForce, ElementDataType &rVariables) |
void | IncreaseIntegrationMethod (IntegrationMethod &rThisIntegrationMethod, unsigned int increment) const |
virtual void | CalculateElementalSystem (LocalSystemComponents &rLocalSystem, const ProcessInfo &rCurrentProcessInfo) |
virtual void | CalculateDynamicSystem (LocalSystemComponents &rLocalSystem, const ProcessInfo &rCurrentProcessInfo) |
void | PrintElementCalculation (LocalSystemComponents &rLocalSystem, ElementDataType &rVariables) |
void | CalculatePerturbedLeftHandSide (MatrixType &rLeftHandSideMatrix, const ProcessInfo &rCurrentProcessInfo) |
virtual void | CalculateAndAddDynamicLHS (MatrixType &rLeftHandSideMatrix, ElementDataType &rVariables, const ProcessInfo &rCurrentProcessInfo, double &rIntegrationWeight) |
virtual void | CalculateAndAddDynamicRHS (VectorType &rRightHandSideVector, ElementDataType &rVariables, const ProcessInfo &rCurrentProcessInfo, double &rIntegrationWeight) |
virtual void | CalculateAndAddKuum (MatrixType &rLeftHandSideMatrix, ElementDataType &rVariables, double &rIntegrationWeight) |
virtual void | CalculateAndAddExternalForces (VectorType &rRightHandSideVector, ElementDataType &rVariables, Vector &rVolumeForce, double &rIntegrationWeight) |
virtual void | CalculateAndAddInternalForces (VectorType &rRightHandSideVector, ElementDataType &rVariables, double &rIntegrationWeight) |
virtual void | CalculateMaterialResponse (ElementDataType &rVariables, ConstitutiveLaw::Parameters &rValues, const int &rPointNumber) |
virtual SizeType | GetDofsSize () const |
bool | IsSliver () |
void | InitializeConstitutiveLaw () |
void | ResetConstitutiveLaw () override |
void | InitializeExplicitContributions () |
virtual void | TransformElementData (ElementDataType &rVariables, const double &rPointNumber) |
virtual double & | CalculateIntegrationWeight (double &rIntegrationWeight) |
virtual double & | CalculateTotalMass (double &rTotalMass, const ProcessInfo &rCurrentProcessInfo) |
virtual Matrix & | CalculateTotalDeltaPosition (Matrix &rDeltaPosition) |
virtual Vector & | CalculateVolumeForce (Vector &rVolumeForce, ElementDataType &rVariables) |
KRATOS_DEFINE_LOCAL_FLAG (COMPUTE_RHS_VECTOR) | |
KRATOS_DEFINE_LOCAL_FLAG (COMPUTE_LHS_MATRIX) | |
KRATOS_DEFINE_LOCAL_FLAG (FINALIZED_STEP) | |
KRATOS_DEFINE_LOCAL_FLAG (COMPUTE_RHS_VECTOR) | |
KRATOS_DEFINE_LOCAL_FLAG (COMPUTE_LHS_MATRIX) | |
KRATOS_DEFINE_LOCAL_FLAG (FINALIZED_STEP) | |
Protected Attributes | |
Protected member Variables | |
double | mTimeStep |
Protected Attributes inherited from Kratos::UpdatedLagrangianElement< TDim > | |
double | mMaterialDeviatoricCoefficient = 0 |
double | mMaterialVolumetricCoefficient = 0 |
double | mMaterialDensity = 0 |
ConstitutiveLaw::Pointer | mpConstitutiveLaw = nullptr |
std::vector< Matrix > | mDeformationGradientF0 |
Vector | mDeterminantF0 |
Protected Attributes inherited from Kratos::SolidElement | |
IntegrationMethod | mThisIntegrationMethod |
std::vector< ConstitutiveLaw::Pointer > | mConstitutiveLawVector |
Type Definitions | |
typedef ConstitutiveLaw | ConstitutiveLawType |
typedef ConstitutiveLawType::Pointer | ConstitutiveLawPointerType |
Pointer type for constitutive laws. More... | |
typedef ConstitutiveLawType::StressMeasure | StressMeasureType |
StressMeasure from constitutive laws. More... | |
typedef GeometryData::IntegrationMethod | IntegrationMethod |
Type definition for integration methods. More... | |
typedef GeometryData::SizeType | SizeType |
Type for size. More... | |
typedef UpdatedLagrangianElement::ElementDataType | ElementDataType |
Type for element variables. More... | |
KRATOS_CLASS_INTRUSIVE_POINTER_DEFINITION (UpdatedLagrangianUwPElement) | |
Counted pointer of LargeDisplacementUPElement. More... | |
Serialization | |
class | Serializer |
Additional Inherited Members | |
Public Types inherited from Kratos::UpdatedLagrangianElement< TDim > | |
typedef Node | NodeType |
Node type (default is: Node) More... | |
typedef Geometry< NodeType > | GeometryType |
Geometry type (using with given NodeType) More... | |
typedef Geometry< NodeType >::PointsArrayType | NodesArrayType |
Definition of nodes container type, redefined from GeometryType. More... | |
typedef Vector | VectorType |
Vector type for local contributions to the linear system. More... | |
typedef Matrix | MatrixType |
Matrix type for local contributions to the linear system. More... | |
typedef std::size_t | IndexType |
typedef std::size_t | SizeType |
typedef std::vector< std::size_t > | EquationIdVectorType |
typedef std::vector< Dof< double >::Pointer > | DofsVectorType |
typedef PointerVectorSet< Dof< double >, IndexedObject > | DofsArrayType |
typedef Kratos::Vector | ShapeFunctionsType |
Type for shape function values container. More... | |
typedef Kratos::Matrix | ShapeFunctionDerivativesType |
Type for a matrix containing the shape function gradients. More... | |
typedef GeometryType::ShapeFunctionsGradientsType | ShapeFunctionDerivativesArrayType |
Type for an array of shape function gradient matrices. More... | |
typedef Element::PropertiesType | PropertiesType |
typedef ConstitutiveLaw | ConstitutiveLawType |
Reference type definition for constitutive laws. More... | |
typedef ConstitutiveLawType::Pointer | ConstitutiveLawPointerType |
Pointer type for constitutive laws. More... | |
typedef ConstitutiveLaw | ConstitutiveLawType |
typedef ConstitutiveLawType::Pointer | ConstitutiveLawPointerType |
Pointer type for constitutive laws. More... | |
typedef GeometryData::IntegrationMethod | IntegrationMethod |
Type definition for integration methods. More... | |
typedef GeometryData::SizeType | SizeType |
Type for size. More... | |
typedef LargeDisplacementElement::ElementDataType | ElementDataType |
Type for element variables. More... | |
Public Types inherited from Kratos::Element | |
typedef Element | ElementType |
definition of element type More... | |
typedef GeometricalObject | BaseType |
base type: an GeometricalObject that automatically has a unique number More... | |
typedef Node | NodeType |
definition of node type (default is: Node) More... | |
typedef Properties | PropertiesType |
typedef Geometry< NodeType > | GeometryType |
definition of the geometry type with given NodeType More... | |
typedef Geometry< NodeType >::PointsArrayType | NodesArrayType |
definition of nodes container type, redefined from GeometryType More... | |
typedef Vector | VectorType |
typedef Matrix | MatrixType |
typedef std::size_t | IndexType |
typedef std::size_t | SizeType |
typedef Dof< double > | DofType |
typedef std::vector< std::size_t > | EquationIdVectorType |
typedef std::vector< DofType::Pointer > | DofsVectorType |
typedef PointerVectorSet< DofType > | DofsArrayType |
typedef GeometryData::IntegrationMethod | IntegrationMethod |
Type definition for integration methods. More... | |
typedef GeometryData | GeometryDataType |
Public Types inherited from Kratos::GeometricalObject | |
typedef Node | NodeType |
Definition of the node type. More... | |
typedef Geometry< NodeType > | GeometryType |
The geometry type definition. More... | |
typedef std::size_t | IndexType |
Defines the index type. More... | |
typedef std::size_t | result_type |
Defines the result type. More... | |
Public Types inherited from Kratos::IndexedObject | |
typedef std::size_t | IndexType |
The definition of the index type. More... | |
typedef std::size_t | result_type |
The definition of the result_type. More... | |
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 |
Public Types inherited from Kratos::LargeDisplacementElement | |
typedef ConstitutiveLaw | ConstitutiveLawType |
Reference type definition for constitutive laws. More... | |
typedef ConstitutiveLawType::Pointer | ConstitutiveLawPointerType |
Pointer type for constitutive laws. More... | |
typedef ConstitutiveLawType::StressMeasure | StressMeasureType |
StressMeasure from constitutive laws. More... | |
typedef GeometryData::IntegrationMethod | IntegrationMethod |
Type definition for integration methods. More... | |
typedef GeometryData::SizeType | SizeType |
Type for size. More... | |
typedef SolidElement::ElementDataType | ElementDataType |
Type for element variables. More... | |
Public Types inherited from Kratos::SolidElement | |
typedef ConstitutiveLaw | ConstitutiveLawType |
typedef ConstitutiveLawType::Pointer | ConstitutiveLawPointerType |
Pointer type for constitutive laws. More... | |
typedef ConstitutiveLawType::StressMeasure | StressMeasureType |
StressMeasure from constitutive laws. More... | |
typedef GeometryData::IntegrationMethod | IntegrationMethod |
Type definition for integration methods. More... | |
typedef GeometryData::SizeType | SizeType |
Type for size. More... | |
typedef ElementData | ElementDataType |
Type for element variables. More... | |
typedef ConstitutiveLaw | ConstitutiveLawType |
typedef ConstitutiveLawType::Pointer | ConstitutiveLawPointerType |
Pointer type for constitutive laws. More... | |
typedef ConstitutiveLawType::StressMeasure | StressMeasureType |
StressMeasure from constitutive laws. More... | |
typedef GeometryData::IntegrationMethod | IntegrationMethod |
Type definition for integration methods. More... | |
typedef GeometryData::SizeType | SizeType |
Type for size. More... | |
typedef ElementData | ElementDataType |
Type for element variables. More... | |
Static Public Member Functions inherited from Kratos::GeometricalObject | |
static bool | HasSameType (const GeometricalObject &rLHS, const GeometricalObject &rRHS) |
Checks if two GeometricalObject have the same type. More... | |
static bool | HasSameType (const GeometricalObject *rLHS, const GeometricalObject *rRHS) |
Checks if two GeometricalObject have the same type (pointer version) More... | |
static bool | HasSameGeometryType (const GeometricalObject &rLHS, const GeometricalObject &rRHS) |
Checks if two GeometricalObject have the same geometry type. More... | |
static bool | HasSameGeometryType (const GeometricalObject *rLHS, const GeometricalObject *rRHS) |
Checks if two GeometricalObject have the same geometry type (pointer version) More... | |
static bool | IsSame (const GeometricalObject &rLHS, const GeometricalObject &rRHS) |
Checks if two GeometricalObject are the same. More... | |
static bool | IsSame (const GeometricalObject *rLHS, const GeometricalObject *rRHS) |
Checks if two GeometricalObject are the same (pointer version) 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) |
Updated Lagrangian Large Displacement Lagrangian U-wP Element for 3D and 2D geometries. Linear Triangles and Tetrahedra (base class)
typedef ConstitutiveLawType::Pointer Kratos::UpdatedLagrangianUwPElement::ConstitutiveLawPointerType |
Pointer type for constitutive laws.
typedef UpdatedLagrangianElement::ElementDataType Kratos::UpdatedLagrangianUwPElement::ElementDataType |
Type for element variables.
Type definition for integration methods.
Type for size.
StressMeasure from constitutive laws.
Kratos::UpdatedLagrangianUwPElement::UpdatedLagrangianUwPElement | ( | ) |
Empty constructor needed for serialization.
Kratos::UpdatedLagrangianUwPElement::UpdatedLagrangianUwPElement | ( | IndexType | NewId, |
GeometryType::Pointer | pGeometry | ||
) |
Default constructors.
Kratos::UpdatedLagrangianUwPElement::UpdatedLagrangianUwPElement | ( | IndexType | NewId, |
GeometryType::Pointer | pGeometry, | ||
PropertiesType::Pointer | pProperties | ||
) |
Kratos::UpdatedLagrangianUwPElement::UpdatedLagrangianUwPElement | ( | UpdatedLagrangianUwPElement const & | rOther | ) |
Copy constructor.
|
virtual |
Destructor.
|
overrideprotectedvirtual |
Calculation and addition of the matrices of the LHS
Reimplemented from Kratos::SolidElement.
Reimplemented in Kratos::UpdatedLagrangianUwPStabElement.
|
overrideprotectedvirtual |
Calculation and addition of the vectors of the RHS
Reimplemented from Kratos::SolidElement.
Reimplemented in Kratos::UpdatedLagrangianUwPStabElement.
|
overrideprotectedvirtual |
Calculate a double Variable on the Element Constitutive Law
Reimplemented from Kratos::Element.
|
overrideprotectedvirtual |
Reimplemented from Kratos::Element.
|
overrideprotectedvirtual |
Reimplemented from Kratos::Element.
|
override |
This function provides the place to perform checks on the completeness of the input. It is designed to be called only once (or anyway, not often) typically at the beginning of the calculations, so to verify that nothing is missing from the input or that no common error is found.
rCurrentProcessInfo |
|
overridevirtual |
clones the selected element variables, creating a new one
NewId | the ID of the new element |
ThisNodes | the nodes of the new element |
pProperties | the properties assigned to the new element |
Reimplemented from Kratos::UpdatedLagrangianElement< TDim >.
Reimplemented in Kratos::UpdatedLagrangianUwPStabElement.
|
overridevirtual |
Returns the currently selected integration method
NewId | the ID of the new element |
ThisNodes | the nodes of the new element |
pProperties | the properties assigned to the new element |
Reimplemented from Kratos::UpdatedLagrangianElement< TDim >.
Reimplemented in Kratos::UpdatedLagrangianUwPStabElement.
|
override |
Sets on rResult the ID's of the element degrees of freedom
|
override |
Sets on rElementalDofList the degrees of freedom of the considered element geometry
|
overridevirtual |
Sets on rValues the nodal velocities
Reimplemented from Kratos::Element.
|
overridevirtual |
Sets on rValues the nodal accelerations
Reimplemented from Kratos::Element.
|
override |
Get on rVariable a double Value from the Element Constitutive Law
|
override |
|
override |
|
overridevirtual |
Sets on rValues the nodal displacements
Reimplemented from Kratos::Element.
|
overrideprotectedvirtual |
Initialize Element General Variables
Reimplemented from Kratos::SolidElement.
Reimplemented in Kratos::UpdatedLagrangianUwPStabElement.
|
overrideprotectedvirtual |
Initialize System Matrices
Reimplemented from Kratos::SolidElement.
Kratos::UpdatedLagrangianUwPElement::KRATOS_CLASS_INTRUSIVE_POINTER_DEFINITION | ( | UpdatedLagrangianUwPElement | ) |
Counted pointer of LargeDisplacementUPElement.
UpdatedLagrangianUwPElement & Kratos::UpdatedLagrangianUwPElement::operator= | ( | UpdatedLagrangianUwPElement const & | rOther | ) |
Assignment operator.
|
friend |
|
protected |