![]() |
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.
|
MPCMortarContactCondition. More...
#include <mpc_mortar_contact_condition.h>
Public Member Functions | |
Life Cycle | |
MPCMortarContactCondition () | |
Default constructor. More... | |
MPCMortarContactCondition (IndexType NewId, GeometryType::Pointer pGeometry) | |
MPCMortarContactCondition (IndexType NewId, GeometryType::Pointer pGeometry, PropertiesType::Pointer pProperties) | |
MPCMortarContactCondition (IndexType NewId, GeometryType::Pointer pGeometry, PropertiesType::Pointer pProperties, GeometryType::Pointer pMasterGeometry) | |
MPCMortarContactCondition (MPCMortarContactCondition const &rOther) | |
Copy constructor. More... | |
~MPCMortarContactCondition () override | |
Destructor. More... | |
Operations | |
Condition::Pointer | Create (IndexType NewId, NodesArrayType const &rThisNodes, PropertiesType::Pointer pProperties) const override |
Creates a new element pointer from an arry of nodes. More... | |
Condition::Pointer | Create (IndexType NewId, GeometryType::Pointer pGeom, PropertiesType::Pointer pProperties) const override |
Creates a new element pointer from an existing geometry. More... | |
Condition::Pointer | Create (IndexType NewId, GeometryType::Pointer pGeom, PropertiesType::Pointer pProperties, GeometryType::Pointer pMasterGeom) const override |
Creates a new element pointer from an existing geometry. More... | |
void | Initialize (const ProcessInfo &rCurrentProcessInfo) override |
Called at the beginning of each solution step. More... | |
void | InitializeSolutionStep (const ProcessInfo &rCurrentProcessInfo) override |
Called at the beginning of each solution step. More... | |
void | InitializeNonLinearIteration (const ProcessInfo &rCurrentProcessInfo) override |
Called at the beginning of each iteration. More... | |
void | FinalizeSolutionStep (const ProcessInfo &rCurrentProcessInfo) override |
Called at the ending of each solution step. More... | |
void | FinalizeNonLinearIteration (const ProcessInfo &rCurrentProcessInfo) override |
Called at the end of each iteration. More... | |
void | EquationIdVector (EquationIdVectorType &rResult, const ProcessInfo &rCurrentProcessInfo) const override |
Sets on rResult the ID's of the element degrees of freedom. More... | |
void | GetDofList (DofsVectorType &rConditionalDofList, const ProcessInfo &rCurrentProcessInfo) const override |
Sets on ConditionalDofList the degrees of freedom of the considered element geometry. More... | |
void | CalculateMassMatrix (MatrixType &rMassMatrix, const ProcessInfo &rCurrentProcessInfo) override |
This method computes the mass matrix. More... | |
void | CalculateDampingMatrix (MatrixType &rDampingMatrix, const ProcessInfo &rCurrentProcessInfo) override |
Initialize Damping Matrix. More... | |
void | AddExplicitContribution (const ProcessInfo &rCurrentProcessInfo) override |
This is called during the assembling process in order to calculate the condition contribution in explicit calculation. NodalData is modified Inside the function, so the. More... | |
void | CalculateOnIntegrationPoints (const Variable< double > &rVariable, std::vector< double > &rOutput, const ProcessInfo &rCurrentProcessInfo) override |
Calculate a double Variable. More... | |
void | CalculateOnIntegrationPoints (const Variable< array_1d< double, 3 > > &rVariable, std::vector< array_1d< double, 3 > > &rOutput, const ProcessInfo &rCurrentProcessInfo) override |
Calculate a array_1d Variable. More... | |
void | CalculateOnIntegrationPoints (const Variable< Vector > &rVariable, std::vector< Vector > &rOutput, const ProcessInfo &rCurrentProcessInfo) override |
Calculate a Vector Variable. More... | |
int | Check (const ProcessInfo &rCurrentProcessInfo) const override |
This function provides the place to perform checks on the completeness of the input. More... | |
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... | |
![]() | |
PairedCondition () | |
Default constructor. More... | |
PairedCondition (IndexType NewId, GeometryType::Pointer pGeometry) | |
PairedCondition (IndexType NewId, GeometryType::Pointer pGeometry, PropertiesType::Pointer pProperties) | |
PairedCondition (IndexType NewId, GeometryType::Pointer pGeometry, PropertiesType::Pointer pProperties, GeometryType::Pointer pPairedGeometry) | |
PairedCondition (PairedCondition const &rOther) | |
Copy constructor. More... | |
~PairedCondition () override | |
Destructor. More... | |
void | Initialize (const ProcessInfo &rCurrentProcessInfo) override |
Called at the beginning of each solution step. More... | |
void | InitializeSolutionStep (const ProcessInfo &rCurrentProcessInfo) override |
Called at the beginning of each solution step. More... | |
void | InitializeNonLinearIteration (const ProcessInfo &rCurrentProcessInfo) override |
Called at the beginning of each iteration. More... | |
Condition::Pointer | Create (IndexType NewId, NodesArrayType const &rThisNodes, PropertiesType::Pointer pProperties) const override |
Creates a new element pointer from an arry of nodes. More... | |
Condition::Pointer | Create (IndexType NewId, GeometryType::Pointer pGeometry, PropertiesType::Pointer pProperties) const override |
Creates a new element pointer from an existing geometry. More... | |
GeometryType::Pointer | pGetParentGeometry () |
This method returns the parent geometry. More... | |
GeometryType::Pointer const | pGetParentGeometry () const |
This method returns the parent geometry (constant version) More... | |
GeometryType::Pointer | pGetPairedGeometry () |
This method returns the paired geometry. More... | |
GeometryType::Pointer const | pGetPairedGeometry () const |
This method returns the paired geometry (constant version) More... | |
GeometryType & | GetParentGeometry () |
This method returns the parent geometry. More... | |
GeometryType const & | GetParentGeometry () const |
This method returns the parent geometry (constant version) More... | |
GeometryType & | GetPairedGeometry () |
This method returns the paired geometry. More... | |
GeometryType const & | GetPairedGeometry () const |
This method returns the paired geometry (constant version) More... | |
void | SetPairedNormal (const array_1d< double, 3 > &rPairedNormal) |
This method sets the paired normal. More... | |
array_1d< double, 3 > const & | GetPairedNormal () const |
This method returns the paired normal. 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... | |
KRATOS_CLASS_INTRUSIVE_POINTER_DEFINITION (PairedCondition) | |
Counted pointer of PairedCondition. More... | |
![]() | |
Condition (IndexType NewId=0) | |
Condition (IndexType NewId, const NodesArrayType &ThisNodes) | |
Condition (IndexType NewId, GeometryType::Pointer pGeometry) | |
Condition (IndexType NewId, GeometryType::Pointer pGeometry, PropertiesType::Pointer pProperties) | |
Condition (Condition const &rOther) | |
Copy constructor. More... | |
~Condition () override | |
Destructor. More... | |
Condition & | operator= (Condition const &rOther) |
Assignment operator. More... | |
virtual Pointer | Clone (IndexType NewId, NodesArrayType const &ThisNodes) const |
It creates a new condition pointer and clones the previous condition data. More... | |
virtual void | GetValuesVector (Vector &values, int Step=0) const |
virtual void | GetFirstDerivativesVector (Vector &values, int Step=0) const |
virtual void | GetSecondDerivativesVector (Vector &values, int Step=0) const |
virtual void | ResetConstitutiveLaw () |
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 | AddExplicitContribution (const VectorType &rRHSVector, const Variable< VectorType > &rRHSVariable, const Variable< double > &rDestinationVariable, const ProcessInfo &rCurrentProcessInfo) |
This function is designed to make the condition 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 VectorType &rRHSVector, const Variable< VectorType > &rRHSVariable, const Variable< array_1d< double, 3 > > &rDestinationVariable, const ProcessInfo &rCurrentProcessInfo) |
This function is designed to make the condition 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... | |
virtual void | AddExplicitContribution (const MatrixType &rLHSMatrix, const Variable< MatrixType > &rLHSVariable, const Variable< Matrix > &rDestinationVariable, const ProcessInfo &rCurrentProcessInfo) |
This function is designed to make the condition 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 | CalculateOnIntegrationPoints (const Variable< Matrix > &rVariable, std::vector< Matrix > &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 | 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 condition. Does not throw an error, to allow copying of conditions 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 Condition 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 (Condition) | |
Pointer definition of Condition. More... | |
![]() | |
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... | |
Protected Member Functions | |
Protected Operations | |
void | CalculateLocalSystem (MatrixType &rLeftHandSideMatrix, VectorType &rRightHandSideVector, const ProcessInfo &rCurrentProcessInfo) override |
This is called during the assembling process in order to calculate all condition contributions to the global system matrix and the right hand side. More... | |
void | CalculateRightHandSide (VectorType &rRightHandSideVector, const ProcessInfo &rCurrentProcessInfo) override |
This is called during the assembling process in order to calculate the condition right hand side vector only. More... | |
void | CalculateLeftHandSide (MatrixType &rLeftHandSideMatrix, const ProcessInfo &rCurrentProcessInfo) override |
This is called during the assembling process in order to calculate the condition left hand side matrix only. More... | |
IntegrationMethod | GetIntegrationMethod () const override |
It returns theintegration method considered. More... | |
Protected Attributes | |
Protected member Variables | |
bool | mPreviousMortarOperatorsInitialized = false |
MortarConditionMatrices | mPreviousMortarOperators |
In order to know iw we need to initialize the previous operators. More... | |
Type Definitions | |
using | BaseType = PairedCondition |
Base class definitions. More... | |
using | VectorType = typename BaseType::VectorType |
Vector type definition. More... | |
using | MatrixType = typename BaseType::MatrixType |
Matrix type definition. More... | |
using | IndexType = typename BaseType::IndexType |
Index type definition. More... | |
using | GeometryPointerType = typename BaseType::GeometryType::Pointer |
Geometry pointer definition. More... | |
using | NodesArrayType = typename BaseType::NodesArrayType |
Nodes array type definition. More... | |
using | PropertiesPointerType = typename BaseType::PropertiesType::Pointer |
Properties pointer definition. More... | |
using | PointType = Point |
Point definition. More... | |
using | ConditionArrayType = array_1d< Point, TDim > |
Array type for condition with points. More... | |
using | ConditionArrayListType = typename std::vector< ConditionArrayType > |
Type definition for a list of condition arrays. More... | |
using | GeometryType = Geometry< Node > |
Geometry type definition. More... | |
using | IntegrationPointsType = typename GeometryType::IntegrationPointsArrayType |
using | LineType = Line2D2< PointType > |
Line type definition. More... | |
using | TriangleType = Triangle3D3< PointType > |
Triangle type definition. More... | |
using | DecompositionType = typename std::conditional< TDim==2, LineType, TriangleType >::type |
Type definition for decomposition based on dimension. More... | |
using | GeneralVariables = MortarKinematicVariables< TNumNodes, TNumNodesMaster > |
Type definition for general variables. More... | |
using | AeData = DualLagrangeMultiplierOperators< TNumNodes, TNumNodesMaster > |
Type definition for AE data. More... | |
using | MortarConditionMatrices = MortarOperator< TNumNodes, TNumNodesMaster > |
Type definition for mortar condition matrices. More... | |
using | IntegrationUtility = ExactMortarIntegrationUtility< TDim, TNumNodes, false, TNumNodesMaster > |
Type definition for integration utility. More... | |
using | DerivativesUtilitiesType = DerivativesUtilities< TDim, TNumNodes, false, false, TNumNodesMaster > |
Type definition for derivatives utilities. More... | |
static constexpr IndexType | MatrixSize = TDim * (TNumNodes + TNumNodesMaster) |
Constant expression for matrix size. More... | |
KRATOS_CLASS_INTRUSIVE_POINTER_DEFINITION (MPCMortarContactCondition) | |
Counted pointer of MPCMortarContactCondition. More... | |
Un accessible methods | |
class | Serializer |
Additional Inherited Members | |
![]() | |
using | BaseType = Condition |
Basetype definition. More... | |
using | PointType = Point |
Point type definition. More... | |
using | GeometryType = Geometry< Node > |
Geometry type definition. More... | |
using | CouplingGeometryType = CouplingGeometry< Node > |
Coupling geometry type definition. More... | |
using | VectorType = BaseType::VectorType |
Vector type definition. More... | |
using | MatrixType = BaseType::MatrixType |
Matrix type definition. More... | |
using | IndexType = BaseType::IndexType |
Index type definition. More... | |
using | GeometryPointerType = BaseType::GeometryType::Pointer |
Geometry pointer type definition. More... | |
using | NodesArrayType = BaseType::NodesArrayType |
Nodes array type definition. More... | |
using | PropertiesPointerType = BaseType::PropertiesType::Pointer |
Properties pointer type definition. More... | |
![]() | |
typedef Condition | ConditionType |
definition of condition 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) |
This is a contact condition which employes the mortar method with dual lagrange multiplier in a explicit manner in order to compute the gap/slip and the weights
TDim | The dimension of work |
TNumNodes | The number of nodes of the slave |
TNumNodesMaster | The number of nodes of the master |
using Kratos::MPCMortarContactCondition< TDim, TNumNodes, TNumNodesMaster >::AeData = DualLagrangeMultiplierOperators<TNumNodes, TNumNodesMaster> |
Type definition for AE data.
using Kratos::MPCMortarContactCondition< TDim, TNumNodes, TNumNodesMaster >::BaseType = PairedCondition |
Base class definitions.
using Kratos::MPCMortarContactCondition< TDim, TNumNodes, TNumNodesMaster >::ConditionArrayListType = typename std::vector<ConditionArrayType> |
Type definition for a list of condition arrays.
using Kratos::MPCMortarContactCondition< TDim, TNumNodes, TNumNodesMaster >::ConditionArrayType = array_1d<Point, TDim> |
Array type for condition with points.
using Kratos::MPCMortarContactCondition< TDim, TNumNodes, TNumNodesMaster >::DecompositionType = typename std::conditional<TDim == 2, LineType, TriangleType>::type |
Type definition for decomposition based on dimension.
using Kratos::MPCMortarContactCondition< TDim, TNumNodes, TNumNodesMaster >::DerivativesUtilitiesType = DerivativesUtilities<TDim, TNumNodes, false, false, TNumNodesMaster> |
Type definition for derivatives utilities.
using Kratos::MPCMortarContactCondition< TDim, TNumNodes, TNumNodesMaster >::GeneralVariables = MortarKinematicVariables<TNumNodes, TNumNodesMaster> |
Type definition for general variables.
using Kratos::MPCMortarContactCondition< TDim, TNumNodes, TNumNodesMaster >::GeometryPointerType = typename BaseType::GeometryType::Pointer |
Geometry pointer definition.
using Kratos::MPCMortarContactCondition< TDim, TNumNodes, TNumNodesMaster >::GeometryType = Geometry<Node> |
Geometry type definition.
using Kratos::MPCMortarContactCondition< TDim, TNumNodes, TNumNodesMaster >::IndexType = typename BaseType::IndexType |
Index type definition.
using Kratos::MPCMortarContactCondition< TDim, TNumNodes, TNumNodesMaster >::IntegrationPointsType = typename GeometryType::IntegrationPointsArrayType |
using Kratos::MPCMortarContactCondition< TDim, TNumNodes, TNumNodesMaster >::IntegrationUtility = ExactMortarIntegrationUtility<TDim, TNumNodes, false, TNumNodesMaster> |
Type definition for integration utility.
using Kratos::MPCMortarContactCondition< TDim, TNumNodes, TNumNodesMaster >::LineType = Line2D2<PointType> |
Line type definition.
using Kratos::MPCMortarContactCondition< TDim, TNumNodes, TNumNodesMaster >::MatrixType = typename BaseType::MatrixType |
Matrix type definition.
using Kratos::MPCMortarContactCondition< TDim, TNumNodes, TNumNodesMaster >::MortarConditionMatrices = MortarOperator<TNumNodes, TNumNodesMaster> |
Type definition for mortar condition matrices.
using Kratos::MPCMortarContactCondition< TDim, TNumNodes, TNumNodesMaster >::NodesArrayType = typename BaseType::NodesArrayType |
Nodes array type definition.
using Kratos::MPCMortarContactCondition< TDim, TNumNodes, TNumNodesMaster >::PointType = Point |
Point definition.
using Kratos::MPCMortarContactCondition< TDim, TNumNodes, TNumNodesMaster >::PropertiesPointerType = typename BaseType::PropertiesType::Pointer |
Properties pointer definition.
using Kratos::MPCMortarContactCondition< TDim, TNumNodes, TNumNodesMaster >::TriangleType = Triangle3D3<PointType> |
Triangle type definition.
using Kratos::MPCMortarContactCondition< TDim, TNumNodes, TNumNodesMaster >::VectorType = typename BaseType::VectorType |
Vector type definition.
|
inline |
Default constructor.
|
inline |
|
inline |
|
inline |
|
inline |
Copy constructor.
|
overridedefault |
Destructor.
|
overridevirtual |
This is called during the assembling process in order to calculate the condition contribution in explicit calculation. NodalData is modified Inside the function, so the.
The "AddEXplicit" FUNCTIONS THE ONLY FUNCTIONS IN WHICH A CONDITION IS ALLOWED TO WRITE ON ITS NODES. The caller is expected to ensure thread safety hence SET/UNSETLOCK MUST BE PERFORMED IN THE STRATEGY BEFORE CALLING THIS FUNCTION
rCurrentProcessInfo | the current process info instance |
Reimplemented from Kratos::Condition.
|
overridevirtual |
Initialize Damping Matrix.
rDampingMatrix | The damping matrix to be computed |
rCurrentProcessInfo | the current process info instance |
Reimplemented from Kratos::Condition.
|
overrideprotectedvirtual |
This is called during the assembling process in order to calculate the condition left hand side matrix only.
rLeftHandSideMatrix | the condition left hand side matrix |
rCurrentProcessInfo | the current process info instance |
Reimplemented from Kratos::Condition.
|
overrideprotectedvirtual |
This is called during the assembling process in order to calculate all condition contributions to the global system matrix and the right hand side.
rLeftHandSideMatrix | the condition left hand side matrix |
rRightHandSideVector | the condition right hand side |
rCurrentProcessInfo | the current process info instance |
Reimplemented from Kratos::Condition.
|
overridevirtual |
This method computes the mass matrix.
rMassMatrix | The mass matrix to be computed |
rCurrentProcessInfo | the current process info instance |
Reimplemented from Kratos::Condition.
|
override |
|
overridevirtual |
Calculate a double Variable.
rVariable | Internal values |
rCurrentProcessInfo | The current process information |
rOutput | The values of interest (doubles) |
Reimplemented from Kratos::Condition.
|
overridevirtual |
Calculate a Vector Variable.
rVariable | Internal values |
rCurrentProcessInfo | The current process information |
rOutput | The values of interest (vector) |
Reimplemented from Kratos::Condition.
|
overrideprotectedvirtual |
This is called during the assembling process in order to calculate the condition right hand side vector only.
rRightHandSideVector | the condition right hand side vector |
rCurrentProcessInfo | the current process info instance |
Reimplemented from Kratos::Condition.
|
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 | The current process information |
Reimplemented from Kratos::Condition.
|
overridevirtual |
Creates a new element pointer from an existing geometry.
NewId | the ID of the new element |
pGeom | the geometry taken to create the condition |
pProperties | the properties assigned to the new element |
Reimplemented from Kratos::Condition.
|
overridevirtual |
Creates a new element pointer from an existing geometry.
NewId | the ID of the new element |
pGeom | the geometry taken to create the condition |
pProperties | the properties assigned to the new element |
pMasterGeom | the paired geometry |
Reimplemented from Kratos::PairedCondition.
|
overridevirtual |
Creates a new element pointer from an arry of nodes.
NewId | the ID of the new element |
rThisNodes | the nodes of the new element |
pProperties | the properties assigned to the new element |
Reimplemented from Kratos::Condition.
|
overridevirtual |
Sets on rResult the ID's of the element degrees of freedom.
rResult | The result vector with the ID's of the DOF |
rCurrentProcessInfo | the current process info instance |
Reimplemented from Kratos::Condition.
|
overridevirtual |
Called at the end of each iteration.
rCurrentProcessInfo | the current process info instance |
Reimplemented from Kratos::Condition.
|
overridevirtual |
Called at the ending of each solution step.
rCurrentProcessInfo | the current process info instance |
Reimplemented from Kratos::Condition.
|
overridevirtual |
Sets on ConditionalDofList the degrees of freedom of the considered element geometry.
rConditionalDofList | The list of DOFs |
rCurrentProcessInfo | The current process info instance |
Reimplemented from Kratos::Condition.
|
inlineoverrideprotectedvirtual |
It returns theintegration method considered.
Reimplemented from Kratos::Condition.
|
inlineoverridevirtual |
Turn back information as a string.
Reimplemented from Kratos::Condition.
|
overridevirtual |
Called at the beginning of each solution step.
rCurrentProcessInfo | the current process info instance |
Reimplemented from Kratos::Condition.
|
overridevirtual |
Called at the beginning of each iteration.
rCurrentProcessInfo | the current process info instance |
Reimplemented from Kratos::Condition.
|
overridevirtual |
Called at the beginning of each solution step.
rCurrentProcessInfo | the current process info instance |
Reimplemented from Kratos::Condition.
Kratos::MPCMortarContactCondition< TDim, TNumNodes, TNumNodesMaster >::KRATOS_CLASS_INTRUSIVE_POINTER_DEFINITION | ( | MPCMortarContactCondition< TDim, TNumNodes, TNumNodesMaster > | ) |
Counted pointer of MPCMortarContactCondition.
|
inlineoverridevirtual |
Print object's data.
Reimplemented from Kratos::Condition.
|
inlineoverridevirtual |
Print information about this object.
Reimplemented from Kratos::Condition.
|
friend |
|
staticconstexpr |
Constant expression for matrix size.
|
protected |
In order to know iw we need to initialize the previous operators.
|
protected |