![]() |
KratosMultiphysics
KRATOS Multiphysics (Kratos) is a framework for building parallel, multi-disciplinary simulation software, aiming at modularity, extensibility, and high performance. Kratos is written in C++, and counts with an extensive Python interface.
|
Updated Lagrangian element for 2D and 3D geometries. More...
#include <U_Pw_updated_lagrangian_element.hpp>
Public Member Functions | |
Input and output | |
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... | |
![]() | |
KRATOS_CLASS_INTRUSIVE_POINTER_DEFINITION (UPwSmallStrainElement) | |
UPwSmallStrainElement (IndexType NewId=0) | |
UPwSmallStrainElement (IndexType NewId, const NodesArrayType &ThisNodes) | |
Constructor using an array of nodes. More... | |
UPwSmallStrainElement (IndexType NewId, GeometryType::Pointer pGeometry) | |
Constructor using Geometry. More... | |
UPwSmallStrainElement (IndexType NewId, GeometryType::Pointer pGeometry, PropertiesType::Pointer pProperties) | |
Constructor using Properties. More... | |
~UPwSmallStrainElement () override=default | |
UPwSmallStrainElement (const UPwSmallStrainElement &)=delete | |
UPwSmallStrainElement & | operator= (const UPwSmallStrainElement &)=delete |
UPwSmallStrainElement (UPwSmallStrainElement &&)=delete | |
UPwSmallStrainElement & | operator= (UPwSmallStrainElement &&)=delete |
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 | SetValuesOnIntegrationPoints (const Variable< Vector > &rVariable, const std::vector< Vector > &rValues, const ProcessInfo &rCurrentProcessInfo) override |
void | CalculateOnIntegrationPoints (const Variable< array_1d< double, 3 >> &rVariable, std::vector< array_1d< double, 3 >> &rOutput, const ProcessInfo &rCurrentProcessInfo) override |
void | CalculateOnIntegrationPoints (const Variable< Vector > &rVariable, std::vector< Vector > &rOutput, const ProcessInfo &rCurrentProcessInfo) override |
KRATOS_CLASS_INTRUSIVE_POINTER_DEFINITION (UPwSmallStrainElement) | |
UPwSmallStrainElement (IndexType NewId=0) | |
Default Constructor. More... | |
UPwSmallStrainElement (IndexType NewId, const NodesArrayType &ThisNodes) | |
Constructor using an array of nodes. More... | |
UPwSmallStrainElement (IndexType NewId, GeometryType::Pointer pGeometry) | |
Constructor using Geometry. More... | |
UPwSmallStrainElement (IndexType NewId, GeometryType::Pointer pGeometry, PropertiesType::Pointer pProperties) | |
Constructor using Properties. More... | |
~UPwSmallStrainElement () override | |
Destructor. More... | |
Element::Pointer | Create (IndexType NewId, NodesArrayType const &ThisNodes, PropertiesType::Pointer pProperties) const override |
Element::Pointer | Create (IndexType NewId, GeometryType::Pointer pGeom, PropertiesType::Pointer pProperties) const override |
It creates a new element pointer. More... | |
int | Check (const ProcessInfo &rCurrentProcessInfo) const override |
void | InitializeNonLinearIteration (const ProcessInfo &rCurrentProcessInfo) override |
void | FinalizeNonLinearIteration (const ProcessInfo &rCurrentProcessInfo) override |
void | FinalizeSolutionStep (const ProcessInfo &rCurrentProcessInfo) override |
void | CalculateOnIntegrationPoints (const Variable< double > &rVariable, std::vector< double > &rOutput, const ProcessInfo &rCurrentProcessInfo) override |
void | CalculateOnIntegrationPoints (const Variable< array_1d< double, 3 >> &rVariable, std::vector< array_1d< double, 3 >> &rOutput, const ProcessInfo &rCurrentProcessInfo) override |
void | CalculateOnIntegrationPoints (const Variable< Matrix > &rVariable, std::vector< Matrix > &rOutput, const ProcessInfo &rCurrentProcessInfo) override |
![]() | |
KRATOS_CLASS_INTRUSIVE_POINTER_DEFINITION (UPwBaseElement) | |
UPwBaseElement (IndexType NewId=0) | |
UPwBaseElement (IndexType NewId, const NodesArrayType &ThisNodes) | |
Constructor using an array of nodes. More... | |
UPwBaseElement (IndexType NewId, GeometryType::Pointer pGeometry) | |
Constructor using Geometry. More... | |
UPwBaseElement (IndexType NewId, GeometryType::Pointer pGeometry, PropertiesType::Pointer pProperties) | |
Constructor using Properties. More... | |
~UPwBaseElement () override=default | |
UPwBaseElement (const UPwBaseElement &)=delete | |
UPwBaseElement & | operator= (const UPwBaseElement &)=delete |
UPwBaseElement (UPwBaseElement &&) noexcept=delete | |
UPwBaseElement & | operator= (UPwBaseElement &&) noexcept=delete |
void | Initialize (const ProcessInfo &rCurrentProcessInfo) override |
void | GetDofList (DofsVectorType &rElementalDofList, const ProcessInfo &rCurrentProcessInfo) const override |
void | ResetConstitutiveLaw () override |
GeometryData::IntegrationMethod | GetIntegrationMethod () const override |
void | CalculateLocalSystem (MatrixType &rLeftHandSideMatrix, VectorType &rRightHandSideVector, const ProcessInfo &rCurrentProcessInfo) override |
void | CalculateLeftHandSide (MatrixType &rLeftHandSideMatrix, const ProcessInfo &rCurrentProcessInfo) override |
void | CalculateRightHandSide (VectorType &rRightHandSideVector, const ProcessInfo &rCurrentProcessInfo) override |
void | EquationIdVector (EquationIdVectorType &rResult, const ProcessInfo &rCurrentProcessInfo) const override |
void | CalculateDampingMatrix (MatrixType &rDampingMatrix, const ProcessInfo &rCurrentProcessInfo) override |
void | GetValuesVector (Vector &rValues, int Step=0) const override |
void | GetFirstDerivativesVector (Vector &rValues, int Step=0) const override |
void | GetSecondDerivativesVector (Vector &rValues, int Step=0) const override |
void | CalculateOnIntegrationPoints (const Variable< ConstitutiveLaw::Pointer > &rVariable, std::vector< ConstitutiveLaw::Pointer > &rValues, const ProcessInfo &rCurrentProcessInfo) override |
void | SetValuesOnIntegrationPoints (const Variable< double > &rVariable, const std::vector< double > &rValues, const ProcessInfo &rCurrentProcessInfo) override |
void | SetValuesOnIntegrationPoints (const Variable< Matrix > &rVariable, const std::vector< Matrix > &rValues, const ProcessInfo &rCurrentProcessInfo) override |
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< double > &rVariable, std::vector< double > &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 | CalculateOnIntegrationPoints (const Variable< Vector > &rVariable, std::vector< Vector > &rOutput, const ProcessInfo &rCurrentProcessInfo) |
virtual void | CalculateOnIntegrationPoints (const Variable< Matrix > &rVariable, std::vector< Matrix > &rOutput, const ProcessInfo &rCurrentProcessInfo) |
virtual void | CalculateOnIntegrationPoints (const Variable< ConstitutiveLaw::Pointer > &rVariable, std::vector< ConstitutiveLaw::Pointer > &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< double > &rVariable, const std::vector< double > &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 | SetValuesOnIntegrationPoints (const Variable< Vector > &rVariable, const std::vector< Vector > &rValues, const ProcessInfo &rCurrentProcessInfo) |
virtual void | SetValuesOnIntegrationPoints (const Variable< Matrix > &rVariable, const std::vector< Matrix > &rValues, const ProcessInfo &rCurrentProcessInfo) |
virtual void | SetValuesOnIntegrationPoints (const Variable< ConstitutiveLaw::Pointer > &rVariable, const std::vector< ConstitutiveLaw::Pointer > &rValues, const ProcessInfo &rCurrentProcessInfo) |
![]() | |
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 | Clone (IndexType NewId, NodesArrayType const &ThisNodes) const |
It creates a new element pointer and clones the previous element data. More... | |
virtual void | CalculateFirstDerivativesContributions (MatrixType &rLeftHandSideMatrix, VectorType &rRightHandSideVector, const ProcessInfo &rCurrentProcessInfo) |
virtual void | CalculateFirstDerivativesLHS (MatrixType &rLeftHandSideMatrix, const ProcessInfo &rCurrentProcessInfo) |
virtual void | CalculateFirstDerivativesRHS (VectorType &rRightHandSideVector, const ProcessInfo &rCurrentProcessInfo) |
virtual void | CalculateSecondDerivativesContributions (MatrixType &rLeftHandSideMatrix, VectorType &rRightHandSideVector, const ProcessInfo &rCurrentProcessInfo) |
virtual void | CalculateSecondDerivativesLHS (MatrixType &rLeftHandSideMatrix, const ProcessInfo &rCurrentProcessInfo) |
virtual void | CalculateSecondDerivativesRHS (VectorType &rRightHandSideVector, const ProcessInfo &rCurrentProcessInfo) |
virtual void | CalculateLumpedMassVector (VectorType &rLumpedMassVector, const ProcessInfo &rCurrentProcessInfo) const |
virtual void | AddExplicitContribution (const ProcessInfo &rCurrentProcessInfo) |
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, 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 | SetValuesOnIntegrationPoints (const Variable< ConstitutiveLaw::Pointer > &rVariable, const std::vector< ConstitutiveLaw::Pointer > &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) | |
![]() | |
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... | |
![]() | |
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... | |
![]() | |
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... | |
![]() | |
KRATOS_CLASS_INTRUSIVE_POINTER_DEFINITION (UPwElement) | |
UPwElement (IndexType NewId=0) | |
Default Constructor. More... | |
UPwElement (IndexType NewId, const NodesArrayType &ThisNodes) | |
Constructor using an array of nodes. More... | |
UPwElement (IndexType NewId, GeometryType::Pointer pGeometry) | |
Constructor using Geometry. More... | |
UPwElement (IndexType NewId, GeometryType::Pointer pGeometry, PropertiesType::Pointer pProperties) | |
Constructor using Properties. More... | |
virtual | ~UPwElement () |
Destructor. More... | |
void | Initialize (const ProcessInfo &rCurrentProcessInfo) override |
void | GetDofList (DofsVectorType &rElementalDofList, const ProcessInfo &rCurrentProcessInfo) const override |
GeometryData::IntegrationMethod | GetIntegrationMethod () const override |
void | CalculateLocalSystem (MatrixType &rLeftHandSideMatrix, VectorType &rRightHandSideVector, const ProcessInfo &rCurrentProcessInfo) override |
void | CalculateLeftHandSide (MatrixType &rLeftHandSideMatrix, const ProcessInfo &rCurrentProcessInfo) override |
void | CalculateRightHandSide (VectorType &rRightHandSideVector, const ProcessInfo &rCurrentProcessInfo) override |
void | EquationIdVector (EquationIdVectorType &rResult, const ProcessInfo &rCurrentProcessInfo) const override |
void | CalculateMassMatrix (MatrixType &rMassMatrix, const ProcessInfo &rCurrentProcessInfo) override |
void | CalculateDampingMatrix (MatrixType &rDampingMatrix, const ProcessInfo &rCurrentProcessInfo) override |
void | GetValuesVector (Vector &rValues, int Step=0) const override |
void | GetFirstDerivativesVector (Vector &rValues, int Step=0) const override |
void | GetSecondDerivativesVector (Vector &rValues, int Step=0) const override |
void | SetValuesOnIntegrationPoints (const Variable< double > &rVariable, const std::vector< double > &rValues, const ProcessInfo &rCurrentProcessInfo) override |
void | SetValuesOnIntegrationPoints (const Variable< Matrix > &rVariable, const std::vector< Matrix > &rValues, const ProcessInfo &rCurrentProcessInfo) override |
void | CalculateOnIntegrationPoints (const Variable< ConstitutiveLaw::Pointer > &rVariable, std::vector< ConstitutiveLaw::Pointer > &rValues, const ProcessInfo &rCurrentProcessInfo) override |
void | AddExplicitContribution (const VectorType &rRHSVector, const Variable< VectorType > &rRHSVariable, const Variable< double > &rDestinationVariable, const ProcessInfo &rCurrentProcessInfo) override |
void | AddExplicitContribution (const VectorType &rRHSVector, const Variable< VectorType > &rRHSVariable, const Variable< array_1d< double, 3 > > &rDestinationVariable, const ProcessInfo &rCurrentProcessInfo) override |
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 vector version) More... | |
void | EquationIdVector (EquationIdVectorType &rResult, const ProcessInfo &rCurrentProcessInfo) const |
void | EquationIdVector (EquationIdVectorType &rResult, const ProcessInfo &rCurrentProcessInfo) const |
void | EquationIdVector (EquationIdVectorType &rResult, const ProcessInfo &rCurrentProcessInfo) const |
void | EquationIdVector (EquationIdVectorType &rResult, const ProcessInfo &rCurrentProcessInfo) const |
void | EquationIdVector (EquationIdVectorType &rResult, const ProcessInfo &rCurrentProcessInfo) const |
Protected Member Functions | |
Protected Operators | |
void | CalculateAll (MatrixType &rLeftHandSideMatrix, VectorType &rRightHandSideVector, const ProcessInfo &rCurrentProcessInfo, const bool CalculateStiffnessMatrixFlag, const bool CalculateResidualVectorFlag) override |
This functions calculates both the RHS and the LHS. More... | |
![]() | |
void | SaveGPStress (Matrix &rStressContainer, const Vector &rStressVector, unsigned int GPoint) |
void | ExtrapolateGPValues (const Matrix &rStressContainer) |
void | CalculateMaterialStiffnessMatrix (MatrixType &rStiffnessMatrix, const ProcessInfo &CurrentProcessInfo) override |
void | CalculateMassMatrix (MatrixType &rMassMatrix, const ProcessInfo &rCurrentProcessInfo) override |
virtual void | InitializeElementVariables (ElementVariables &rVariables, const ProcessInfo &CurrentProcessInfo) |
void | SetConstitutiveParameters (ElementVariables &rVariables, ConstitutiveLaw::Parameters &rConstitutiveParameters) |
void | SetRetentionParameters (const ElementVariables &rVariables, RetentionLaw::Parameters &rRetentionParameters) |
virtual void | CalculateKinematics (ElementVariables &rVariables, unsigned int PointNumber) |
void | InitializeBiotCoefficients (ElementVariables &rVariables, bool hasBiotCoefficient=false) |
void | CalculatePermeabilityUpdateFactor (ElementVariables &rVariables) |
virtual void | CalculateBMatrix (Matrix &rB, const Matrix &GradNpT, const Vector &Np) |
virtual void | CalculateAndAddLHS (MatrixType &rLeftHandSideMatrix, ElementVariables &rVariables) |
void | CalculateAndAddStiffnessMatrix (MatrixType &rLeftHandSideMatrix, ElementVariables &rVariables) |
void | CalculateAndAddCouplingMatrix (MatrixType &rLeftHandSideMatrix, ElementVariables &rVariables) |
virtual void | CalculateAndAddCompressibilityMatrix (MatrixType &rLeftHandSideMatrix, ElementVariables &rVariables) |
virtual void | CalculateCompressibilityMatrix (BoundedMatrix< double, TNumNodes, TNumNodes > &rPMatrix, const ElementVariables &rVariables) const |
virtual void | CalculateAndAddPermeabilityMatrix (MatrixType &rLeftHandSideMatrix, ElementVariables &rVariables) |
virtual void | CalculatePermeabilityMatrix (BoundedMatrix< double, TNumNodes, TDim > &rPDimMatrix, BoundedMatrix< double, TNumNodes, TNumNodes > &rPMatrix, const ElementVariables &rVariables) const |
virtual void | CalculateAndAddRHS (VectorType &rRightHandSideVector, ElementVariables &rVariables, unsigned int GPoint) |
void | CalculateAndAddStiffnessForce (VectorType &rRightHandSideVector, ElementVariables &rVariables, unsigned int GPoint) |
void | CalculateAndAddMixBodyForce (VectorType &rRightHandSideVector, ElementVariables &rVariables) |
void | CalculateAndAddCouplingTerms (VectorType &rRightHandSideVector, ElementVariables &rVariables) |
virtual void | CalculateAndAddCompressibilityFlow (VectorType &rRightHandSideVector, ElementVariables &rVariables) |
virtual void | CalculateCompressibilityFlow (BoundedMatrix< double, TNumNodes, TNumNodes > &rPMatrix, array_1d< double, TNumNodes > &rPVector, const ElementVariables &rVariables) const |
virtual void | CalculateAndAddPermeabilityFlow (VectorType &rRightHandSideVector, ElementVariables &rVariables) |
virtual void | CalculatePermeabilityFlow (BoundedMatrix< double, TNumNodes, TDim > &rPDimMatrix, BoundedMatrix< double, TNumNodes, TNumNodes > &rPMatrix, array_1d< double, TNumNodes > &rPVector, const ElementVariables &rVariables) const |
virtual void | CalculateAndAddFluidBodyFlow (VectorType &rRightHandSideVector, ElementVariables &rVariables) |
virtual void | CalculateFluidBodyFlow (BoundedMatrix< double, TNumNodes, TDim > &rPDimMatrix, array_1d< double, TNumNodes > &rPVector, const ElementVariables &rVariables) const |
double | CalculateBulkModulus (const Matrix &ConstitutiveMatrix) const |
double | CalculateBiotCoefficient (const ElementVariables &rVariables, bool hasBiotCoefficient) const |
virtual void | CalculateCauchyAlmansiStrain (ElementVariables &rVariables) |
virtual void | CalculateCauchyGreenStrain (ElementVariables &rVariables) |
virtual void | CalculateCauchyStrain (ElementVariables &rVariables) |
virtual void | CalculateStrain (ElementVariables &rVariables, unsigned int GPoint) |
virtual void | CalculateDeformationGradient (ElementVariables &rVariables, unsigned int GPoint) |
void | InitializeNodalDisplacementVariables (ElementVariables &rVariables) |
void | InitializeNodalPorePressureVariables (ElementVariables &rVariables) |
void | InitializeNodalVolumeAccelerationVariables (ElementVariables &rVariables) |
void | InitializeProperties (ElementVariables &rVariables) |
double | CalculateFluidPressure (const ElementVariables &rVariables) |
void | CalculateRetentionResponse (ElementVariables &rVariables, RetentionLaw::Parameters &rRetentionParameters, unsigned int GPoint) |
void | CalculateExtrapolationMatrix (BoundedMatrix< double, TNumNodes, TNumNodes > &rExtrapolationMatrix) |
void | ResetHydraulicDischarge () |
void | CalculateHydraulicDischarge (const ProcessInfo &rCurrentProcessInfo) |
void | CalculateSoilGamma (ElementVariables &rVariables) |
virtual void | CalculateSoilDensity (ElementVariables &rVariables) |
virtual void | CalculateAndAddGeometricStiffnessMatrix (MatrixType &rLeftHandSideMatrix, ElementVariables &rVariables, unsigned int GPoint) |
void | SaveGPGradPressure (Matrix &rGradPressureContainer, const array_1d< double, TDim > &GradPressure, const unsigned int &GPoint) |
Member Variables. More... | |
void | SaveGPStress (Matrix &rStressContainer, const Vector &StressVector, const unsigned int &VoigtSize, const unsigned int &GPoint) |
void | ExtrapolateGPValues (const Matrix &GradPressureContainer, const Matrix &StressContainer, const unsigned int &VoigtSize) |
void | CalculateStiffnessMatrix (MatrixType &rStiffnessMatrix, const ProcessInfo &CurrentProcessInfo) override |
The vector containing the imposed z strains (for 2.5D element: 2D geom with 3D CL) More... | |
void | CalculateAll (MatrixType &rLeftHandSideMatrix, VectorType &rRightHandSideVector, const ProcessInfo &CurrentProcessInfo) override |
void | CalculateRHS (VectorType &rRightHandSideVector, const ProcessInfo &CurrentProcessInfo) override |
void | InitializeElementVariables (ElementVariables &rVariables, ConstitutiveLaw::Parameters &rConstitutiveParameters, const GeometryType &Geom, const PropertiesType &Prop, const ProcessInfo &CurrentProcessInfo) |
void | CalculateBMatrix (Matrix &rB, const Matrix &GradNpT) |
void | CalculateKinematics (Matrix &rGradNpT, Matrix &rB, Vector &rStrainVector, const GeometryType::ShapeFunctionsGradientsType &DN_DXContainer, const array_1d< double, TNumNodes *TDim > &DisplacementVector, const unsigned int &GPoint) |
void | CalculateAndAddLHS (MatrixType &rLeftHandSideMatrix, ElementVariables &rVariables) |
void | CalculateAndAddStiffnessMatrix (MatrixType &rLeftHandSideMatrix, ElementVariables &rVariables) |
void | CalculateAndAddCouplingMatrix (MatrixType &rLeftHandSideMatrix, ElementVariables &rVariables) |
void | CalculateAndAddCompressibilityMatrix (MatrixType &rLeftHandSideMatrix, ElementVariables &rVariables) |
void | CalculateAndAddPermeabilityMatrix (MatrixType &rLeftHandSideMatrix, ElementVariables &rVariables) |
void | CalculateAndAddRHS (VectorType &rRightHandSideVector, ElementVariables &rVariables) |
void | CalculateAndAddStiffnessForce (VectorType &rRightHandSideVector, ElementVariables &rVariables) |
void | CalculateAndAddMixBodyForce (VectorType &rRightHandSideVector, ElementVariables &rVariables) |
void | CalculateAndAddCouplingTerms (VectorType &rRightHandSideVector, ElementVariables &rVariables) |
void | CalculateAndAddCompressibilityFlow (VectorType &rRightHandSideVector, ElementVariables &rVariables) |
void | CalculateAndAddPermeabilityFlow (VectorType &rRightHandSideVector, ElementVariables &rVariables) |
void | CalculateAndAddFluidBodyFlow (VectorType &rRightHandSideVector, ElementVariables &rVariables) |
void | CalculateFluxResidual (VectorType &rRightHandSideVector, const ProcessInfo &rCurrentProcessInfo) override |
void | CalculateMixBodyForce (VectorType &rRightHandSideVector, const ProcessInfo &rCurrentProcessInfo) override |
void | CalculateNegInternalForce (VectorType &rRightHandSideVector, const ProcessInfo &rCurrentProcessInfo) override |
void | CalculateExplicitContributions (VectorType &rFluxResidual, VectorType &rBodyForce, VectorType &rNegInternalForces, const ProcessInfo &rCurrentProcessInfo) override |
void | CalculateExtrapolationMatrix (BoundedMatrix< double, 3, 3 > &rExtrapolationMatrix) |
void | CalculateExtrapolationMatrix (BoundedMatrix< double, 4, 4 > &rExtrapolationMatrix) |
void | CalculateExtrapolationMatrix (BoundedMatrix< double, 4, 4 > &rExtrapolationMatrix) |
void | CalculateExtrapolationMatrix (BoundedMatrix< double, 8, 8 > &rExtrapolationMatrix) |
void | ExtrapolateGPValues (const Matrix &GradPressureContainer, const Matrix &StressContainer, const unsigned int &VoigtSize) |
void | ExtrapolateGPValues (const Matrix &GradPressureContainer, const Matrix &StressContainer, const unsigned int &VoigtSize) |
void | ExtrapolateGPValues (const Matrix &GradPressureContainer, const Matrix &StressContainer, const unsigned int &VoigtSize) |
void | ExtrapolateGPValues (const Matrix &GradPressureContainer, const Matrix &StressContainer, const unsigned int &VoigtSize) |
void | CalculateBMatrix (Matrix &rB, const Matrix &GradNpT) |
void | CalculateBMatrix (Matrix &rB, const Matrix &GradNpT) |
void | CalculateBMatrix (Matrix &rB, const Matrix &GradNpT) |
void | CalculateBMatrix (Matrix &rB, const Matrix &GradNpT) |
![]() | |
virtual double | CalculateIntegrationCoefficient (const GeometryType::IntegrationPointsArrayType &IntegrationPoints, unsigned int PointNumber, double detJ) |
void | CalculateDerivativesOnInitialConfiguration (double &detJ, Matrix &J0, Matrix &InvJ0, Matrix &DN_DX, unsigned int PointNumber) const |
void | CalculateJacobianOnCurrentConfiguration (double &detJ, Matrix &rJ, Matrix &rInvJ, unsigned int GPoint) const |
void | CalculateJacobianOnCurrentConfiguration (double &detJ, Matrix &J0, Matrix &InvJ0, Matrix &DN_DX, unsigned int PointNumber) const |
This functions calculate the derivatives in the reference frame. More... | |
double | CalculateDerivativesOnCurrentConfiguration (Matrix &rJ, Matrix &rInvJ, Matrix &rDN_DX, const IndexType &PointNumber, IntegrationMethod ThisIntegrationMethod) const |
This functions calculate the derivatives in the current frame. More... | |
virtual unsigned int | GetNumberOfDOF () const |
![]() | |
void | CalculateIntegrationCoefficient (double &rIntegrationCoefficient, const double &detJ, const double &weight) |
virtual void | CalculateLumpedMassMatrix (MatrixType &rLeftHandSideMatrix, const ProcessInfo &rCurrentProcessInfo) |
virtual void | CalculateDampingMatrixWithLumpedMass (MatrixType &rLeftHandSideMatrix, const ProcessInfo &rCurrentProcessInfo) |
virtual void | CalculateInertialForce (VectorType &rRightHandSideVector, const ProcessInfo &rCurrentProcessInfo) |
virtual void | CalculateDampingForce (VectorType &rRightHandSideVector, const ProcessInfo &rCurrentProcessInfo) |
void | CalculateIntegrationCoefficient (double &rIntegrationCoefficient, const double &detJ, const double &weight) |
void | CalculateIntegrationCoefficient (double &rIntegrationCoefficient, const double &detJ, const double &weight) |
void | CalculateIntegrationCoefficient (double &rIntegrationCoefficient, const double &detJ, const double &weight) |
void | CalculateIntegrationCoefficient (double &rIntegrationCoefficient, const double &detJ, const double &weight) |
void | CalculateIntegrationCoefficient (double &rIntegrationCoefficient, const double &detJ, const double &weight) |
Type Definitions | |
using | IndexType = std::size_t |
using | PropertiesType = Properties |
using | NodeType = Node |
using | GeometryType = Geometry< NodeType > |
using | NodesArrayType = GeometryType::PointsArrayType |
using | VectorType = Vector |
using | MatrixType = Matrix |
using | IntegrationMethod = GeometryData::IntegrationMethod |
Type definition for integration methods. More... | |
using | SizeType = std::size_t |
The definition of the sizetype. More... | |
using | ElementVariables = typename UPwSmallStrainElement< TDim, TNumNodes >::ElementVariables |
KRATOS_CLASS_INTRUSIVE_POINTER_DEFINITION (UPwUpdatedLagrangianElement) | |
Counted pointer of UPwUpdatedLagrangianElement. More... | |
UPwUpdatedLagrangianElement (IndexType NewId=0) | |
Default Constructor. More... | |
UPwUpdatedLagrangianElement (IndexType NewId, const NodesArrayType &ThisNodes) | |
Constructor using an array of nodes. More... | |
UPwUpdatedLagrangianElement (IndexType NewId, GeometryType::Pointer pGeometry) | |
Constructor using Geometry. More... | |
UPwUpdatedLagrangianElement (IndexType NewId, GeometryType::Pointer pGeometry, PropertiesType::Pointer pProperties) | |
Constructor using Properties. More... | |
~UPwUpdatedLagrangianElement () override | |
Destructor. More... | |
int | Check (const ProcessInfo &rCurrentProcessInfo) const override |
Element::Pointer | Create (IndexType NewId, GeometryType::Pointer pGeom, PropertiesType::Pointer pProperties) const override |
Creates a new element. More... | |
Element::Pointer | Create (IndexType NewId, NodesArrayType const &ThisNodes, PropertiesType::Pointer pProperties) const override |
Creates a new element. More... | |
void | CalculateOnIntegrationPoints (const Variable< double > &rVariable, std::vector< double > &rOutput, const ProcessInfo &rCurrentProcessInfo) override |
Calculate a double Variable on the Element Constitutive Law. More... | |
void | CalculateOnIntegrationPoints (const Variable< Matrix > &rVariable, std::vector< Matrix > &rOutput, const ProcessInfo &rCurrentProcessInfo) override |
Calculate a Matrix Variable on the Element Constitutive Law. More... | |
Serialization | |
class | Serializer |
Additional Inherited Members | |
![]() | |
using | IndexType = std::size_t |
using | PropertiesType = Properties |
using | NodeType = Node |
using | GeometryType = Geometry< NodeType > |
using | NodesArrayType = GeometryType::PointsArrayType |
using | VectorType = Vector |
using | MatrixType = Matrix |
using | SizeType = std::size_t |
The definition of the sizetype. More... | |
typedef std::size_t | IndexType |
typedef Properties | PropertiesType |
typedef Node | NodeType |
typedef Geometry< NodeType > | GeometryType |
typedef Geometry< NodeType >::PointsArrayType | NodesArrayType |
typedef Vector | VectorType |
typedef Matrix | MatrixType |
![]() | |
using | SizeType = std::size_t |
![]() | |
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 |
![]() | |
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... | |
![]() | |
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... | |
![]() | |
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 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 const Flags | AllDefined () |
static const Flags | AllTrue () |
static Flags | Create (IndexType ThisPosition, bool Value=true) |
![]() | |
GeometryData::IntegrationMethod | mThisIntegrationMethod |
Member Variables. More... | |
std::vector< ConstitutiveLaw::Pointer > | mConstitutiveLawVector |
std::vector< RetentionLaw::Pointer > | mRetentionLawVector |
std::vector< Vector > | mStressVector |
std::vector< Vector > | mStateVariablesFinalized |
bool | mIsInitialised = false |
![]() | |
GeometryData::IntegrationMethod | mThisIntegrationMethod |
Member Variables. More... | |
std::vector< ConstitutiveLaw::Pointer > | mConstitutiveLawVector |
Matrix | mIntrinsicPermeability |
std::vector< double > | mImposedZStrainVector |
![]() | |
static constexpr SizeType | VoigtSize = (TDim == N_DIM_3D ? VOIGT_SIZE_3D : VOIGT_SIZE_2D_PLANE_STRAIN) |
static constexpr SizeType | StressTensorSize |
Updated Lagrangian element for 2D and 3D geometries.
Implements an Updated Lagrangian definition for U-P elements. This works for arbitrary geometries in 2D and 3D
using Kratos::UPwUpdatedLagrangianElement< TDim, TNumNodes >::ElementVariables = typename UPwSmallStrainElement<TDim, TNumNodes>::ElementVariables |
using Kratos::UPwUpdatedLagrangianElement< TDim, TNumNodes >::GeometryType = Geometry<NodeType> |
using Kratos::UPwUpdatedLagrangianElement< TDim, TNumNodes >::IndexType = std::size_t |
using Kratos::UPwUpdatedLagrangianElement< TDim, TNumNodes >::IntegrationMethod = GeometryData::IntegrationMethod |
Type definition for integration methods.
using Kratos::UPwUpdatedLagrangianElement< TDim, TNumNodes >::MatrixType = Matrix |
using Kratos::UPwUpdatedLagrangianElement< TDim, TNumNodes >::NodesArrayType = GeometryType::PointsArrayType |
using Kratos::UPwUpdatedLagrangianElement< TDim, TNumNodes >::NodeType = Node |
using Kratos::UPwUpdatedLagrangianElement< TDim, TNumNodes >::PropertiesType = Properties |
using Kratos::UPwUpdatedLagrangianElement< TDim, TNumNodes >::SizeType = std::size_t |
The definition of the sizetype.
using Kratos::UPwUpdatedLagrangianElement< TDim, TNumNodes >::VectorType = Vector |
|
inline |
Default Constructor.
|
inline |
Constructor using an array of nodes.
|
inline |
Constructor using Geometry.
|
inline |
Constructor using Properties.
|
inlineoverride |
Destructor.
|
overrideprotectedvirtual |
This functions calculates both the RHS and the LHS.
rLeftHandSideMatrix | The LHS |
rRightHandSideVector | The RHS |
rCurrentProcessInfo | The current process info instance |
CalculateStiffnessMatrixFlag | The flag to set if compute the LHS |
CalculateResidualVectorFlag | The flag to set if compute the RHS |
Reimplemented from Kratos::UPwSmallStrainElement< TDim, TNumNodes >.
|
overridevirtual |
Calculate a double Variable on the Element Constitutive Law.
rVariable | The variable we want to get |
rOutput | The values obtained int the integration points |
rCurrentProcessInfo | The current process info instance |
Reimplemented from Kratos::UPwSmallStrainElement< TDim, TNumNodes >.
|
overridevirtual |
Calculate a Matrix Variable on the Element Constitutive Law.
rVariable | The variable we want to get |
rOutput | The values obtained int the integration points |
rCurrentProcessInfo | The current process info instance |
Reimplemented from Kratos::UPwSmallStrainElement< TDim, TNumNodes >.
|
overridevirtual |
This method provides the place to perform checks on the completeness of the input and the compatibility with the problem options as well as the contitutive laws selected 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 | this method is: MANDATORY |
Reimplemented from Kratos::UPwSmallStrainElement< TDim, TNumNodes >.
|
overridevirtual |
Creates a new element.
NewId | The Id of the new created element |
pGeom | The pointer to the geometry of the element |
pProperties | The pointer to property |
Reimplemented from Kratos::UPwSmallStrainElement< TDim, TNumNodes >.
Reimplemented in Kratos::UPwUpdatedLagrangianAxisymmetricElement< TDim, TNumNodes >, Kratos::UPwUpdatedLagrangianAxisymmetricElement< 2, 3 >, Kratos::UPwUpdatedLagrangianAxisymmetricElement< 2, 9 >, Kratos::UPwUpdatedLagrangianAxisymmetricElement< 2, 8 >, Kratos::UPwUpdatedLagrangianAxisymmetricElement< 2, 6 >, Kratos::UPwUpdatedLagrangianAxisymmetricElement< 2, 15 >, Kratos::UPwUpdatedLagrangianAxisymmetricElement< 2, 10 >, and Kratos::UPwUpdatedLagrangianAxisymmetricElement< 2, 4 >.
|
overridevirtual |
Creates a new element.
NewId | The Id of the new created element |
ThisNodes | The array containing nodes |
pProperties | The pointer to property |
Reimplemented from Kratos::UPwSmallStrainElement< TDim, TNumNodes >.
Reimplemented in Kratos::UPwUpdatedLagrangianAxisymmetricElement< TDim, TNumNodes >, Kratos::UPwUpdatedLagrangianAxisymmetricElement< 2, 3 >, Kratos::UPwUpdatedLagrangianAxisymmetricElement< 2, 9 >, Kratos::UPwUpdatedLagrangianAxisymmetricElement< 2, 8 >, Kratos::UPwUpdatedLagrangianAxisymmetricElement< 2, 6 >, Kratos::UPwUpdatedLagrangianAxisymmetricElement< 2, 15 >, Kratos::UPwUpdatedLagrangianAxisymmetricElement< 2, 10 >, and Kratos::UPwUpdatedLagrangianAxisymmetricElement< 2, 4 >.
|
inlineoverridevirtual |
Turn back information as a string.
Reimplemented from Kratos::UPwSmallStrainElement< TDim, TNumNodes >.
Reimplemented in Kratos::UPwUpdatedLagrangianAxisymmetricElement< TDim, TNumNodes >, Kratos::UPwUpdatedLagrangianAxisymmetricElement< 2, 3 >, Kratos::UPwUpdatedLagrangianAxisymmetricElement< 2, 9 >, Kratos::UPwUpdatedLagrangianAxisymmetricElement< 2, 8 >, Kratos::UPwUpdatedLagrangianAxisymmetricElement< 2, 6 >, Kratos::UPwUpdatedLagrangianAxisymmetricElement< 2, 15 >, Kratos::UPwUpdatedLagrangianAxisymmetricElement< 2, 10 >, and Kratos::UPwUpdatedLagrangianAxisymmetricElement< 2, 4 >.
Kratos::UPwUpdatedLagrangianElement< TDim, TNumNodes >::KRATOS_CLASS_INTRUSIVE_POINTER_DEFINITION | ( | UPwUpdatedLagrangianElement< TDim, TNumNodes > | ) |
Counted pointer of UPwUpdatedLagrangianElement.
|
inlineoverridevirtual |
Print object's data.
Reimplemented from Kratos::Element.
|
inlineoverridevirtual |
Print information about this object.
Reimplemented from Kratos::UPwSmallStrainElement< TDim, TNumNodes >.
Reimplemented in Kratos::UPwUpdatedLagrangianAxisymmetricElement< TDim, TNumNodes >, Kratos::UPwUpdatedLagrangianAxisymmetricElement< 2, 3 >, Kratos::UPwUpdatedLagrangianAxisymmetricElement< 2, 9 >, Kratos::UPwUpdatedLagrangianAxisymmetricElement< 2, 8 >, Kratos::UPwUpdatedLagrangianAxisymmetricElement< 2, 6 >, Kratos::UPwUpdatedLagrangianAxisymmetricElement< 2, 15 >, Kratos::UPwUpdatedLagrangianAxisymmetricElement< 2, 10 >, and Kratos::UPwUpdatedLagrangianAxisymmetricElement< 2, 4 >.
|
friend |