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.
|
Large Displacement Lagrangian Element for 3D and 2D geometries. (base class) More...
#include <solid_element.hpp>
Classes | |
struct | ElementData |
struct | LocalSystemComponents |
Public Member Functions | |
Life Cycle | |
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... | |
Operators | |
SolidElement & | operator= (SolidElement const &rOther) |
Assignment operator. More... | |
SolidElement & | operator= (SolidElement 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 |
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< double > &rVariable, const std::vector< double > &rValues, const ProcessInfo &rCurrentProcessInfo) 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 | Initialize (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< 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 |
int | Check (const ProcessInfo &rCurrentProcessInfo) const override |
Element::Pointer | Create (IndexType NewId, NodesArrayType const &ThisNodes, PropertiesType::Pointer pProperties) const override |
Element::Pointer | Clone (IndexType NewId, NodesArrayType const &ThisNodes) const 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< double > &rVariable, const std::vector< double > &rValues, const ProcessInfo &rCurrentProcessInfo) 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 | Initialize (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< 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 |
int | Check (const ProcessInfo &rCurrentProcessInfo) const override |
Input and output | |
Turn back information as a string. | |
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... | |
std::string | Info () const override |
Turn back information as a string. More... | |
void | PrintInfo (std::ostream &rOStream) const override |
Print information about this object. More... | |
void | PrintData (std::ostream &rOStream) const override |
Print object's data. More... | |
Public Member Functions inherited from Kratos::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... | |
Protected Member Functions | |
Protected Operations | |
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 | CalculateAndAddLHS (LocalSystemComponents &rLocalSystem, ElementDataType &rVariables, double &rIntegrationWeight) |
virtual void | CalculateAndAddRHS (LocalSystemComponents &rLocalSystem, ElementDataType &rVariables, Vector &rVolumeForce, double &rIntegrationWeight) |
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 | CalculateAndAddKuug (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 | SetElementData (ElementDataType &rVariables, ConstitutiveLaw::Parameters &rValues, const int &rPointNumber) |
virtual void | CalculateMaterialResponse (ElementDataType &rVariables, ConstitutiveLaw::Parameters &rValues, const int &rPointNumber) |
virtual SizeType | GetDofsSize () const |
bool | IsSliver () |
virtual void | InitializeSystemMatrices (MatrixType &rLeftHandSideMatrix, VectorType &rRightHandSideVector, Flags &rCalculationFlags) |
void | InitializeConstitutiveLaw () |
void | ResetConstitutiveLaw () override |
void | InitializeExplicitContributions () |
virtual void | CalculateKinematics (ElementDataType &rVariables, const double &rPointNumber) |
virtual void | CalculateKinetics (ElementDataType &rVariables, const double &rPointNumber) |
virtual void | InitializeElementData (ElementDataType &rVariables, const ProcessInfo &rCurrentProcessInfo) |
virtual void | TransformElementData (ElementDataType &rVariables, const double &rPointNumber) |
virtual void | FinalizeStepVariables (ElementDataType &rVariables, const double &rPointNumber) |
virtual double & | CalculateIntegrationWeight (double &rIntegrationWeight) |
virtual double & | CalculateTotalMass (double &rTotalMass, const ProcessInfo &rCurrentProcessInfo) |
virtual Matrix & | CalculateDeltaPosition (Matrix &rDeltaPosition) |
virtual Matrix & | CalculateTotalDeltaPosition (Matrix &rDeltaPosition) |
virtual double & | CalculateVolumeChange (double &rVolumeChange, ElementDataType &rVariables) |
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 | CalculateAndAddLHS (LocalSystemComponents &rLocalSystem, ElementDataType &rVariables, double &rIntegrationWeight) |
virtual void | CalculateAndAddRHS (LocalSystemComponents &rLocalSystem, ElementDataType &rVariables, Vector &rVolumeForce, double &rIntegrationWeight) |
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 | CalculateAndAddKuug (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 | SetElementData (ElementDataType &rVariables, ConstitutiveLaw::Parameters &rValues, const int &rPointNumber) |
virtual void | CalculateMaterialResponse (ElementDataType &rVariables, ConstitutiveLaw::Parameters &rValues, const int &rPointNumber) |
virtual SizeType | GetDofsSize () const |
bool | IsSliver () |
virtual void | InitializeSystemMatrices (MatrixType &rLeftHandSideMatrix, VectorType &rRightHandSideVector, Flags &rCalculationFlags) |
void | InitializeConstitutiveLaw () |
void | ResetConstitutiveLaw () override |
void | InitializeExplicitContributions () |
virtual void | CalculateKinematics (ElementDataType &rVariables, const double &rPointNumber) |
virtual void | CalculateKinetics (ElementDataType &rVariables, const double &rPointNumber) |
virtual void | InitializeElementData (ElementDataType &rVariables, const ProcessInfo &rCurrentProcessInfo) |
virtual void | TransformElementData (ElementDataType &rVariables, const double &rPointNumber) |
virtual void | FinalizeStepVariables (ElementDataType &rVariables, const double &rPointNumber) |
virtual double & | CalculateIntegrationWeight (double &rIntegrationWeight) |
virtual double & | CalculateTotalMass (double &rTotalMass, const ProcessInfo &rCurrentProcessInfo) |
virtual Matrix & | CalculateDeltaPosition (Matrix &rDeltaPosition) |
virtual Matrix & | CalculateTotalDeltaPosition (Matrix &rDeltaPosition) |
virtual double & | CalculateVolumeChange (double &rVolumeChange, ElementDataType &rVariables) |
virtual Vector & | CalculateVolumeForce (Vector &rVolumeForce, ElementDataType &rVariables) |
Protected Attributes | |
Protected member Variables | |
IntegrationMethod | mThisIntegrationMethod |
std::vector< ConstitutiveLaw::Pointer > | mConstitutiveLawVector |
Serialization | |
class | Serializer |
Additional Inherited Members | |
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 |
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) |
Large Displacement Lagrangian Element for 3D and 2D geometries. (base class)
Implements a Large Displacement Lagrangian definition for structural analysis. This works for arbitrary geometries in 3D and 2D (base class)
typedef ConstitutiveLawType::Pointer Kratos::SolidElement::ConstitutiveLawPointerType |
Pointer type for constitutive laws.
typedef ConstitutiveLawType::Pointer Kratos::SolidElement::ConstitutiveLawPointerType |
Pointer type for constitutive laws.
Type for element variables.
Type for element variables.
Type definition for integration methods.
Type definition for integration methods.
Type for size.
Type for size.
StressMeasure from constitutive laws.
StressMeasure from constitutive laws.
Kratos::SolidElement::SolidElement | ( | ) |
Empty constructor needed for serialization.
Kratos::SolidElement::SolidElement | ( | IndexType | NewId, |
GeometryType::Pointer | pGeometry | ||
) |
Default constructors.
Kratos::SolidElement::SolidElement | ( | IndexType | NewId, |
GeometryType::Pointer | pGeometry, | ||
PropertiesType::Pointer | pProperties | ||
) |
Kratos::SolidElement::SolidElement | ( | SolidElement const & | rOther | ) |
Copy constructor.
|
override |
Destructor.
Kratos::SolidElement::SolidElement | ( | ) |
Empty constructor needed for serialization.
Kratos::SolidElement::SolidElement | ( | IndexType | NewId, |
GeometryType::Pointer | pGeometry | ||
) |
Default constructors.
Kratos::SolidElement::SolidElement | ( | IndexType | NewId, |
GeometryType::Pointer | pGeometry, | ||
PropertiesType::Pointer | pProperties | ||
) |
Kratos::SolidElement::SolidElement | ( | SolidElement const & | rOther | ) |
Copy constructor.
|
override |
Destructor.
|
overridevirtual |
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.
rRHSVector | input variable containing the RHS vector to be assembled |
rRHSVariable | variable describing the type of the RHS vector to be assembled |
rDestinationVariable | variable in the database to which the rRHSvector will be assembled |
rCurrentProcessInfo | the current process info instance |
Reimplemented from Kratos::Element.
|
overridevirtual |
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.
rRHSVector | input variable containing the RHS vector to be assembled |
rRHSVariable | variable describing the type of the RHS vector to be assembled |
rDestinationVariable | variable in the database to which the rRHSvector will be assembled |
rCurrentProcessInfo | the current process info instance |
Reimplemented from Kratos::Element.
|
protectedvirtual |
Calculation and addition of the matrices of the LHS
Reimplemented in Kratos::LargeDisplacementUPElement.
|
protectedvirtual |
Calculation and addition of the matrices of the LHS
Reimplemented in Kratos::LargeDisplacementUPElement.
|
protectedvirtual |
Calculation and addition of the vectors of the RHS
Reimplemented in Kratos::LargeDisplacementUPElement.
|
protectedvirtual |
Calculation and addition of the vectors of the RHS
Reimplemented in Kratos::LargeDisplacementUPElement.
|
protectedvirtual |
Calculation of the External Forces Vector. Fe = N * t + N * b
Reimplemented in Kratos::UpdatedLagrangianUWwPElement, Kratos::UpdatedLagrangianUWElement, Kratos::SmallDisplacementUWwPElement, Kratos::LargeDisplacementUPElement, Kratos::UpdatedLagrangianUPwPElement, Kratos::UpdatedLagrangianUJElement, and Kratos::AxisymUpdatedLagrangianUPwPElement.
|
protectedvirtual |
Calculation of the External Forces Vector. Fe = N * t + N * b
Reimplemented in Kratos::UpdatedLagrangianUWwPElement, Kratos::UpdatedLagrangianUWElement, Kratos::SmallDisplacementUWwPElement, Kratos::LargeDisplacementUPElement, Kratos::UpdatedLagrangianUPwPElement, Kratos::UpdatedLagrangianUJElement, and Kratos::AxisymUpdatedLagrangianUPwPElement.
|
protectedvirtual |
Calculation of the Internal Forces Vector. Fi = B * sigma
Reimplemented in Kratos::LargeDisplacementUPElement, Kratos::UpdatedLagrangianUWwPElement, Kratos::UpdatedLagrangianUWElement, Kratos::UpdatedLagrangianUPwPElement, Kratos::UpdatedLagrangianUJElement, Kratos::SmallDisplacementUWwPElement, and Kratos::AxisymUpdatedLagrangianUPwPElement.
|
protectedvirtual |
Calculation of the Internal Forces Vector. Fi = B * sigma
Reimplemented in Kratos::LargeDisplacementUPElement, Kratos::UpdatedLagrangianUWwPElement, Kratos::UpdatedLagrangianUWElement, Kratos::UpdatedLagrangianUPwPElement, Kratos::UpdatedLagrangianUJElement, Kratos::SmallDisplacementUWwPElement, and Kratos::AxisymUpdatedLagrangianUPwPElement.
|
protectedvirtual |
Calculation of the Geometric Stiffness Matrix. Kuug = BT * S
Reimplemented in Kratos::SmallDisplacementElement, Kratos::LargeDisplacementElement, Kratos::SmallDisplacementElement, Kratos::LargeDisplacementUPElement, Kratos::AxisymmetricUpdatedLagrangianUPElement, Kratos::AxisymmetricUpdatedLagrangianElement, Kratos::UpdatedLagrangianUJElement, and Kratos::AxisymUpdatedLagrangianUJElement.
|
protectedvirtual |
Calculation of the Geometric Stiffness Matrix. Kuug = BT * S
Reimplemented in Kratos::SmallDisplacementElement, Kratos::LargeDisplacementElement, Kratos::SmallDisplacementElement, Kratos::LargeDisplacementUPElement, Kratos::AxisymmetricUpdatedLagrangianUPElement, Kratos::AxisymmetricUpdatedLagrangianElement, Kratos::UpdatedLagrangianUJElement, and Kratos::AxisymUpdatedLagrangianUJElement.
|
protectedvirtual |
Calculation of the Material Stiffness Matrix. Kuum = BT * C * B
Reimplemented in Kratos::LargeDisplacementUPElement, Kratos::UpdatedLagrangianUWwPElement, Kratos::UpdatedLagrangianUWElement, Kratos::UpdatedLagrangianUJElement, Kratos::SmallDisplacementUWwPElement, and Kratos::AxisymUpdatedLagrangianUJElement.
|
protectedvirtual |
Calculation of the Material Stiffness Matrix. Kuum = BT * C * B
Reimplemented in Kratos::LargeDisplacementUPElement, Kratos::UpdatedLagrangianUWwPElement, Kratos::UpdatedLagrangianUWElement, Kratos::UpdatedLagrangianUJElement, Kratos::SmallDisplacementUWwPElement, and Kratos::AxisymUpdatedLagrangianUJElement.
|
protectedvirtual |
Calculation and addition of the matrices of the LHS
Reimplemented in Kratos::UpdatedLagrangianUPElement, Kratos::LargeDisplacementVElement, Kratos::LargeDisplacementUPElement, Kratos::LargeDisplacementSegregatedVPElement, Kratos::AxisymmetricUpdatedLagrangianUPElement, Kratos::AxisymmetricUpdatedLagrangianElement, Kratos::AxisymmetricSmallDisplacementElement, Kratos::UpdatedLagrangianUwPStabElement, Kratos::UpdatedLagrangianUwPElement, Kratos::UpdatedLagrangianUWwPElement, Kratos::UpdatedLagrangianUWElement, Kratos::UpdatedLagrangianUPressureElement, Kratos::UpdatedLagrangianUPwPElement, Kratos::UpdatedLagrangianUJwPElement, Kratos::UpdatedLagrangianUJWwPElement, Kratos::UpdatedLagrangianUJPElement, Kratos::UpdatedLagrangianUJElement, Kratos::TotalUpdatedLagrangianUPElement, Kratos::SmallDisplacementUWwPElement, Kratos::AxisymUpdatedLagrangianUwPStabElement, Kratos::AxisymUpdatedLagrangianUwPElement, Kratos::AxisymUpdatedLagrangianUPressureElement, Kratos::AxisymUpdatedLagrangianUPwPElement, Kratos::AxisymUpdatedLagrangianUJwPElement, Kratos::AxisymUpdatedLagrangianUJWwPElement, and Kratos::AxisymUpdatedLagrangianUJElement.
|
protectedvirtual |
Calculation and addition of the matrices of the LHS
Reimplemented in Kratos::UpdatedLagrangianUPElement, Kratos::LargeDisplacementVElement, Kratos::LargeDisplacementUPElement, Kratos::LargeDisplacementSegregatedVPElement, Kratos::AxisymmetricUpdatedLagrangianUPElement, Kratos::AxisymmetricUpdatedLagrangianElement, Kratos::AxisymmetricSmallDisplacementElement, Kratos::UpdatedLagrangianUwPStabElement, Kratos::UpdatedLagrangianUwPElement, Kratos::UpdatedLagrangianUWwPElement, Kratos::UpdatedLagrangianUWElement, Kratos::UpdatedLagrangianUPressureElement, Kratos::UpdatedLagrangianUPwPElement, Kratos::UpdatedLagrangianUJwPElement, Kratos::UpdatedLagrangianUJWwPElement, Kratos::UpdatedLagrangianUJPElement, Kratos::UpdatedLagrangianUJElement, Kratos::TotalUpdatedLagrangianUPElement, Kratos::SmallDisplacementUWwPElement, Kratos::AxisymUpdatedLagrangianUwPStabElement, Kratos::AxisymUpdatedLagrangianUwPElement, Kratos::AxisymUpdatedLagrangianUPressureElement, Kratos::AxisymUpdatedLagrangianUPwPElement, Kratos::AxisymUpdatedLagrangianUJwPElement, Kratos::AxisymUpdatedLagrangianUJWwPElement, and Kratos::AxisymUpdatedLagrangianUJElement.
|
protectedvirtual |
Calculation and addition of the vectors of the RHS
Reimplemented in Kratos::UpdatedLagrangianUPElement, Kratos::LargeDisplacementUPElement, Kratos::LargeDisplacementSegregatedVPElement, Kratos::AxisymmetricUpdatedLagrangianUPElement, Kratos::AxisymmetricUpdatedLagrangianElement, Kratos::AxisymmetricSmallDisplacementElement, Kratos::UpdatedLagrangianUwPStabElement, Kratos::UpdatedLagrangianUwPElement, Kratos::UpdatedLagrangianUWwPElement, Kratos::UpdatedLagrangianUWElement, Kratos::UpdatedLagrangianUPressureElement, Kratos::UpdatedLagrangianUPwPElement, Kratos::UpdatedLagrangianUJwPElement, Kratos::UpdatedLagrangianUJWwPElement, Kratos::UpdatedLagrangianUJPElement, Kratos::UpdatedLagrangianUJElement, Kratos::TotalUpdatedLagrangianUPElement, Kratos::SmallDisplacementUWwPElement, Kratos::AxisymUpdatedLagrangianUwPStabElement, Kratos::AxisymUpdatedLagrangianUwPElement, Kratos::AxisymUpdatedLagrangianUPressureElement, Kratos::AxisymUpdatedLagrangianUPwPElement, Kratos::AxisymUpdatedLagrangianUJwPElement, Kratos::AxisymUpdatedLagrangianUJWwPElement, and Kratos::AxisymUpdatedLagrangianUJElement.
|
protectedvirtual |
Calculation and addition of the vectors of the RHS
Reimplemented in Kratos::UpdatedLagrangianUPElement, Kratos::LargeDisplacementUPElement, Kratos::LargeDisplacementSegregatedVPElement, Kratos::AxisymmetricUpdatedLagrangianUPElement, Kratos::AxisymmetricUpdatedLagrangianElement, Kratos::AxisymmetricSmallDisplacementElement, Kratos::UpdatedLagrangianUwPStabElement, Kratos::UpdatedLagrangianUwPElement, Kratos::UpdatedLagrangianUWwPElement, Kratos::UpdatedLagrangianUWElement, Kratos::UpdatedLagrangianUPressureElement, Kratos::UpdatedLagrangianUPwPElement, Kratos::UpdatedLagrangianUJwPElement, Kratos::UpdatedLagrangianUJWwPElement, Kratos::UpdatedLagrangianUJPElement, Kratos::UpdatedLagrangianUJElement, Kratos::TotalUpdatedLagrangianUPElement, Kratos::SmallDisplacementUWwPElement, Kratos::AxisymUpdatedLagrangianUwPStabElement, Kratos::AxisymUpdatedLagrangianUwPElement, Kratos::AxisymUpdatedLagrangianUPressureElement, Kratos::AxisymUpdatedLagrangianUPwPElement, Kratos::AxisymUpdatedLagrangianUJwPElement, Kratos::AxisymUpdatedLagrangianUJWwPElement, and Kratos::AxisymUpdatedLagrangianUJElement.
|
overridevirtual |
this is called during the assembling process in order to calculate the elemental damping matrix
rDampingMatrix | the elemental damping matrix |
rCurrentProcessInfo | the current process info instance |
Reimplemented from Kratos::Element.
Reimplemented in Kratos::LargeDisplacementUPElement, and Kratos::LargeDisplacementSegregatedVPElement.
|
overridevirtual |
this is called during the assembling process in order to calculate the elemental damping matrix
rDampingMatrix | the elemental damping matrix |
rCurrentProcessInfo | the current process info instance |
Reimplemented from Kratos::Element.
Calculation of the Position Increment
Reimplemented in Kratos::UpdatedLagrangianElement< TDim >, Kratos::UpdatedLagrangianElement< 2 >, and Kratos::UpdatedLagrangianElement< 3 >.
|
protectedvirtual |
Calculation of the Position Increment
Reimplemented in Kratos::UpdatedLagrangianElement< TDim >, Kratos::UpdatedLagrangianElement< 2 >, and Kratos::UpdatedLagrangianElement< 3 >.
|
protectedvirtual |
Calculates the elemental dynamic contributions
|
protectedvirtual |
Calculates the elemental dynamic contributions
|
protectedvirtual |
Calculates the elemental contributions
|
protectedvirtual |
Calculates the elemental contributions
|
overridevirtual |
this is called during the assembling process in order to calculate the first derivatives contributions for the LHS and RHS
rLeftHandSideMatrix | the elemental left hand side matrix |
rRightHandSideVector | the elemental right hand side |
rCurrentProcessInfo | the current process info instance |
Reimplemented from Kratos::Element.
|
overridevirtual |
this is called during the assembling process in order to calculate the first derivatives contributions for the LHS and RHS
rLeftHandSideMatrix | the elemental left hand side matrix |
rRightHandSideVector | the elemental right hand side |
rCurrentProcessInfo | the current process info instance |
Reimplemented from Kratos::Element.
|
protectedvirtual |
Calculation of the Integration Weight
|
protectedvirtual |
Calculation of the Integration Weight
|
protectedvirtual |
Calculate Element Kinematics
Reimplemented in Kratos::UpdatedLagrangianVElement, Kratos::UpdatedLagrangianUPElement, Kratos::UpdatedLagrangianSegregatedVPElement, Kratos::UpdatedLagrangianElement< TDim >, Kratos::UpdatedLagrangianElement< 2 >, Kratos::UpdatedLagrangianElement< 3 >, Kratos::TotalLagrangianElement, Kratos::SmallDisplacementElement, Kratos::SmallDisplacementBbarElement, Kratos::AxisymmetricUpdatedLagrangianUPElement, Kratos::AxisymmetricUpdatedLagrangianElement, Kratos::AxisymmetricSmallDisplacementElement, Kratos::UpdatedLagrangianUJElement, Kratos::TotalUpdatedLagrangianUPElement, Kratos::TotalUpdatedLagrangianElement, Kratos::AxisymUpdatedLagrangianUPressureElement, Kratos::AxisymUpdatedLagrangianUJElement, and Kratos::SmallDisplacementElement.
|
protectedvirtual |
Calculate Element Kinematics
Reimplemented in Kratos::UpdatedLagrangianVElement, Kratos::UpdatedLagrangianUPElement, Kratos::UpdatedLagrangianSegregatedVPElement, Kratos::UpdatedLagrangianElement< TDim >, Kratos::UpdatedLagrangianElement< 2 >, Kratos::UpdatedLagrangianElement< 3 >, Kratos::TotalLagrangianElement, Kratos::SmallDisplacementElement, Kratos::SmallDisplacementBbarElement, Kratos::AxisymmetricUpdatedLagrangianUPElement, Kratos::AxisymmetricUpdatedLagrangianElement, Kratos::AxisymmetricSmallDisplacementElement, Kratos::UpdatedLagrangianUJElement, Kratos::TotalUpdatedLagrangianUPElement, Kratos::TotalUpdatedLagrangianElement, Kratos::AxisymUpdatedLagrangianUPressureElement, Kratos::AxisymUpdatedLagrangianUJElement, and Kratos::SmallDisplacementElement.
|
protectedvirtual |
|
protectedvirtual |
|
overridevirtual |
this is called during the assembling process in order to calculate the elemental left hand side vector only
rLeftHandSideVector | the elemental left hand side vector |
rCurrentProcessInfo | the current process info instance |
Reimplemented from Kratos::Element.
Reimplemented in Kratos::LargeDisplacementSegregatedVPElement, Kratos::UpdatedLagrangianVImplicitSolidElement< TDim >, Kratos::UpdatedLagrangianVImplicitSolidElement< 2 >, Kratos::UpdatedLagrangianVImplicitSolidElement< 3 >, Kratos::UpdatedLagrangianElement< TDim >, Kratos::UpdatedLagrangianElement< 2 >, Kratos::UpdatedLagrangianElement< 3 >, Kratos::TwoStepUpdatedLagrangianVPImplicitSolidElement< TDim >, Kratos::TwoStepUpdatedLagrangianVPImplicitSolidElement< 2 >, Kratos::TwoStepUpdatedLagrangianVPImplicitSolidElement< 3 >, Kratos::TwoStepUpdatedLagrangianVPImplicitNodallyIntegratedSolidElement< TDim >, Kratos::TwoStepUpdatedLagrangianVPImplicitNodallyIntegratedSolidElement< 2 >, Kratos::TwoStepUpdatedLagrangianVPImplicitNodallyIntegratedSolidElement< 3 >, Kratos::TwoStepUpdatedLagrangianVPImplicitFluidPspgElement< TDim >, Kratos::TwoStepUpdatedLagrangianVPImplicitFluidPspgElement< 2 >, Kratos::TwoStepUpdatedLagrangianVPImplicitFluidPspgElement< 3 >, Kratos::TwoStepUpdatedLagrangianVPImplicitFluidFicElement< TDim >, Kratos::TwoStepUpdatedLagrangianVPImplicitFluidFicElement< 2 >, Kratos::TwoStepUpdatedLagrangianVPImplicitFluidFicElement< 3 >, Kratos::TwoStepUpdatedLagrangianVPImplicitFluidElement< TDim >, Kratos::TwoStepUpdatedLagrangianVPImplicitFluidDEMcouplingElement< TDim >, Kratos::TwoStepUpdatedLagrangianVPImplicitFluidDEMcouplingElement< 2 >, Kratos::TwoStepUpdatedLagrangianVPImplicitFluidDEMcouplingElement< 3 >, Kratos::TwoStepUpdatedLagrangianVPImplicitElement< TDim >, Kratos::TwoStepUpdatedLagrangianVPImplicitElement< 2 >, Kratos::TwoStepUpdatedLagrangianVPImplicitElement< 3 >, Kratos::TwoStepUpdatedLagrangianElement< TDim >, Kratos::TwoStepUpdatedLagrangianElement< 2 >, Kratos::TwoStepUpdatedLagrangianElement< 3 >, Kratos::ThreeStepUpdatedLagrangianElement< TDim >, Kratos::ThreeStepUpdatedLagrangianElement< 2 >, and Kratos::ThreeStepUpdatedLagrangianElement< 3 >.
|
overridevirtual |
this is called during the assembling process in order to calculate the elemental left hand side vector only
rLeftHandSideVector | the elemental left hand side vector |
rCurrentProcessInfo | the current process info instance |
Reimplemented from Kratos::Element.
Reimplemented in Kratos::UpdatedLagrangianVImplicitSolidElement< 2 >, Kratos::UpdatedLagrangianVImplicitSolidElement< 3 >, Kratos::UpdatedLagrangianElement< 2 >, Kratos::UpdatedLagrangianElement< 3 >, Kratos::TwoStepUpdatedLagrangianVPImplicitSolidElement< 2 >, Kratos::TwoStepUpdatedLagrangianVPImplicitSolidElement< 3 >, Kratos::TwoStepUpdatedLagrangianVPImplicitNodallyIntegratedSolidElement< 2 >, Kratos::TwoStepUpdatedLagrangianVPImplicitNodallyIntegratedSolidElement< 3 >, Kratos::TwoStepUpdatedLagrangianVPImplicitFluidPspgElement< 2 >, Kratos::TwoStepUpdatedLagrangianVPImplicitFluidPspgElement< 3 >, Kratos::TwoStepUpdatedLagrangianVPImplicitFluidFicElement< 2 >, Kratos::TwoStepUpdatedLagrangianVPImplicitFluidFicElement< 3 >, Kratos::TwoStepUpdatedLagrangianVPImplicitFluidDEMcouplingElement< 2 >, Kratos::TwoStepUpdatedLagrangianVPImplicitFluidDEMcouplingElement< 3 >, Kratos::TwoStepUpdatedLagrangianVPImplicitElement< 2 >, Kratos::TwoStepUpdatedLagrangianVPImplicitElement< 3 >, Kratos::TwoStepUpdatedLagrangianElement< 2 >, Kratos::TwoStepUpdatedLagrangianElement< 3 >, Kratos::ThreeStepUpdatedLagrangianElement< 2 >, and Kratos::ThreeStepUpdatedLagrangianElement< 3 >.
|
overridevirtual |
this is called during the assembling process in order to calculate all elemental contributions to the global system matrix and the right hand side
rLeftHandSideMatrix | the elemental left hand side matrix |
rRightHandSideVector | the elemental right hand side |
rCurrentProcessInfo | the current process info instance |
Reimplemented from Kratos::Element.
Reimplemented in Kratos::LargeDisplacementSegregatedVPElement, Kratos::UpdatedLagrangianElement< TDim >, Kratos::UpdatedLagrangianElement< 2 >, Kratos::UpdatedLagrangianElement< 3 >, Kratos::TwoStepUpdatedLagrangianVPImplicitElement< TDim >, Kratos::TwoStepUpdatedLagrangianVPImplicitElement< 2 >, Kratos::TwoStepUpdatedLagrangianVPImplicitElement< 3 >, Kratos::TwoStepUpdatedLagrangianElement< TDim >, Kratos::TwoStepUpdatedLagrangianElement< 2 >, Kratos::TwoStepUpdatedLagrangianElement< 3 >, Kratos::ThreeStepUpdatedLagrangianElement< TDim >, Kratos::ThreeStepUpdatedLagrangianElement< 2 >, Kratos::ThreeStepUpdatedLagrangianElement< 3 >, Kratos::ThreeStepSecondOrderUpdatedLagrangianElement< TDim >, Kratos::ThreeStepSecondOrderUpdatedLagrangianElement< 2 >, Kratos::ThreeStepSecondOrderUpdatedLagrangianElement< 3 >, Kratos::ThreeStepSecondOrderPspgUpdatedLagrangianElement< TDim >, Kratos::ThreeStepSecondOrderPspgUpdatedLagrangianElement< 2 >, Kratos::ThreeStepSecondOrderPspgUpdatedLagrangianElement< 3 >, Kratos::ThreeStepFirstOrderUpdatedLagrangianElement< TDim >, Kratos::ThreeStepFirstOrderUpdatedLagrangianElement< 2 >, and Kratos::ThreeStepFirstOrderUpdatedLagrangianElement< 3 >.
|
overridevirtual |
this is called during the assembling process in order to calculate all elemental contributions to the global system matrix and the right hand side
rLeftHandSideMatrix | the elemental left hand side matrix |
rRightHandSideVector | the elemental right hand side |
rCurrentProcessInfo | the current process info instance |
Reimplemented from Kratos::Element.
Reimplemented in Kratos::UpdatedLagrangianElement< 2 >, Kratos::UpdatedLagrangianElement< 3 >, Kratos::TwoStepUpdatedLagrangianVPImplicitElement< 2 >, Kratos::TwoStepUpdatedLagrangianVPImplicitElement< 3 >, Kratos::TwoStepUpdatedLagrangianElement< 2 >, Kratos::TwoStepUpdatedLagrangianElement< 3 >, Kratos::ThreeStepUpdatedLagrangianElement< 2 >, Kratos::ThreeStepUpdatedLagrangianElement< 3 >, Kratos::ThreeStepSecondOrderUpdatedLagrangianElement< 2 >, Kratos::ThreeStepSecondOrderUpdatedLagrangianElement< 3 >, Kratos::ThreeStepSecondOrderPspgUpdatedLagrangianElement< 2 >, Kratos::ThreeStepSecondOrderPspgUpdatedLagrangianElement< 3 >, Kratos::ThreeStepFirstOrderUpdatedLagrangianElement< 2 >, and Kratos::ThreeStepFirstOrderUpdatedLagrangianElement< 3 >.
|
overridevirtual |
this is called during the assembling process in order to calculate the elemental mass matrix
rMassMatrix | the elemental mass matrix |
rCurrentProcessInfo | the current process info instance |
Reimplemented from Kratos::Element.
Reimplemented in Kratos::LargeDisplacementUPElement, Kratos::LargeDisplacementSegregatedVPElement, Kratos::AxisymmetricUpdatedLagrangianUPElement, Kratos::UpdatedLagrangianElement< TDim >, Kratos::UpdatedLagrangianElement< 2 >, Kratos::UpdatedLagrangianElement< 3 >, Kratos::TwoStepUpdatedLagrangianElement< TDim >, Kratos::TwoStepUpdatedLagrangianElement< 2 >, Kratos::TwoStepUpdatedLagrangianElement< 3 >, Kratos::ThreeStepUpdatedLagrangianElement< TDim >, Kratos::ThreeStepUpdatedLagrangianElement< 2 >, and Kratos::ThreeStepUpdatedLagrangianElement< 3 >.
|
overridevirtual |
this is called during the assembling process in order to calculate the elemental mass matrix
rMassMatrix | the elemental mass matrix |
rCurrentProcessInfo | the current process info instance |
Reimplemented from Kratos::Element.
Reimplemented in Kratos::UpdatedLagrangianElement< 2 >, Kratos::UpdatedLagrangianElement< 3 >, Kratos::TwoStepUpdatedLagrangianElement< 2 >, Kratos::TwoStepUpdatedLagrangianElement< 3 >, Kratos::ThreeStepUpdatedLagrangianElement< 2 >, and Kratos::ThreeStepUpdatedLagrangianElement< 3 >.
|
protectedvirtual |
Set Parameters for the Constitutive Law and Calculate Material Response
Reimplemented in Kratos::UpdatedLagrangianSegregatedVPElement.
|
protectedvirtual |
Set Parameters for the Constitutive Law and Calculate Material Response
Reimplemented in Kratos::UpdatedLagrangianSegregatedVPElement.
|
overridevirtual |
Get a Constitutive Law Value
Reimplemented from Kratos::Element.
|
overridevirtual |
Calculate a double Variable on the Element Constitutive Law
Reimplemented from Kratos::Element.
Reimplemented in Kratos::UpdatedLagrangianVElement, Kratos::UpdatedLagrangianUPElement, Kratos::UpdatedLagrangianSegregatedVPElement, Kratos::UpdatedLagrangianElement< TDim >, Kratos::UpdatedLagrangianElement< 2 >, Kratos::UpdatedLagrangianElement< 3 >, Kratos::AxisymmetricUpdatedLagrangianUPElement, Kratos::AxisymmetricUpdatedLagrangianElement, Kratos::SmallDisplacementElement, Kratos::LargeDisplacementElement, Kratos::UpdatedLagrangianUwPElement, Kratos::UpdatedLagrangianUWElement, Kratos::UpdatedLagrangianUJPElement, Kratos::UpdatedLagrangianUJElement, Kratos::AxisymUpdatedLagrangianUwPElement, Kratos::TwoStepUpdatedLagrangianVPImplicitElement< TDim >, Kratos::TwoStepUpdatedLagrangianVPImplicitElement< 2 >, and Kratos::TwoStepUpdatedLagrangianVPImplicitElement< 3 >.
|
overridevirtual |
Calculate a double Variable on the Element Constitutive Law
Reimplemented from Kratos::Element.
Reimplemented in Kratos::UpdatedLagrangianVElement, Kratos::UpdatedLagrangianUPElement, Kratos::UpdatedLagrangianSegregatedVPElement, Kratos::UpdatedLagrangianElement< TDim >, Kratos::UpdatedLagrangianElement< 2 >, Kratos::UpdatedLagrangianElement< 3 >, Kratos::TwoStepUpdatedLagrangianVPImplicitElement< 2 >, and Kratos::TwoStepUpdatedLagrangianVPImplicitElement< 3 >.
|
overridevirtual |
Calculate a Matrix Variable on the Element Constitutive Law
Reimplemented from Kratos::Element.
Reimplemented in Kratos::SmallDisplacementElement, Kratos::LargeDisplacementElement, Kratos::UpdatedLagrangianUwPElement, Kratos::UpdatedLagrangianUWElement, Kratos::UpdatedLagrangianUPressureElement, Kratos::UpdatedLagrangianUJPElement, Kratos::UpdatedLagrangianUJElement, and Kratos::AxisymUpdatedLagrangianUwPElement.
|
overridevirtual |
Calculate a Matrix Variable on the Element Constitutive Law
Reimplemented from Kratos::Element.
|
overridevirtual |
Calculate a Vector Variable on the Element Constitutive Law
Reimplemented from Kratos::Element.
Reimplemented in Kratos::UpdatedLagrangianUJwPElement, Kratos::AxisymUpdatedLagrangianUJwPElement, Kratos::SmallDisplacementElement, Kratos::LargeDisplacementElement, Kratos::UpdatedLagrangianUwPElement, Kratos::UpdatedLagrangianUWElement, Kratos::UpdatedLagrangianUJPElement, Kratos::UpdatedLagrangianUJElement, Kratos::AxisymUpdatedLagrangianUwPElement, Kratos::TwoStepUpdatedLagrangianVPImplicitElement< TDim >, Kratos::TwoStepUpdatedLagrangianVPImplicitElement< 2 >, and Kratos::TwoStepUpdatedLagrangianVPImplicitElement< 3 >.
|
overridevirtual |
Calculate a Vector Variable on the Element Constitutive Law
Reimplemented from Kratos::Element.
Reimplemented in Kratos::TwoStepUpdatedLagrangianVPImplicitElement< 2 >, and Kratos::TwoStepUpdatedLagrangianVPImplicitElement< 3 >.
|
protected |
Calculation of the tangent via perturbation of the dofs variables : testing purposes
|
protected |
Calculation of the tangent via perturbation of the dofs variables : testing purposes
|
overridevirtual |
this is called during the assembling process in order to calculate the elemental right hand side vector only
rRightHandSideVector | the elemental right hand side vector |
rCurrentProcessInfo | the current process info instance |
Reimplemented from Kratos::Element.
Reimplemented in Kratos::LargeDisplacementSegregatedVPElement, Kratos::UpdatedLagrangianVImplicitSolidElement< TDim >, Kratos::UpdatedLagrangianVImplicitSolidElement< 2 >, Kratos::UpdatedLagrangianVImplicitSolidElement< 3 >, Kratos::UpdatedLagrangianElement< TDim >, Kratos::UpdatedLagrangianElement< 2 >, Kratos::UpdatedLagrangianElement< 3 >, Kratos::TwoStepUpdatedLagrangianVPImplicitSolidElement< TDim >, Kratos::TwoStepUpdatedLagrangianVPImplicitSolidElement< 2 >, Kratos::TwoStepUpdatedLagrangianVPImplicitSolidElement< 3 >, Kratos::TwoStepUpdatedLagrangianVPImplicitNodallyIntegratedSolidElement< TDim >, Kratos::TwoStepUpdatedLagrangianVPImplicitNodallyIntegratedSolidElement< 2 >, Kratos::TwoStepUpdatedLagrangianVPImplicitNodallyIntegratedSolidElement< 3 >, Kratos::TwoStepUpdatedLagrangianVPImplicitFluidPspgElement< TDim >, Kratos::TwoStepUpdatedLagrangianVPImplicitFluidPspgElement< 2 >, Kratos::TwoStepUpdatedLagrangianVPImplicitFluidPspgElement< 3 >, Kratos::TwoStepUpdatedLagrangianVPImplicitFluidFicElement< TDim >, Kratos::TwoStepUpdatedLagrangianVPImplicitFluidFicElement< 2 >, Kratos::TwoStepUpdatedLagrangianVPImplicitFluidFicElement< 3 >, Kratos::TwoStepUpdatedLagrangianVPImplicitFluidElement< TDim >, Kratos::TwoStepUpdatedLagrangianVPImplicitFluidDEMcouplingElement< TDim >, Kratos::TwoStepUpdatedLagrangianVPImplicitFluidDEMcouplingElement< 2 >, Kratos::TwoStepUpdatedLagrangianVPImplicitFluidDEMcouplingElement< 3 >, Kratos::TwoStepUpdatedLagrangianVPImplicitElement< TDim >, Kratos::TwoStepUpdatedLagrangianVPImplicitElement< 2 >, Kratos::TwoStepUpdatedLagrangianVPImplicitElement< 3 >, Kratos::TwoStepUpdatedLagrangianElement< TDim >, Kratos::TwoStepUpdatedLagrangianElement< 2 >, Kratos::TwoStepUpdatedLagrangianElement< 3 >, Kratos::ThreeStepUpdatedLagrangianElement< TDim >, Kratos::ThreeStepUpdatedLagrangianElement< 2 >, and Kratos::ThreeStepUpdatedLagrangianElement< 3 >.
|
overridevirtual |
this is called during the assembling process in order to calculate the elemental right hand side vector only
rRightHandSideVector | the elemental right hand side vector |
rCurrentProcessInfo | the current process info instance |
Reimplemented from Kratos::Element.
Reimplemented in Kratos::UpdatedLagrangianVImplicitSolidElement< 2 >, Kratos::UpdatedLagrangianVImplicitSolidElement< 3 >, Kratos::UpdatedLagrangianElement< 2 >, Kratos::UpdatedLagrangianElement< 3 >, Kratos::TwoStepUpdatedLagrangianVPImplicitSolidElement< 2 >, Kratos::TwoStepUpdatedLagrangianVPImplicitSolidElement< 3 >, Kratos::TwoStepUpdatedLagrangianVPImplicitNodallyIntegratedSolidElement< 2 >, Kratos::TwoStepUpdatedLagrangianVPImplicitNodallyIntegratedSolidElement< 3 >, Kratos::TwoStepUpdatedLagrangianVPImplicitFluidPspgElement< 2 >, Kratos::TwoStepUpdatedLagrangianVPImplicitFluidPspgElement< 3 >, Kratos::TwoStepUpdatedLagrangianVPImplicitFluidFicElement< 2 >, Kratos::TwoStepUpdatedLagrangianVPImplicitFluidFicElement< 3 >, Kratos::TwoStepUpdatedLagrangianVPImplicitFluidDEMcouplingElement< 2 >, Kratos::TwoStepUpdatedLagrangianVPImplicitFluidDEMcouplingElement< 3 >, Kratos::TwoStepUpdatedLagrangianVPImplicitElement< 2 >, Kratos::TwoStepUpdatedLagrangianVPImplicitElement< 3 >, Kratos::TwoStepUpdatedLagrangianElement< 2 >, Kratos::TwoStepUpdatedLagrangianElement< 3 >, Kratos::ThreeStepUpdatedLagrangianElement< 2 >, and Kratos::ThreeStepUpdatedLagrangianElement< 3 >.
|
overridevirtual |
this is called during the assembling process in order to calculate the second derivatives contributions for the LHS and RHS
rLeftHandSideMatrix | the elemental left hand side matrix |
rRightHandSideVector | the elemental right hand side |
rCurrentProcessInfo | the current process info instance |
Reimplemented from Kratos::Element.
|
overridevirtual |
this is called during the assembling process in order to calculate the second derivatives contributions for the LHS and RHS
rLeftHandSideMatrix | the elemental left hand side matrix |
rRightHandSideVector | the elemental right hand side |
rCurrentProcessInfo | the current process info instance |
Reimplemented from Kratos::Element.
|
overridevirtual |
this is called during the assembling process in order to calculate the elemental left hand side matrix for the second derivatives constributions
rLeftHandSideMatrix | the elemental left hand side matrix |
rCurrentProcessInfo | the current process info instance |
Reimplemented from Kratos::Element.
|
overridevirtual |
this is called during the assembling process in order to calculate the elemental left hand side matrix for the second derivatives constributions
rLeftHandSideMatrix | the elemental left hand side matrix |
rCurrentProcessInfo | the current process info instance |
Reimplemented from Kratos::Element.
|
overridevirtual |
this is called during the assembling process in order to calculate the elemental right hand side vector for the second derivatives constributions
rRightHandSideVector | the elemental right hand side vector |
rCurrentProcessInfo | the current process info instance |
Reimplemented from Kratos::Element.
|
overridevirtual |
this is called during the assembling process in order to calculate the elemental right hand side vector for the second derivatives constributions
rRightHandSideVector | the elemental right hand side vector |
rCurrentProcessInfo | the current process info instance |
Reimplemented from Kratos::Element.
|
protectedvirtual |
Calculation of the Total Position Increment
|
protectedvirtual |
Calculation of the Total Position Increment
|
protectedvirtual |
Calculation of the Total Mass of the Element
Reimplemented in Kratos::TotalLagrangianElement, Kratos::AxisymmetricUpdatedLagrangianUPElement, Kratos::AxisymmetricUpdatedLagrangianElement, and Kratos::AxisymmetricSmallDisplacementElement.
|
protectedvirtual |
Calculation of the Total Mass of the Element
Reimplemented in Kratos::TotalLagrangianElement, Kratos::AxisymmetricUpdatedLagrangianUPElement, Kratos::AxisymmetricUpdatedLagrangianElement, and Kratos::AxisymmetricSmallDisplacementElement.
|
protectedvirtual |
Calculation of the Volume Change of the Element
Reimplemented in Kratos::UpdatedLagrangianVElement, Kratos::UpdatedLagrangianUPElement, Kratos::UpdatedLagrangianSegregatedVPElement, Kratos::UpdatedLagrangianElement< TDim >, Kratos::UpdatedLagrangianElement< 2 >, Kratos::UpdatedLagrangianElement< 3 >, Kratos::TotalLagrangianElement, Kratos::AxisymmetricUpdatedLagrangianUPElement, Kratos::AxisymmetricUpdatedLagrangianElement, Kratos::UpdatedLagrangianUPwPElement, Kratos::UpdatedLagrangianUJElement, Kratos::TotalUpdatedLagrangianUPElement, Kratos::TotalUpdatedLagrangianElement, and Kratos::AxisymUpdatedLagrangianUPwPElement.
|
protectedvirtual |
Calculation of the Volume Change of the Element
Reimplemented in Kratos::UpdatedLagrangianVElement, Kratos::UpdatedLagrangianUPElement, Kratos::UpdatedLagrangianSegregatedVPElement, Kratos::UpdatedLagrangianElement< TDim >, Kratos::UpdatedLagrangianElement< 2 >, Kratos::UpdatedLagrangianElement< 3 >, Kratos::TotalLagrangianElement, Kratos::AxisymmetricUpdatedLagrangianUPElement, Kratos::AxisymmetricUpdatedLagrangianElement, Kratos::UpdatedLagrangianUPwPElement, Kratos::UpdatedLagrangianUJElement, Kratos::TotalUpdatedLagrangianUPElement, Kratos::TotalUpdatedLagrangianElement, and Kratos::AxisymUpdatedLagrangianUPwPElement.
|
protectedvirtual |
Calculation of the Volume Force of the Element
|
protectedvirtual |
Calculation of the Volume Force of the Element
|
overridevirtual |
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 |
Reimplemented from Kratos::Element.
Reimplemented in Kratos::UpdatedLagrangianVElement, Kratos::UpdatedLagrangianSegregatedVPElement, Kratos::UpdatedLagrangianElement< TDim >, Kratos::UpdatedLagrangianElement< 2 >, Kratos::UpdatedLagrangianElement< 3 >, Kratos::TotalLagrangianElement, Kratos::SmallDisplacementElement, Kratos::LargeDisplacementVElement, Kratos::LargeDisplacementUPElement, Kratos::LargeDisplacementSegregatedVPElement, Kratos::LargeDisplacementElement, Kratos::AxisymmetricUpdatedLagrangianUPElement, Kratos::AxisymmetricUpdatedLagrangianElement, Kratos::AxisymmetricSmallDisplacementElement, Kratos::UpdatedLagrangianElement< TDim >, Kratos::UpdatedLagrangianElement< 2 >, Kratos::UpdatedLagrangianElement< 3 >, Kratos::TwoStepUpdatedLagrangianVPImplicitSolidElement< TDim >, Kratos::TwoStepUpdatedLagrangianVPImplicitSolidElement< 2 >, Kratos::TwoStepUpdatedLagrangianVPImplicitSolidElement< 3 >, Kratos::TwoStepUpdatedLagrangianVPImplicitNodallyIntegratedSolidElement< TDim >, Kratos::TwoStepUpdatedLagrangianVPImplicitNodallyIntegratedSolidElement< 2 >, Kratos::TwoStepUpdatedLagrangianVPImplicitNodallyIntegratedSolidElement< 3 >, Kratos::TwoStepUpdatedLagrangianVPImplicitNodallyIntegratedFluidElement< TDim >, Kratos::TwoStepUpdatedLagrangianVPImplicitNodallyIntegratedFluidElement< 2 >, Kratos::TwoStepUpdatedLagrangianVPImplicitNodallyIntegratedFluidElement< 3 >, Kratos::TwoStepUpdatedLagrangianVPImplicitNodallyIntegratedElement< TDim >, Kratos::TwoStepUpdatedLagrangianVPImplicitNodallyIntegratedElement< 2 >, Kratos::TwoStepUpdatedLagrangianVPImplicitNodallyIntegratedElement< 3 >, Kratos::TwoStepUpdatedLagrangianVPImplicitFluidPspgElement< TDim >, Kratos::TwoStepUpdatedLagrangianVPImplicitFluidPspgElement< 2 >, Kratos::TwoStepUpdatedLagrangianVPImplicitFluidPspgElement< 3 >, Kratos::TwoStepUpdatedLagrangianVPImplicitFluidFicElement< TDim >, Kratos::TwoStepUpdatedLagrangianVPImplicitFluidFicElement< 2 >, Kratos::TwoStepUpdatedLagrangianVPImplicitFluidFicElement< 3 >, Kratos::TwoStepUpdatedLagrangianVPImplicitFluidElement< TDim >, Kratos::TwoStepUpdatedLagrangianVPImplicitFluidDEMcouplingElement< TDim >, Kratos::TwoStepUpdatedLagrangianVPImplicitFluidDEMcouplingElement< 2 >, Kratos::TwoStepUpdatedLagrangianVPImplicitFluidDEMcouplingElement< 3 >, Kratos::TwoStepUpdatedLagrangianVPImplicitElement< TDim >, Kratos::TwoStepUpdatedLagrangianVPImplicitElement< 2 >, Kratos::TwoStepUpdatedLagrangianVPImplicitElement< 3 >, Kratos::TwoStepUpdatedLagrangianElement< TDim >, Kratos::TwoStepUpdatedLagrangianElement< 2 >, Kratos::TwoStepUpdatedLagrangianElement< 3 >, Kratos::ThreeStepUpdatedLagrangianElement< TDim >, Kratos::ThreeStepUpdatedLagrangianElement< 2 >, and Kratos::ThreeStepUpdatedLagrangianElement< 3 >.
|
overridevirtual |
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 |
Reimplemented from Kratos::Element.
Reimplemented in Kratos::UpdatedLagrangianVElement, Kratos::UpdatedLagrangianSegregatedVPElement, Kratos::UpdatedLagrangianElement< TDim >, Kratos::UpdatedLagrangianElement< 2 >, Kratos::UpdatedLagrangianElement< 3 >, Kratos::TotalLagrangianElement, Kratos::UpdatedLagrangianElement< 2 >, Kratos::UpdatedLagrangianElement< 3 >, Kratos::TwoStepUpdatedLagrangianVPImplicitSolidElement< 2 >, Kratos::TwoStepUpdatedLagrangianVPImplicitSolidElement< 3 >, Kratos::TwoStepUpdatedLagrangianVPImplicitNodallyIntegratedSolidElement< 2 >, Kratos::TwoStepUpdatedLagrangianVPImplicitNodallyIntegratedSolidElement< 3 >, Kratos::TwoStepUpdatedLagrangianVPImplicitNodallyIntegratedFluidElement< 2 >, Kratos::TwoStepUpdatedLagrangianVPImplicitNodallyIntegratedFluidElement< 3 >, Kratos::TwoStepUpdatedLagrangianVPImplicitNodallyIntegratedElement< 2 >, Kratos::TwoStepUpdatedLagrangianVPImplicitNodallyIntegratedElement< 3 >, Kratos::TwoStepUpdatedLagrangianVPImplicitFluidPspgElement< 2 >, Kratos::TwoStepUpdatedLagrangianVPImplicitFluidPspgElement< 3 >, Kratos::TwoStepUpdatedLagrangianVPImplicitFluidFicElement< 2 >, Kratos::TwoStepUpdatedLagrangianVPImplicitFluidFicElement< 3 >, Kratos::TwoStepUpdatedLagrangianVPImplicitFluidDEMcouplingElement< 2 >, Kratos::TwoStepUpdatedLagrangianVPImplicitFluidDEMcouplingElement< 3 >, Kratos::TwoStepUpdatedLagrangianVPImplicitElement< 2 >, Kratos::TwoStepUpdatedLagrangianVPImplicitElement< 3 >, Kratos::TwoStepUpdatedLagrangianElement< 2 >, Kratos::TwoStepUpdatedLagrangianElement< 3 >, Kratos::ThreeStepUpdatedLagrangianElement< 2 >, and Kratos::ThreeStepUpdatedLagrangianElement< 3 >.
|
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::Element.
Reimplemented in Kratos::UpdatedLagrangianVElement, Kratos::UpdatedLagrangianUPElement, Kratos::UpdatedLagrangianSegregatedVPElement, Kratos::UpdatedLagrangianElement< TDim >, Kratos::UpdatedLagrangianElement< 2 >, Kratos::UpdatedLagrangianElement< 3 >, Kratos::TotalLagrangianElement, Kratos::SmallDisplacementElement, Kratos::SmallDisplacementBbarElement, Kratos::LargeDisplacementVElement, Kratos::LargeDisplacementUPElement, Kratos::LargeDisplacementSegregatedVPElement, Kratos::LargeDisplacementElement, Kratos::AxisymmetricUpdatedLagrangianUPElement, Kratos::AxisymmetricUpdatedLagrangianElement, Kratos::AxisymmetricSmallDisplacementElement, Kratos::UpdatedLagrangianUwPStabElement, Kratos::UpdatedLagrangianUwPElement, Kratos::UpdatedLagrangianUWwPElement, Kratos::UpdatedLagrangianUWwPDMEElement, Kratos::UpdatedLagrangianUWElement, Kratos::UpdatedLagrangianUPressureElement, Kratos::UpdatedLagrangianUPwPElement, Kratos::UpdatedLagrangianUJwPElement, Kratos::UpdatedLagrangianUJWwPHOElement, Kratos::UpdatedLagrangianUJWwPElement, Kratos::UpdatedLagrangianUJWwPDMEElement, Kratos::UpdatedLagrangianUJPElement, Kratos::UpdatedLagrangianUJElement, Kratos::TotalUpdatedLagrangianUPElement, Kratos::TotalUpdatedLagrangianElement, Kratos::SmallDisplacementUWwPElement, Kratos::AxisymUpdatedLagrangianUwPStabElement, Kratos::AxisymUpdatedLagrangianUwPElement, Kratos::AxisymUpdatedLagrangianUPressureElement, Kratos::AxisymUpdatedLagrangianUPwPElement, Kratos::AxisymUpdatedLagrangianUJwPElement, Kratos::AxisymUpdatedLagrangianUJWwPElement, Kratos::AxisymUpdatedLagrangianUJWwPDMEElement, Kratos::AxisymUpdatedLagrangianUJElement, Kratos::UpdatedLagrangianVImplicitSolidElement< TDim >, Kratos::UpdatedLagrangianVImplicitSolidElement< 2 >, Kratos::UpdatedLagrangianVImplicitSolidElement< 3 >, Kratos::UpdatedLagrangianElement< TDim >, Kratos::UpdatedLagrangianElement< 2 >, Kratos::UpdatedLagrangianElement< 3 >, Kratos::TwoStepUpdatedLagrangianVPImplicitSolidElement< TDim >, Kratos::TwoStepUpdatedLagrangianVPImplicitSolidElement< 2 >, Kratos::TwoStepUpdatedLagrangianVPImplicitSolidElement< 3 >, Kratos::TwoStepUpdatedLagrangianVPImplicitNodallyIntegratedSolidElement< TDim >, Kratos::TwoStepUpdatedLagrangianVPImplicitNodallyIntegratedSolidElement< 2 >, Kratos::TwoStepUpdatedLagrangianVPImplicitNodallyIntegratedSolidElement< 3 >, Kratos::TwoStepUpdatedLagrangianVPImplicitNodallyIntegratedFluidElement< TDim >, Kratos::TwoStepUpdatedLagrangianVPImplicitNodallyIntegratedFluidElement< 2 >, Kratos::TwoStepUpdatedLagrangianVPImplicitNodallyIntegratedFluidElement< 3 >, Kratos::TwoStepUpdatedLagrangianVPImplicitNodallyIntegratedElement< TDim >, Kratos::TwoStepUpdatedLagrangianVPImplicitNodallyIntegratedElement< 2 >, Kratos::TwoStepUpdatedLagrangianVPImplicitNodallyIntegratedElement< 3 >, Kratos::TwoStepUpdatedLagrangianVPImplicitFluidPspgElement< TDim >, Kratos::TwoStepUpdatedLagrangianVPImplicitFluidPspgElement< 2 >, Kratos::TwoStepUpdatedLagrangianVPImplicitFluidPspgElement< 3 >, Kratos::TwoStepUpdatedLagrangianVPImplicitFluidFicElement< TDim >, Kratos::TwoStepUpdatedLagrangianVPImplicitFluidFicElement< 2 >, Kratos::TwoStepUpdatedLagrangianVPImplicitFluidFicElement< 3 >, Kratos::TwoStepUpdatedLagrangianVPImplicitFluidElement< TDim >, Kratos::TwoStepUpdatedLagrangianVPImplicitFluidDEMcouplingElement< TDim >, Kratos::TwoStepUpdatedLagrangianVPImplicitFluidDEMcouplingElement< 2 >, Kratos::TwoStepUpdatedLagrangianVPImplicitFluidDEMcouplingElement< 3 >, Kratos::TwoStepUpdatedLagrangianVPImplicitElement< TDim >, Kratos::TwoStepUpdatedLagrangianVPImplicitElement< 2 >, Kratos::TwoStepUpdatedLagrangianVPImplicitElement< 3 >, Kratos::TwoStepUpdatedLagrangianElement< TDim >, Kratos::TwoStepUpdatedLagrangianElement< 2 >, Kratos::TwoStepUpdatedLagrangianElement< 3 >, Kratos::ThreeStepUpdatedLagrangianElement< TDim >, Kratos::ThreeStepUpdatedLagrangianElement< 2 >, Kratos::ThreeStepUpdatedLagrangianElement< 3 >, Kratos::ThreeStepSecondOrderUpdatedLagrangianElement< TDim >, Kratos::ThreeStepSecondOrderUpdatedLagrangianElement< 2 >, Kratos::ThreeStepSecondOrderUpdatedLagrangianElement< 3 >, Kratos::ThreeStepSecondOrderPspgUpdatedLagrangianElement< TDim >, Kratos::ThreeStepSecondOrderPspgUpdatedLagrangianElement< 2 >, Kratos::ThreeStepSecondOrderPspgUpdatedLagrangianElement< 3 >, Kratos::ThreeStepFirstOrderUpdatedLagrangianElement< TDim >, Kratos::ThreeStepFirstOrderUpdatedLagrangianElement< 2 >, and Kratos::ThreeStepFirstOrderUpdatedLagrangianElement< 3 >.
|
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::Element.
Reimplemented in Kratos::UpdatedLagrangianVElement, Kratos::UpdatedLagrangianUPElement, Kratos::UpdatedLagrangianSegregatedVPElement, Kratos::UpdatedLagrangianElement< TDim >, Kratos::UpdatedLagrangianElement< 2 >, Kratos::UpdatedLagrangianElement< 3 >, Kratos::TotalLagrangianElement, Kratos::UpdatedLagrangianVImplicitSolidElement< 2 >, Kratos::UpdatedLagrangianVImplicitSolidElement< 3 >, Kratos::UpdatedLagrangianElement< 2 >, Kratos::UpdatedLagrangianElement< 3 >, Kratos::TwoStepUpdatedLagrangianVPImplicitSolidElement< 2 >, Kratos::TwoStepUpdatedLagrangianVPImplicitSolidElement< 3 >, Kratos::TwoStepUpdatedLagrangianVPImplicitNodallyIntegratedSolidElement< 2 >, Kratos::TwoStepUpdatedLagrangianVPImplicitNodallyIntegratedSolidElement< 3 >, Kratos::TwoStepUpdatedLagrangianVPImplicitNodallyIntegratedFluidElement< 2 >, Kratos::TwoStepUpdatedLagrangianVPImplicitNodallyIntegratedFluidElement< 3 >, Kratos::TwoStepUpdatedLagrangianVPImplicitNodallyIntegratedElement< 2 >, Kratos::TwoStepUpdatedLagrangianVPImplicitNodallyIntegratedElement< 3 >, Kratos::TwoStepUpdatedLagrangianVPImplicitFluidPspgElement< 2 >, Kratos::TwoStepUpdatedLagrangianVPImplicitFluidPspgElement< 3 >, Kratos::TwoStepUpdatedLagrangianVPImplicitFluidFicElement< 2 >, Kratos::TwoStepUpdatedLagrangianVPImplicitFluidFicElement< 3 >, Kratos::TwoStepUpdatedLagrangianVPImplicitFluidDEMcouplingElement< 2 >, Kratos::TwoStepUpdatedLagrangianVPImplicitFluidDEMcouplingElement< 3 >, Kratos::TwoStepUpdatedLagrangianVPImplicitElement< 2 >, Kratos::TwoStepUpdatedLagrangianVPImplicitElement< 3 >, Kratos::TwoStepUpdatedLagrangianElement< 2 >, Kratos::TwoStepUpdatedLagrangianElement< 3 >, Kratos::ThreeStepUpdatedLagrangianElement< 2 >, Kratos::ThreeStepUpdatedLagrangianElement< 3 >, Kratos::ThreeStepSecondOrderUpdatedLagrangianElement< 2 >, Kratos::ThreeStepSecondOrderUpdatedLagrangianElement< 3 >, Kratos::ThreeStepSecondOrderPspgUpdatedLagrangianElement< 2 >, Kratos::ThreeStepSecondOrderPspgUpdatedLagrangianElement< 3 >, Kratos::ThreeStepFirstOrderUpdatedLagrangianElement< 2 >, and Kratos::ThreeStepFirstOrderUpdatedLagrangianElement< 3 >.
|
overridevirtual |
creates a new element pointer
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::Element.
Reimplemented in Kratos::UpdatedLagrangianVElement, Kratos::UpdatedLagrangianUPElement, Kratos::UpdatedLagrangianSegregatedVPElement, Kratos::UpdatedLagrangianElement< TDim >, Kratos::UpdatedLagrangianElement< 2 >, Kratos::UpdatedLagrangianElement< 3 >, Kratos::TotalLagrangianElement, Kratos::SmallDisplacementElement, Kratos::SmallDisplacementBbarElement, Kratos::LargeDisplacementVElement, Kratos::LargeDisplacementUPElement, Kratos::LargeDisplacementSegregatedVPElement, Kratos::LargeDisplacementElement, Kratos::AxisymmetricUpdatedLagrangianUPElement, Kratos::AxisymmetricUpdatedLagrangianElement, Kratos::AxisymmetricSmallDisplacementElement, Kratos::UpdatedLagrangianUwPStabElement, Kratos::UpdatedLagrangianUwPElement, Kratos::UpdatedLagrangianUWwPElement, Kratos::UpdatedLagrangianUWwPDMEElement, Kratos::UpdatedLagrangianUWElement, Kratos::UpdatedLagrangianUPressureElement, Kratos::UpdatedLagrangianUPwPElement, Kratos::UpdatedLagrangianUJwPElement, Kratos::UpdatedLagrangianUJWwPHOElement, Kratos::UpdatedLagrangianUJWwPElement, Kratos::UpdatedLagrangianUJWwPDMEElement, Kratos::UpdatedLagrangianUJPElement, Kratos::UpdatedLagrangianUJElement, Kratos::TotalUpdatedLagrangianUPElement, Kratos::TotalUpdatedLagrangianElement, Kratos::SmallDisplacementUWwPElement, Kratos::AxisymUpdatedLagrangianUwPStabElement, Kratos::AxisymUpdatedLagrangianUwPElement, Kratos::AxisymUpdatedLagrangianUPressureElement, Kratos::AxisymUpdatedLagrangianUPwPElement, Kratos::AxisymUpdatedLagrangianUJwPElement, Kratos::AxisymUpdatedLagrangianUJWwPElement, Kratos::AxisymUpdatedLagrangianUJWwPDMEElement, Kratos::AxisymUpdatedLagrangianUJElement, Kratos::UpdatedLagrangianElement< TDim >, Kratos::UpdatedLagrangianElement< 2 >, and Kratos::UpdatedLagrangianElement< 3 >.
|
overridevirtual |
creates a new element pointer
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::Element.
Reimplemented in Kratos::UpdatedLagrangianVElement, Kratos::UpdatedLagrangianUPElement, Kratos::UpdatedLagrangianSegregatedVPElement, Kratos::UpdatedLagrangianElement< TDim >, Kratos::UpdatedLagrangianElement< 2 >, Kratos::UpdatedLagrangianElement< 3 >, Kratos::TotalLagrangianElement, Kratos::UpdatedLagrangianElement< 2 >, and Kratos::UpdatedLagrangianElement< 3 >.
|
overridevirtual |
Sets on rResult the ID's of the element degrees of freedom
Reimplemented from Kratos::Element.
Reimplemented in Kratos::LargeDisplacementVElement, Kratos::LargeDisplacementUPElement, Kratos::LargeDisplacementSegregatedVPElement, Kratos::UpdatedLagrangianElement< TDim >, Kratos::UpdatedLagrangianElement< 2 >, Kratos::UpdatedLagrangianElement< 3 >, Kratos::TwoStepUpdatedLagrangianElement< TDim >, Kratos::TwoStepUpdatedLagrangianElement< 2 >, Kratos::TwoStepUpdatedLagrangianElement< 3 >, Kratos::ThreeStepUpdatedLagrangianElement< TDim >, Kratos::ThreeStepUpdatedLagrangianElement< 2 >, and Kratos::ThreeStepUpdatedLagrangianElement< 3 >.
|
overridevirtual |
Sets on rResult the ID's of the element degrees of freedom
Reimplemented from Kratos::Element.
Reimplemented in Kratos::UpdatedLagrangianElement< 2 >, Kratos::UpdatedLagrangianElement< 3 >, Kratos::TwoStepUpdatedLagrangianElement< 2 >, Kratos::TwoStepUpdatedLagrangianElement< 3 >, Kratos::ThreeStepUpdatedLagrangianElement< 2 >, and Kratos::ThreeStepUpdatedLagrangianElement< 3 >.
|
overridevirtual |
this is called for non-linear analysis at the beginning of the iteration process
Reimplemented from Kratos::Element.
Reimplemented in Kratos::LargeDisplacementSegregatedVPElement.
|
overridevirtual |
this is called for non-linear analysis at the beginning of the iteration process
Reimplemented from Kratos::Element.
|
overridevirtual |
Called at the end of eahc solution step
Reimplemented from Kratos::Element.
Reimplemented in Kratos::LargeDisplacementSegregatedVPElement, and Kratos::LargeDisplacementElement.
|
overridevirtual |
Called at the end of eahc solution step
Reimplemented from Kratos::Element.
|
protectedvirtual |
Finalize Element Internal Variables
Reimplemented in Kratos::UpdatedLagrangianVElement, Kratos::UpdatedLagrangianUPElement, Kratos::UpdatedLagrangianSegregatedVPElement, Kratos::UpdatedLagrangianElement< TDim >, Kratos::UpdatedLagrangianElement< 2 >, Kratos::UpdatedLagrangianElement< 3 >, Kratos::AxisymmetricUpdatedLagrangianUPElement, Kratos::AxisymmetricUpdatedLagrangianElement, and Kratos::UpdatedLagrangianUJElement.
|
protectedvirtual |
Finalize Element Internal Variables
Reimplemented in Kratos::UpdatedLagrangianVElement, Kratos::UpdatedLagrangianUPElement, Kratos::UpdatedLagrangianSegregatedVPElement, Kratos::UpdatedLagrangianElement< TDim >, Kratos::UpdatedLagrangianElement< 2 >, Kratos::UpdatedLagrangianElement< 3 >, Kratos::AxisymmetricUpdatedLagrangianUPElement, Kratos::AxisymmetricUpdatedLagrangianElement, and Kratos::UpdatedLagrangianUJElement.
|
overridevirtual |
Sets on rElementalDofList the degrees of freedom of the considered element geometry
Reimplemented from Kratos::Element.
Reimplemented in Kratos::LargeDisplacementVElement, Kratos::LargeDisplacementUPElement, Kratos::LargeDisplacementSegregatedVPElement, Kratos::UpdatedLagrangianElement< 2 >, and Kratos::UpdatedLagrangianElement< 3 >.
|
overridevirtual |
Sets on rElementalDofList the degrees of freedom of the considered element geometry
Reimplemented from Kratos::Element.
Reimplemented in Kratos::UpdatedLagrangianElement< 2 >, and Kratos::UpdatedLagrangianElement< 3 >.
|
protectedvirtual |
Get element size from the dofs
Reimplemented in Kratos::LargeDisplacementVElement, Kratos::LargeDisplacementUPElement, Kratos::LargeDisplacementSegregatedVPElement, and Kratos::UpdatedLagrangianUJElement.
|
protectedvirtual |
Get element size from the dofs
Reimplemented in Kratos::LargeDisplacementVElement, Kratos::LargeDisplacementUPElement, Kratos::LargeDisplacementSegregatedVPElement, and Kratos::UpdatedLagrangianUJElement.
|
overridevirtual |
Sets on rValues the nodal velocities
Reimplemented from Kratos::Element.
Reimplemented in Kratos::LargeDisplacementUPElement, Kratos::LargeDisplacementSegregatedVPElement, Kratos::UpdatedLagrangianUwPElement, Kratos::UpdatedLagrangianUWwPElement, Kratos::UpdatedLagrangianUWElement, Kratos::UpdatedLagrangianUPwPElement, Kratos::UpdatedLagrangianUJwPElement, Kratos::UpdatedLagrangianUJWwPElement, Kratos::UpdatedLagrangianUJPElement, Kratos::UpdatedLagrangianUJElement, Kratos::SmallDisplacementUWwPElement, Kratos::AxisymUpdatedLagrangianUwPElement, Kratos::AxisymUpdatedLagrangianUPwPElement, Kratos::AxisymUpdatedLagrangianUJwPElement, and Kratos::AxisymUpdatedLagrangianUJWwPElement.
|
overridevirtual |
Sets on rValues the nodal velocities
Reimplemented from Kratos::Element.
|
overridevirtual |
Returns the currently selected integration method
Reimplemented from Kratos::Element.
Reimplemented in Kratos::UpdatedLagrangianElement< TDim >, Kratos::UpdatedLagrangianElement< 2 >, and Kratos::UpdatedLagrangianElement< 3 >.
|
overridevirtual |
Returns the currently selected integration method
Reimplemented from Kratos::Element.
Reimplemented in Kratos::UpdatedLagrangianElement< 2 >, and Kratos::UpdatedLagrangianElement< 3 >.
|
overridevirtual |
Sets on rValues the nodal accelerations
Reimplemented from Kratos::Element.
Reimplemented in Kratos::LargeDisplacementUPElement, Kratos::LargeDisplacementSegregatedVPElement, Kratos::UpdatedLagrangianUwPElement, Kratos::UpdatedLagrangianUWwPElement, Kratos::UpdatedLagrangianUWElement, Kratos::UpdatedLagrangianUPwPElement, Kratos::UpdatedLagrangianUJwPElement, Kratos::UpdatedLagrangianUJWwPElement, Kratos::UpdatedLagrangianUJPElement, Kratos::UpdatedLagrangianUJElement, Kratos::SmallDisplacementUWwPElement, Kratos::AxisymUpdatedLagrangianUwPElement, Kratos::AxisymUpdatedLagrangianUPwPElement, Kratos::AxisymUpdatedLagrangianUJwPElement, and Kratos::AxisymUpdatedLagrangianUJWwPElement.
|
overridevirtual |
Sets on rValues the nodal accelerations
Reimplemented from Kratos::Element.
Sets on rValues the nodal displacements
Reimplemented from Kratos::Element.
Reimplemented in Kratos::LargeDisplacementUPElement, Kratos::LargeDisplacementSegregatedVPElement, Kratos::UpdatedLagrangianUwPElement, Kratos::UpdatedLagrangianUWwPElement, Kratos::UpdatedLagrangianUWElement, Kratos::UpdatedLagrangianUPwPElement, Kratos::UpdatedLagrangianUJwPElement, Kratos::UpdatedLagrangianUJWwPElement, Kratos::UpdatedLagrangianUJPElement, Kratos::UpdatedLagrangianUJElement, Kratos::SmallDisplacementUWwPElement, Kratos::AxisymUpdatedLagrangianUwPElement, Kratos::AxisymUpdatedLagrangianUPwPElement, Kratos::AxisymUpdatedLagrangianUJwPElement, and Kratos::AxisymUpdatedLagrangianUJWwPElement.
Sets on rValues the nodal displacements
Reimplemented from Kratos::Element.
|
protected |
Increases the integration method in the "increment" order
|
protected |
Increases the integration method in the "increment" order
|
inlineoverridevirtual |
Turn back information as a string.
Reimplemented from Kratos::Element.
Reimplemented in Kratos::UpdatedLagrangianVElement, Kratos::UpdatedLagrangianSegregatedVPElement, Kratos::UpdatedLagrangianElement< TDim >, Kratos::UpdatedLagrangianElement< 2 >, Kratos::UpdatedLagrangianElement< 3 >, Kratos::LargeDisplacementElement, Kratos::UpdatedLagrangianVImplicitSolidElement< TDim >, Kratos::UpdatedLagrangianVImplicitSolidElement< 2 >, Kratos::UpdatedLagrangianVImplicitSolidElement< 3 >, Kratos::UpdatedLagrangianElement< TDim >, Kratos::UpdatedLagrangianElement< 2 >, Kratos::UpdatedLagrangianElement< 3 >, Kratos::TwoStepUpdatedLagrangianVPImplicitSolidElement< TDim >, Kratos::TwoStepUpdatedLagrangianVPImplicitSolidElement< 2 >, Kratos::TwoStepUpdatedLagrangianVPImplicitSolidElement< 3 >, Kratos::TwoStepUpdatedLagrangianVPImplicitNodallyIntegratedSolidElement< TDim >, Kratos::TwoStepUpdatedLagrangianVPImplicitNodallyIntegratedSolidElement< 2 >, Kratos::TwoStepUpdatedLagrangianVPImplicitNodallyIntegratedSolidElement< 3 >, Kratos::TwoStepUpdatedLagrangianVPImplicitNodallyIntegratedFluidElement< TDim >, Kratos::TwoStepUpdatedLagrangianVPImplicitNodallyIntegratedFluidElement< 2 >, Kratos::TwoStepUpdatedLagrangianVPImplicitNodallyIntegratedFluidElement< 3 >, Kratos::TwoStepUpdatedLagrangianVPImplicitNodallyIntegratedElement< TDim >, Kratos::TwoStepUpdatedLagrangianVPImplicitNodallyIntegratedElement< 2 >, Kratos::TwoStepUpdatedLagrangianVPImplicitNodallyIntegratedElement< 3 >, Kratos::TwoStepUpdatedLagrangianVPImplicitFluidPspgElement< TDim >, Kratos::TwoStepUpdatedLagrangianVPImplicitFluidPspgElement< 2 >, Kratos::TwoStepUpdatedLagrangianVPImplicitFluidPspgElement< 3 >, Kratos::TwoStepUpdatedLagrangianVPImplicitFluidFicElement< TDim >, Kratos::TwoStepUpdatedLagrangianVPImplicitFluidFicElement< 2 >, Kratos::TwoStepUpdatedLagrangianVPImplicitFluidFicElement< 3 >, Kratos::TwoStepUpdatedLagrangianVPImplicitFluidElement< TDim >, Kratos::TwoStepUpdatedLagrangianVPImplicitFluidDEMcouplingElement< TDim >, Kratos::TwoStepUpdatedLagrangianVPImplicitFluidDEMcouplingElement< 2 >, Kratos::TwoStepUpdatedLagrangianVPImplicitFluidDEMcouplingElement< 3 >, Kratos::TwoStepUpdatedLagrangianVPImplicitElement< TDim >, Kratos::TwoStepUpdatedLagrangianVPImplicitElement< 2 >, Kratos::TwoStepUpdatedLagrangianVPImplicitElement< 3 >, Kratos::TwoStepUpdatedLagrangianElement< TDim >, Kratos::TwoStepUpdatedLagrangianElement< 2 >, Kratos::TwoStepUpdatedLagrangianElement< 3 >, Kratos::ThreeStepUpdatedLagrangianElement< TDim >, Kratos::ThreeStepUpdatedLagrangianElement< 2 >, Kratos::ThreeStepUpdatedLagrangianElement< 3 >, Kratos::ThreeStepSecondOrderUpdatedLagrangianElement< TDim >, Kratos::ThreeStepSecondOrderUpdatedLagrangianElement< 2 >, Kratos::ThreeStepSecondOrderUpdatedLagrangianElement< 3 >, Kratos::ThreeStepSecondOrderPspgUpdatedLagrangianElement< TDim >, Kratos::ThreeStepSecondOrderPspgUpdatedLagrangianElement< 2 >, Kratos::ThreeStepSecondOrderPspgUpdatedLagrangianElement< 3 >, Kratos::ThreeStepFirstOrderUpdatedLagrangianElement< TDim >, Kratos::ThreeStepFirstOrderUpdatedLagrangianElement< 2 >, and Kratos::ThreeStepFirstOrderUpdatedLagrangianElement< 3 >.
|
inlineoverridevirtual |
Turn back information as a string.
Reimplemented from Kratos::Element.
Reimplemented in Kratos::UpdatedLagrangianVElement, Kratos::UpdatedLagrangianSegregatedVPElement, Kratos::UpdatedLagrangianElement< TDim >, Kratos::UpdatedLagrangianElement< 2 >, Kratos::UpdatedLagrangianElement< 3 >, Kratos::UpdatedLagrangianVImplicitSolidElement< 2 >, Kratos::UpdatedLagrangianVImplicitSolidElement< 3 >, Kratos::UpdatedLagrangianElement< 2 >, Kratos::UpdatedLagrangianElement< 3 >, Kratos::TwoStepUpdatedLagrangianVPImplicitSolidElement< 2 >, Kratos::TwoStepUpdatedLagrangianVPImplicitSolidElement< 3 >, Kratos::TwoStepUpdatedLagrangianVPImplicitNodallyIntegratedSolidElement< 2 >, Kratos::TwoStepUpdatedLagrangianVPImplicitNodallyIntegratedSolidElement< 3 >, Kratos::TwoStepUpdatedLagrangianVPImplicitNodallyIntegratedFluidElement< 2 >, Kratos::TwoStepUpdatedLagrangianVPImplicitNodallyIntegratedFluidElement< 3 >, Kratos::TwoStepUpdatedLagrangianVPImplicitNodallyIntegratedElement< 2 >, Kratos::TwoStepUpdatedLagrangianVPImplicitNodallyIntegratedElement< 3 >, Kratos::TwoStepUpdatedLagrangianVPImplicitFluidPspgElement< 2 >, Kratos::TwoStepUpdatedLagrangianVPImplicitFluidPspgElement< 3 >, Kratos::TwoStepUpdatedLagrangianVPImplicitFluidFicElement< 2 >, Kratos::TwoStepUpdatedLagrangianVPImplicitFluidFicElement< 3 >, Kratos::TwoStepUpdatedLagrangianVPImplicitFluidDEMcouplingElement< 2 >, Kratos::TwoStepUpdatedLagrangianVPImplicitFluidDEMcouplingElement< 3 >, Kratos::TwoStepUpdatedLagrangianVPImplicitElement< 2 >, Kratos::TwoStepUpdatedLagrangianVPImplicitElement< 3 >, Kratos::TwoStepUpdatedLagrangianElement< 2 >, Kratos::TwoStepUpdatedLagrangianElement< 3 >, Kratos::ThreeStepUpdatedLagrangianElement< 2 >, Kratos::ThreeStepUpdatedLagrangianElement< 3 >, Kratos::ThreeStepSecondOrderUpdatedLagrangianElement< 2 >, Kratos::ThreeStepSecondOrderUpdatedLagrangianElement< 3 >, Kratos::ThreeStepSecondOrderPspgUpdatedLagrangianElement< 2 >, Kratos::ThreeStepSecondOrderPspgUpdatedLagrangianElement< 3 >, Kratos::ThreeStepFirstOrderUpdatedLagrangianElement< 2 >, and Kratos::ThreeStepFirstOrderUpdatedLagrangianElement< 3 >.
|
overridevirtual |
Called to initialize the element. Must be called before any calculation is done
Reimplemented from Kratos::Element.
Reimplemented in Kratos::UpdatedLagrangianVElement, Kratos::UpdatedLagrangianUPElement, Kratos::UpdatedLagrangianSegregatedVPElement, Kratos::UpdatedLagrangianElement< TDim >, Kratos::UpdatedLagrangianElement< 2 >, Kratos::UpdatedLagrangianElement< 3 >, Kratos::TotalLagrangianElement, Kratos::AxisymmetricUpdatedLagrangianUPElement, Kratos::AxisymmetricUpdatedLagrangianElement, Kratos::UpdatedLagrangianElement< TDim >, Kratos::UpdatedLagrangianElement< 2 >, Kratos::UpdatedLagrangianElement< 3 >, Kratos::TwoStepUpdatedLagrangianVPImplicitSolidElement< TDim >, Kratos::TwoStepUpdatedLagrangianVPImplicitSolidElement< 2 >, Kratos::TwoStepUpdatedLagrangianVPImplicitSolidElement< 3 >, Kratos::TwoStepUpdatedLagrangianVPImplicitNodallyIntegratedSolidElement< TDim >, Kratos::TwoStepUpdatedLagrangianVPImplicitNodallyIntegratedSolidElement< 2 >, Kratos::TwoStepUpdatedLagrangianVPImplicitNodallyIntegratedSolidElement< 3 >, Kratos::TwoStepUpdatedLagrangianVPImplicitNodallyIntegratedFluidElement< TDim >, Kratos::TwoStepUpdatedLagrangianVPImplicitNodallyIntegratedFluidElement< 2 >, Kratos::TwoStepUpdatedLagrangianVPImplicitNodallyIntegratedFluidElement< 3 >, Kratos::TwoStepUpdatedLagrangianVPImplicitNodallyIntegratedElement< TDim >, Kratos::TwoStepUpdatedLagrangianVPImplicitNodallyIntegratedElement< 2 >, Kratos::TwoStepUpdatedLagrangianVPImplicitNodallyIntegratedElement< 3 >, Kratos::TwoStepUpdatedLagrangianVPImplicitFluidPspgElement< TDim >, Kratos::TwoStepUpdatedLagrangianVPImplicitFluidPspgElement< 2 >, Kratos::TwoStepUpdatedLagrangianVPImplicitFluidPspgElement< 3 >, Kratos::TwoStepUpdatedLagrangianVPImplicitFluidElement< TDim >, Kratos::TwoStepUpdatedLagrangianVPImplicitFluidDEMcouplingElement< TDim >, Kratos::TwoStepUpdatedLagrangianVPImplicitFluidDEMcouplingElement< 2 >, Kratos::TwoStepUpdatedLagrangianVPImplicitFluidDEMcouplingElement< 3 >, Kratos::TwoStepUpdatedLagrangianVPImplicitElement< TDim >, Kratos::TwoStepUpdatedLagrangianVPImplicitElement< 2 >, Kratos::TwoStepUpdatedLagrangianVPImplicitElement< 3 >, Kratos::TwoStepUpdatedLagrangianElement< TDim >, Kratos::TwoStepUpdatedLagrangianElement< 2 >, Kratos::TwoStepUpdatedLagrangianElement< 3 >, Kratos::ThreeStepUpdatedLagrangianElement< TDim >, Kratos::ThreeStepUpdatedLagrangianElement< 2 >, and Kratos::ThreeStepUpdatedLagrangianElement< 3 >.
|
overridevirtual |
Called to initialize the element. Must be called before any calculation is done
Reimplemented from Kratos::Element.
Reimplemented in Kratos::UpdatedLagrangianVElement, Kratos::UpdatedLagrangianUPElement, Kratos::UpdatedLagrangianSegregatedVPElement, Kratos::UpdatedLagrangianElement< TDim >, Kratos::UpdatedLagrangianElement< 2 >, Kratos::UpdatedLagrangianElement< 3 >, Kratos::TotalLagrangianElement, Kratos::UpdatedLagrangianElement< 2 >, Kratos::UpdatedLagrangianElement< 3 >, Kratos::TwoStepUpdatedLagrangianVPImplicitSolidElement< 2 >, Kratos::TwoStepUpdatedLagrangianVPImplicitSolidElement< 3 >, Kratos::TwoStepUpdatedLagrangianVPImplicitNodallyIntegratedSolidElement< 2 >, Kratos::TwoStepUpdatedLagrangianVPImplicitNodallyIntegratedSolidElement< 3 >, Kratos::TwoStepUpdatedLagrangianVPImplicitNodallyIntegratedFluidElement< 2 >, Kratos::TwoStepUpdatedLagrangianVPImplicitNodallyIntegratedFluidElement< 3 >, Kratos::TwoStepUpdatedLagrangianVPImplicitNodallyIntegratedElement< 2 >, Kratos::TwoStepUpdatedLagrangianVPImplicitNodallyIntegratedElement< 3 >, Kratos::TwoStepUpdatedLagrangianVPImplicitFluidPspgElement< 2 >, Kratos::TwoStepUpdatedLagrangianVPImplicitFluidPspgElement< 3 >, Kratos::TwoStepUpdatedLagrangianVPImplicitFluidDEMcouplingElement< 2 >, Kratos::TwoStepUpdatedLagrangianVPImplicitFluidDEMcouplingElement< 3 >, Kratos::TwoStepUpdatedLagrangianVPImplicitElement< 2 >, Kratos::TwoStepUpdatedLagrangianVPImplicitElement< 3 >, Kratos::TwoStepUpdatedLagrangianElement< 2 >, Kratos::TwoStepUpdatedLagrangianElement< 3 >, Kratos::ThreeStepUpdatedLagrangianElement< 2 >, and Kratos::ThreeStepUpdatedLagrangianElement< 3 >.
|
protected |
Initialize Material Properties on the Constitutive Law
|
protected |
Initialize Material Properties on the Constitutive Law
|
protectedvirtual |
Initialize Element General Variables
Reimplemented in Kratos::UpdatedLagrangianVElement, Kratos::UpdatedLagrangianUPElement, Kratos::UpdatedLagrangianSegregatedVPElement, Kratos::UpdatedLagrangianElement< TDim >, Kratos::UpdatedLagrangianElement< 2 >, Kratos::UpdatedLagrangianElement< 3 >, Kratos::SmallDisplacementElement, Kratos::SmallDisplacementBbarElement, Kratos::AxisymmetricUpdatedLagrangianUPElement, Kratos::AxisymmetricUpdatedLagrangianElement, Kratos::AxisymmetricSmallDisplacementElement, Kratos::UpdatedLagrangianUwPStabElement, Kratos::UpdatedLagrangianUwPElement, Kratos::UpdatedLagrangianUWwPElement, Kratos::UpdatedLagrangianUWElement, Kratos::UpdatedLagrangianUPressureElement, Kratos::UpdatedLagrangianUPwPElement, Kratos::UpdatedLagrangianUJwPElement, Kratos::UpdatedLagrangianUJWwPElement, Kratos::UpdatedLagrangianUJPElement, Kratos::UpdatedLagrangianUJElement, Kratos::TotalUpdatedLagrangianUPElement, Kratos::TotalUpdatedLagrangianElement, Kratos::SmallDisplacementUWwPElement, Kratos::AxisymUpdatedLagrangianUwPStabElement, Kratos::AxisymUpdatedLagrangianUwPElement, Kratos::AxisymUpdatedLagrangianUPressureElement, Kratos::AxisymUpdatedLagrangianUPwPElement, Kratos::AxisymUpdatedLagrangianUJwPElement, Kratos::AxisymUpdatedLagrangianUJWwPElement, Kratos::AxisymUpdatedLagrangianUJElement, and Kratos::SmallDisplacementElement.
|
protectedvirtual |
Initialize Element General Variables
Reimplemented in Kratos::UpdatedLagrangianVElement, Kratos::UpdatedLagrangianUPElement, Kratos::UpdatedLagrangianSegregatedVPElement, Kratos::UpdatedLagrangianElement< TDim >, Kratos::UpdatedLagrangianElement< 2 >, Kratos::UpdatedLagrangianElement< 3 >, Kratos::SmallDisplacementElement, Kratos::SmallDisplacementBbarElement, Kratos::AxisymmetricUpdatedLagrangianUPElement, Kratos::AxisymmetricUpdatedLagrangianElement, Kratos::AxisymmetricSmallDisplacementElement, Kratos::UpdatedLagrangianUwPStabElement, Kratos::UpdatedLagrangianUwPElement, Kratos::UpdatedLagrangianUWwPElement, Kratos::UpdatedLagrangianUWElement, Kratos::UpdatedLagrangianUPressureElement, Kratos::UpdatedLagrangianUPwPElement, Kratos::UpdatedLagrangianUJwPElement, Kratos::UpdatedLagrangianUJWwPElement, Kratos::UpdatedLagrangianUJPElement, Kratos::UpdatedLagrangianUJElement, Kratos::TotalUpdatedLagrangianUPElement, Kratos::TotalUpdatedLagrangianElement, Kratos::SmallDisplacementUWwPElement, Kratos::AxisymUpdatedLagrangianUwPStabElement, Kratos::AxisymUpdatedLagrangianUwPElement, Kratos::AxisymUpdatedLagrangianUPressureElement, Kratos::AxisymUpdatedLagrangianUPwPElement, Kratos::AxisymUpdatedLagrangianUJwPElement, Kratos::AxisymUpdatedLagrangianUJWwPElement, Kratos::AxisymUpdatedLagrangianUJElement, and Kratos::SmallDisplacementElement.
|
protected |
Clear Nodal Forces
|
protected |
Clear Nodal Forces
|
overridevirtual |
this is called for non-linear analysis at the beginning of the iteration process
Reimplemented from Kratos::Element.
Reimplemented in Kratos::LargeDisplacementSegregatedVPElement, Kratos::UpdatedLagrangianElement< TDim >, Kratos::UpdatedLagrangianElement< 2 >, Kratos::UpdatedLagrangianElement< 3 >, Kratos::TwoStepUpdatedLagrangianVPImplicitSolidElement< TDim >, Kratos::TwoStepUpdatedLagrangianVPImplicitSolidElement< 2 >, Kratos::TwoStepUpdatedLagrangianVPImplicitSolidElement< 3 >, Kratos::TwoStepUpdatedLagrangianVPImplicitNodallyIntegratedElement< TDim >, Kratos::TwoStepUpdatedLagrangianVPImplicitNodallyIntegratedElement< 2 >, Kratos::TwoStepUpdatedLagrangianVPImplicitNodallyIntegratedElement< 3 >, Kratos::TwoStepUpdatedLagrangianVPImplicitFluidPspgElement< TDim >, Kratos::TwoStepUpdatedLagrangianVPImplicitFluidPspgElement< 2 >, Kratos::TwoStepUpdatedLagrangianVPImplicitFluidPspgElement< 3 >, Kratos::TwoStepUpdatedLagrangianVPImplicitFluidFicElement< TDim >, Kratos::TwoStepUpdatedLagrangianVPImplicitFluidFicElement< 2 >, Kratos::TwoStepUpdatedLagrangianVPImplicitFluidFicElement< 3 >, Kratos::TwoStepUpdatedLagrangianVPImplicitFluidElement< TDim >, Kratos::TwoStepUpdatedLagrangianVPImplicitFluidDEMcouplingElement< TDim >, Kratos::TwoStepUpdatedLagrangianVPImplicitFluidDEMcouplingElement< 2 >, Kratos::TwoStepUpdatedLagrangianVPImplicitFluidDEMcouplingElement< 3 >, Kratos::TwoStepUpdatedLagrangianVPImplicitElement< TDim >, Kratos::TwoStepUpdatedLagrangianVPImplicitElement< 2 >, Kratos::TwoStepUpdatedLagrangianVPImplicitElement< 3 >, Kratos::TwoStepUpdatedLagrangianElement< TDim >, Kratos::TwoStepUpdatedLagrangianElement< 2 >, Kratos::TwoStepUpdatedLagrangianElement< 3 >, Kratos::ThreeStepUpdatedLagrangianElement< TDim >, Kratos::ThreeStepUpdatedLagrangianElement< 2 >, and Kratos::ThreeStepUpdatedLagrangianElement< 3 >.
|
overridevirtual |
this is called for non-linear analysis at the beginning of the iteration process
Reimplemented from Kratos::Element.
Reimplemented in Kratos::UpdatedLagrangianElement< 2 >, Kratos::UpdatedLagrangianElement< 3 >, Kratos::TwoStepUpdatedLagrangianVPImplicitSolidElement< 2 >, Kratos::TwoStepUpdatedLagrangianVPImplicitSolidElement< 3 >, Kratos::TwoStepUpdatedLagrangianVPImplicitNodallyIntegratedElement< 2 >, Kratos::TwoStepUpdatedLagrangianVPImplicitNodallyIntegratedElement< 3 >, Kratos::TwoStepUpdatedLagrangianVPImplicitFluidPspgElement< 2 >, Kratos::TwoStepUpdatedLagrangianVPImplicitFluidPspgElement< 3 >, Kratos::TwoStepUpdatedLagrangianVPImplicitFluidFicElement< 2 >, Kratos::TwoStepUpdatedLagrangianVPImplicitFluidFicElement< 3 >, Kratos::TwoStepUpdatedLagrangianVPImplicitFluidDEMcouplingElement< 2 >, Kratos::TwoStepUpdatedLagrangianVPImplicitFluidDEMcouplingElement< 3 >, Kratos::TwoStepUpdatedLagrangianVPImplicitElement< 2 >, Kratos::TwoStepUpdatedLagrangianVPImplicitElement< 3 >, Kratos::TwoStepUpdatedLagrangianElement< 2 >, Kratos::TwoStepUpdatedLagrangianElement< 3 >, Kratos::ThreeStepUpdatedLagrangianElement< 2 >, and Kratos::ThreeStepUpdatedLagrangianElement< 3 >.
|
overridevirtual |
Called at the beginning of each solution step
Reimplemented from Kratos::Element.
Reimplemented in Kratos::LargeDisplacementSegregatedVPElement, Kratos::LargeDisplacementElement, Kratos::UpdatedLagrangianElement< TDim >, Kratos::UpdatedLagrangianElement< 2 >, Kratos::UpdatedLagrangianElement< 3 >, Kratos::TwoStepUpdatedLagrangianVPImplicitNodallyIntegratedSolidElement< TDim >, Kratos::TwoStepUpdatedLagrangianVPImplicitNodallyIntegratedSolidElement< 2 >, Kratos::TwoStepUpdatedLagrangianVPImplicitNodallyIntegratedSolidElement< 3 >, Kratos::TwoStepUpdatedLagrangianVPImplicitNodallyIntegratedFluidElement< TDim >, Kratos::TwoStepUpdatedLagrangianVPImplicitNodallyIntegratedFluidElement< 2 >, Kratos::TwoStepUpdatedLagrangianVPImplicitNodallyIntegratedFluidElement< 3 >, Kratos::TwoStepUpdatedLagrangianVPImplicitNodallyIntegratedElement< TDim >, Kratos::TwoStepUpdatedLagrangianVPImplicitNodallyIntegratedElement< 2 >, Kratos::TwoStepUpdatedLagrangianVPImplicitNodallyIntegratedElement< 3 >, Kratos::TwoStepUpdatedLagrangianVPImplicitFluidPspgElement< TDim >, Kratos::TwoStepUpdatedLagrangianVPImplicitFluidPspgElement< 2 >, Kratos::TwoStepUpdatedLagrangianVPImplicitFluidPspgElement< 3 >, Kratos::TwoStepUpdatedLagrangianVPImplicitFluidFicElement< TDim >, Kratos::TwoStepUpdatedLagrangianVPImplicitFluidFicElement< 2 >, Kratos::TwoStepUpdatedLagrangianVPImplicitFluidFicElement< 3 >, Kratos::TwoStepUpdatedLagrangianVPImplicitFluidElement< TDim >, Kratos::TwoStepUpdatedLagrangianVPImplicitFluidDEMcouplingElement< TDim >, Kratos::TwoStepUpdatedLagrangianVPImplicitFluidDEMcouplingElement< 2 >, Kratos::TwoStepUpdatedLagrangianVPImplicitFluidDEMcouplingElement< 3 >, Kratos::TwoStepUpdatedLagrangianVPImplicitElement< TDim >, Kratos::TwoStepUpdatedLagrangianVPImplicitElement< 2 >, Kratos::TwoStepUpdatedLagrangianVPImplicitElement< 3 >, Kratos::TwoStepUpdatedLagrangianElement< TDim >, Kratos::TwoStepUpdatedLagrangianElement< 2 >, Kratos::TwoStepUpdatedLagrangianElement< 3 >, Kratos::ThreeStepUpdatedLagrangianElement< TDim >, Kratos::ThreeStepUpdatedLagrangianElement< 2 >, and Kratos::ThreeStepUpdatedLagrangianElement< 3 >.
|
overridevirtual |
Called at the beginning of each solution step
Reimplemented from Kratos::Element.
Reimplemented in Kratos::UpdatedLagrangianElement< 2 >, Kratos::UpdatedLagrangianElement< 3 >, Kratos::TwoStepUpdatedLagrangianVPImplicitNodallyIntegratedSolidElement< 2 >, Kratos::TwoStepUpdatedLagrangianVPImplicitNodallyIntegratedSolidElement< 3 >, Kratos::TwoStepUpdatedLagrangianVPImplicitNodallyIntegratedFluidElement< 2 >, Kratos::TwoStepUpdatedLagrangianVPImplicitNodallyIntegratedFluidElement< 3 >, Kratos::TwoStepUpdatedLagrangianVPImplicitNodallyIntegratedElement< 2 >, Kratos::TwoStepUpdatedLagrangianVPImplicitNodallyIntegratedElement< 3 >, Kratos::TwoStepUpdatedLagrangianVPImplicitFluidPspgElement< 2 >, Kratos::TwoStepUpdatedLagrangianVPImplicitFluidPspgElement< 3 >, Kratos::TwoStepUpdatedLagrangianVPImplicitFluidFicElement< 2 >, Kratos::TwoStepUpdatedLagrangianVPImplicitFluidFicElement< 3 >, Kratos::TwoStepUpdatedLagrangianVPImplicitFluidDEMcouplingElement< 2 >, Kratos::TwoStepUpdatedLagrangianVPImplicitFluidDEMcouplingElement< 3 >, Kratos::TwoStepUpdatedLagrangianVPImplicitElement< 2 >, Kratos::TwoStepUpdatedLagrangianVPImplicitElement< 3 >, Kratos::TwoStepUpdatedLagrangianElement< 2 >, Kratos::TwoStepUpdatedLagrangianElement< 3 >, Kratos::ThreeStepUpdatedLagrangianElement< 2 >, and Kratos::ThreeStepUpdatedLagrangianElement< 3 >.
|
protectedvirtual |
Initialize System Matrices
Reimplemented in Kratos::UpdatedLagrangianUwPElement, Kratos::UpdatedLagrangianUWwPElement, Kratos::UpdatedLagrangianUWElement, Kratos::UpdatedLagrangianUPwPElement, Kratos::UpdatedLagrangianUJwPElement, Kratos::UpdatedLagrangianUJWwPElement, Kratos::UpdatedLagrangianUJPElement, Kratos::SmallDisplacementUWwPElement, Kratos::AxisymUpdatedLagrangianUwPElement, Kratos::AxisymUpdatedLagrangianUPwPElement, Kratos::AxisymUpdatedLagrangianUJwPElement, and Kratos::AxisymUpdatedLagrangianUJWwPElement.
|
protectedvirtual |
Initialize System Matrices
Reimplemented in Kratos::UpdatedLagrangianUwPElement, Kratos::UpdatedLagrangianUWwPElement, Kratos::UpdatedLagrangianUWElement, Kratos::UpdatedLagrangianUPwPElement, Kratos::UpdatedLagrangianUJwPElement, Kratos::UpdatedLagrangianUJWwPElement, Kratos::UpdatedLagrangianUJPElement, Kratos::SmallDisplacementUWwPElement, Kratos::AxisymUpdatedLagrangianUwPElement, Kratos::AxisymUpdatedLagrangianUPwPElement, Kratos::AxisymUpdatedLagrangianUJwPElement, and Kratos::AxisymUpdatedLagrangianUJWwPElement.
|
inlineprotected |
Get element calculation flag
|
inlineprotected |
Get element calculation flag
Kratos::SolidElement::KRATOS_CLASS_INTRUSIVE_POINTER_DEFINITION | ( | SolidElement | ) |
Counted pointer of SolidElement.
Kratos::SolidElement::KRATOS_CLASS_INTRUSIVE_POINTER_DEFINITION | ( | SolidElement | ) |
Counted pointer of SolidElement.
|
protected |
|
protected |
|
protected |
Flags related to the element computation
|
protected |
Flags related to the element computation
|
protected |
|
protected |
SolidElement & Kratos::SolidElement::operator= | ( | SolidElement const & | rOther | ) |
Assignment operator.
SolidElement& Kratos::SolidElement::operator= | ( | SolidElement const & | rOther | ) |
Assignment operator.
|
inlineoverridevirtual |
Print object's data.
Reimplemented from Kratos::Element.
Reimplemented in Kratos::UpdatedLagrangianVElement, Kratos::UpdatedLagrangianSegregatedVPElement, Kratos::UpdatedLagrangianElement< TDim >, Kratos::UpdatedLagrangianElement< 2 >, Kratos::UpdatedLagrangianElement< 3 >, and Kratos::LargeDisplacementElement.
|
inlineoverridevirtual |
Print object's data.
Reimplemented from Kratos::Element.
Reimplemented in Kratos::UpdatedLagrangianVElement, Kratos::UpdatedLagrangianSegregatedVPElement, Kratos::UpdatedLagrangianElement< TDim >, Kratos::UpdatedLagrangianElement< 2 >, and Kratos::UpdatedLagrangianElement< 3 >.
|
protected |
Prints element information for each gauss point (debugging purposes)
|
protected |
Prints element information for each gauss point (debugging purposes)
|
inlineoverridevirtual |
Print information about this object.
Reimplemented from Kratos::Element.
Reimplemented in Kratos::UpdatedLagrangianVElement, Kratos::UpdatedLagrangianSegregatedVPElement, Kratos::UpdatedLagrangianElement< TDim >, Kratos::UpdatedLagrangianElement< 2 >, Kratos::UpdatedLagrangianElement< 3 >, Kratos::LargeDisplacementElement, Kratos::UpdatedLagrangianVImplicitSolidElement< TDim >, Kratos::UpdatedLagrangianVImplicitSolidElement< 2 >, Kratos::UpdatedLagrangianVImplicitSolidElement< 3 >, Kratos::UpdatedLagrangianElement< TDim >, Kratos::UpdatedLagrangianElement< 2 >, Kratos::UpdatedLagrangianElement< 3 >, Kratos::TwoStepUpdatedLagrangianVPImplicitSolidElement< TDim >, Kratos::TwoStepUpdatedLagrangianVPImplicitSolidElement< 2 >, Kratos::TwoStepUpdatedLagrangianVPImplicitSolidElement< 3 >, Kratos::TwoStepUpdatedLagrangianVPImplicitNodallyIntegratedSolidElement< TDim >, Kratos::TwoStepUpdatedLagrangianVPImplicitNodallyIntegratedSolidElement< 2 >, Kratos::TwoStepUpdatedLagrangianVPImplicitNodallyIntegratedSolidElement< 3 >, Kratos::TwoStepUpdatedLagrangianVPImplicitNodallyIntegratedFluidElement< TDim >, Kratos::TwoStepUpdatedLagrangianVPImplicitNodallyIntegratedFluidElement< 2 >, Kratos::TwoStepUpdatedLagrangianVPImplicitNodallyIntegratedFluidElement< 3 >, Kratos::TwoStepUpdatedLagrangianVPImplicitNodallyIntegratedElement< TDim >, Kratos::TwoStepUpdatedLagrangianVPImplicitNodallyIntegratedElement< 2 >, Kratos::TwoStepUpdatedLagrangianVPImplicitNodallyIntegratedElement< 3 >, Kratos::TwoStepUpdatedLagrangianVPImplicitFluidPspgElement< TDim >, Kratos::TwoStepUpdatedLagrangianVPImplicitFluidPspgElement< 2 >, Kratos::TwoStepUpdatedLagrangianVPImplicitFluidPspgElement< 3 >, Kratos::TwoStepUpdatedLagrangianVPImplicitFluidFicElement< TDim >, Kratos::TwoStepUpdatedLagrangianVPImplicitFluidFicElement< 2 >, Kratos::TwoStepUpdatedLagrangianVPImplicitFluidFicElement< 3 >, Kratos::TwoStepUpdatedLagrangianVPImplicitFluidElement< TDim >, Kratos::TwoStepUpdatedLagrangianVPImplicitFluidDEMcouplingElement< TDim >, Kratos::TwoStepUpdatedLagrangianVPImplicitFluidDEMcouplingElement< 2 >, Kratos::TwoStepUpdatedLagrangianVPImplicitFluidDEMcouplingElement< 3 >, Kratos::TwoStepUpdatedLagrangianVPImplicitElement< TDim >, Kratos::TwoStepUpdatedLagrangianVPImplicitElement< 2 >, Kratos::TwoStepUpdatedLagrangianVPImplicitElement< 3 >, Kratos::TwoStepUpdatedLagrangianElement< TDim >, Kratos::TwoStepUpdatedLagrangianElement< 2 >, Kratos::TwoStepUpdatedLagrangianElement< 3 >, Kratos::ThreeStepUpdatedLagrangianElement< TDim >, Kratos::ThreeStepUpdatedLagrangianElement< 2 >, and Kratos::ThreeStepUpdatedLagrangianElement< 3 >.
|
inlineoverridevirtual |
Print information about this object.
Reimplemented from Kratos::Element.
Reimplemented in Kratos::UpdatedLagrangianVElement, Kratos::UpdatedLagrangianSegregatedVPElement, Kratos::UpdatedLagrangianElement< TDim >, Kratos::UpdatedLagrangianElement< 2 >, Kratos::UpdatedLagrangianElement< 3 >, Kratos::UpdatedLagrangianVImplicitSolidElement< 2 >, Kratos::UpdatedLagrangianVImplicitSolidElement< 3 >, Kratos::UpdatedLagrangianElement< 2 >, Kratos::UpdatedLagrangianElement< 3 >, Kratos::TwoStepUpdatedLagrangianVPImplicitSolidElement< 2 >, Kratos::TwoStepUpdatedLagrangianVPImplicitSolidElement< 3 >, Kratos::TwoStepUpdatedLagrangianVPImplicitNodallyIntegratedSolidElement< 2 >, Kratos::TwoStepUpdatedLagrangianVPImplicitNodallyIntegratedSolidElement< 3 >, Kratos::TwoStepUpdatedLagrangianVPImplicitNodallyIntegratedFluidElement< 2 >, Kratos::TwoStepUpdatedLagrangianVPImplicitNodallyIntegratedFluidElement< 3 >, Kratos::TwoStepUpdatedLagrangianVPImplicitNodallyIntegratedElement< 2 >, Kratos::TwoStepUpdatedLagrangianVPImplicitNodallyIntegratedElement< 3 >, Kratos::TwoStepUpdatedLagrangianVPImplicitFluidPspgElement< 2 >, Kratos::TwoStepUpdatedLagrangianVPImplicitFluidPspgElement< 3 >, Kratos::TwoStepUpdatedLagrangianVPImplicitFluidFicElement< 2 >, Kratos::TwoStepUpdatedLagrangianVPImplicitFluidFicElement< 3 >, Kratos::TwoStepUpdatedLagrangianVPImplicitFluidDEMcouplingElement< 2 >, Kratos::TwoStepUpdatedLagrangianVPImplicitFluidDEMcouplingElement< 3 >, Kratos::TwoStepUpdatedLagrangianVPImplicitElement< 2 >, Kratos::TwoStepUpdatedLagrangianVPImplicitElement< 3 >, Kratos::TwoStepUpdatedLagrangianElement< 2 >, Kratos::TwoStepUpdatedLagrangianElement< 3 >, Kratos::ThreeStepUpdatedLagrangianElement< 2 >, and Kratos::ThreeStepUpdatedLagrangianElement< 3 >.
|
overrideprotectedvirtual |
Reset the Constitutive Law Parameters
Reimplemented from Kratos::Element.
|
overrideprotectedvirtual |
Reset the Constitutive Law Parameters
Reimplemented from Kratos::Element.
|
protectedvirtual |
Set Variables of the Element to the Parameters of the Constitutive Law
Reimplemented in Kratos::SmallDisplacementElement, Kratos::LargeDisplacementVElement, Kratos::LargeDisplacementElement, and Kratos::SmallDisplacementElement.
|
protectedvirtual |
Set Variables of the Element to the Parameters of the Constitutive Law
Reimplemented in Kratos::SmallDisplacementElement, Kratos::LargeDisplacementVElement, Kratos::LargeDisplacementElement, and Kratos::SmallDisplacementElement.
|
overridevirtual |
Set a Constitutive Law Value
Reimplemented from Kratos::Element.
|
overridevirtual |
Set a Constitutive Law Value
Reimplemented from Kratos::Element.
|
overridevirtual |
Access for variables on Integration points. This gives access to variables stored in the constitutive law on each integration point. Specialisations of element.h (e.g. the TotalLagrangian) must specify the actual interface to the constitutive law! Note, that these functions expect a std::vector of values for the specified variable type that contains a value for each integration point! SetValuesOnIntegrationPoints: set the values for given Variable. Set a double Value on the Element Constitutive Law
Reimplemented from Kratos::Element.
Reimplemented in Kratos::UpdatedLagrangianVElement, Kratos::UpdatedLagrangianUPElement, Kratos::UpdatedLagrangianSegregatedVPElement, Kratos::UpdatedLagrangianElement< TDim >, Kratos::UpdatedLagrangianElement< 2 >, Kratos::UpdatedLagrangianElement< 3 >, Kratos::AxisymmetricUpdatedLagrangianUPElement, and Kratos::AxisymmetricUpdatedLagrangianElement.
|
overridevirtual |
Access for variables on Integration points. This gives access to variables stored in the constitutive law on each integration point. Specialisations of element.h (e.g. the TotalLagrangian) must specify the actual interface to the constitutive law! Note, that these functions expect a std::vector of values for the specified variable type that contains a value for each integration point! SetValuesOnIntegrationPoints: set the values for given Variable. GetValueOnIntegrationPoints: get the values for given Variable. Set a double Value on the Element Constitutive Law
Reimplemented from Kratos::Element.
Reimplemented in Kratos::UpdatedLagrangianVElement, Kratos::UpdatedLagrangianUPElement, Kratos::UpdatedLagrangianSegregatedVPElement, Kratos::UpdatedLagrangianElement< TDim >, Kratos::UpdatedLagrangianElement< 2 >, and Kratos::UpdatedLagrangianElement< 3 >.
|
overridevirtual |
Set a Matrix Value on the Element Constitutive Law
Reimplemented from Kratos::Element.
|
overridevirtual |
Set a Matrix Value on the Element Constitutive Law
Reimplemented from Kratos::Element.
|
overridevirtual |
Set a Vector Value on the Element Constitutive Law
Reimplemented from Kratos::Element.
|
overridevirtual |
Set a Vector Value on the Element Constitutive Law
Reimplemented from Kratos::Element.
|
protectedvirtual |
Transform Element General Variables
Reimplemented in Kratos::TotalUpdatedLagrangianUPElement, and Kratos::TotalUpdatedLagrangianElement.
|
protectedvirtual |
Transform Element General Variables
Reimplemented in Kratos::TotalUpdatedLagrangianUPElement, and Kratos::TotalUpdatedLagrangianElement.
|
friend |
|
protected |
Container for constitutive law instances on each integration point
|
protected |
Currently selected integration methods