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.
|
#include <convection_diffusion_reaction_element.h>
Public Types | |
Type Definitions | |
using | BaseType = Element |
using | NodeType = Node |
Node type (default is: Node) More... | |
using | GeometryType = Geometry< NodeType > |
Geometry type (using with given NodeType) More... | |
using | NodesArrayType = Geometry< NodeType >::PointsArrayType |
Definition of nodes container type, redefined from GeometryType. More... | |
using | VectorType = Vector |
Vector type for local contributions to the linear system. More... | |
using | MatrixType = Matrix |
Matrix type for local contributions to the linear system. More... | |
using | IndexType = std::size_t |
using | EquationIdVectorType = std::vector< IndexType > |
using | DofsVectorType = std::vector< Dof< double >::Pointer > |
using | ShapeFunctionDerivativesArrayType = GeometryType::ShapeFunctionsGradientsType |
Type for an array of shape function gradient matrices. More... | |
using | PropertiesType = typename BaseType::PropertiesType |
using | ConvectionDiffusionReactionDataType = TConvectionDiffusionReactionData |
using | CurrentElementType = ConvectionDiffusionReactionElement< TDim, TNumNodes, TConvectionDiffusionReactionData > |
Public Types inherited from Kratos::Element | |
typedef Element | ElementType |
definition of element type More... | |
typedef GeometricalObject | BaseType |
base type: an GeometricalObject that automatically has a unique number More... | |
typedef Node | NodeType |
definition of node type (default is: Node) More... | |
typedef Properties | PropertiesType |
typedef Geometry< NodeType > | GeometryType |
definition of the geometry type with given NodeType More... | |
typedef Geometry< NodeType >::PointsArrayType | NodesArrayType |
definition of nodes container type, redefined from GeometryType More... | |
typedef Vector | VectorType |
typedef Matrix | MatrixType |
typedef std::size_t | IndexType |
typedef std::size_t | SizeType |
typedef Dof< double > | DofType |
typedef std::vector< std::size_t > | EquationIdVectorType |
typedef std::vector< DofType::Pointer > | DofsVectorType |
typedef PointerVectorSet< DofType > | DofsArrayType |
typedef GeometryData::IntegrationMethod | IntegrationMethod |
Type definition for integration methods. More... | |
typedef GeometryData | GeometryDataType |
Public Types inherited from Kratos::GeometricalObject | |
typedef Node | NodeType |
Definition of the node type. More... | |
typedef Geometry< NodeType > | GeometryType |
The geometry type definition. More... | |
typedef std::size_t | IndexType |
Defines the index type. More... | |
typedef std::size_t | result_type |
Defines the result type. More... | |
Public Types inherited from Kratos::IndexedObject | |
typedef std::size_t | IndexType |
The definition of the index type. More... | |
typedef std::size_t | result_type |
The definition of the result_type. More... | |
Public Types inherited from Kratos::Flags | |
enum | FlagsList { Flag0 = BlockType(1) , Flag1 = BlockType(1) << 1 , Flag2 = BlockType(1) << 2 , Flag3 = BlockType(1) << 3 , Flag4 = BlockType(1) << 4 , Flag5 = BlockType(1) << 5 , Flag6 = BlockType(1) << 6 , Flag7 = BlockType(1) << 7 , Flag8 = BlockType(1) << 8 , Flag9 = BlockType(1) << 9 , Flag10 = BlockType(1) << 10 , Flag11 = BlockType(1) << 11 , Flag12 = BlockType(1) << 12 , Flag13 = BlockType(1) << 13 , Flag14 = BlockType(1) << 14 , Flag15 = BlockType(1) << 15 , Flag16 = BlockType(1) << 16 , Flag17 = BlockType(1) << 17 , Flag18 = BlockType(1) << 18 , Flag19 = BlockType(1) << 19 , Flag20 = BlockType(1) << 20 , Flag21 = BlockType(1) << 21 , Flag22 = BlockType(1) << 22 , Flag23 = BlockType(1) << 23 , Flag24 = BlockType(1) << 24 , Flag25 = BlockType(1) << 25 , Flag26 = BlockType(1) << 26 , Flag27 = BlockType(1) << 27 , Flag28 = BlockType(1) << 28 , Flag29 = BlockType(1) << 29 , Flag30 = BlockType(1) << 30 } |
typedef int64_t | BlockType |
typedef int64_t | FlagType |
typedef std::size_t | IndexType |
Public Member Functions | |
Pointer Definitions | |
Pointer definition of ConvectionDiffusionReactionElement | |
KRATOS_CLASS_INTRUSIVE_POINTER_DEFINITION (ConvectionDiffusionReactionElement) | |
Life Cycle | |
ConvectionDiffusionReactionElement (IndexType NewId=0) | |
ConvectionDiffusionReactionElement (IndexType NewId, const NodesArrayType &ThisNodes) | |
ConvectionDiffusionReactionElement (IndexType NewId, GeometryType::Pointer pGeometry) | |
ConvectionDiffusionReactionElement (IndexType NewId, GeometryType::Pointer pGeometry, typename PropertiesType::Pointer pProperties) | |
ConvectionDiffusionReactionElement (ConvectionDiffusionReactionElement const &rOther) | |
~ConvectionDiffusionReactionElement () override=default | |
Operations | |
Element::Pointer | Create (IndexType NewId, NodesArrayType const &ThisNodes, typename PropertiesType::Pointer pProperties) const override |
Element::Pointer | Create (IndexType NewId, GeometryType::Pointer pGeom, typename PropertiesType::Pointer pProperties) const override |
Element::Pointer | Clone (IndexType NewId, NodesArrayType const &ThisNodes) const override |
void | EquationIdVector (EquationIdVectorType &rResult, const ProcessInfo &CurrentProcessInfo) const override |
void | GetDofList (DofsVectorType &rElementalDofList, const ProcessInfo &CurrentProcessInfo) 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 | CalculateLocalSystem (MatrixType &rLeftHandSideMatrix, VectorType &rRightHandSideVector, const ProcessInfo &rCurrentProcessInfo) override |
void | CalculateRightHandSide (VectorType &rRightHandSideVector, const ProcessInfo &rCurrentProcessInfo) override |
void | CalculateLocalVelocityContribution (MatrixType &rDampingMatrix, VectorType &rRightHandSideVector, const ProcessInfo &rCurrentProcessInfo) override |
CalculateLocalVelocityContribution Calculate the local contribution in terms of velocity and pressure. More... | |
void | CalculateMassMatrix (MatrixType &rMassMatrix, const ProcessInfo &rCurrentProcessInfo) override |
void | CalculateDampingMatrix (MatrixType &rDampingMatrix, const ProcessInfo &rCurrentProcessInfo) override |
int | Check (const ProcessInfo &rCurrentProcessInfo) const override |
GeometryData::IntegrationMethod | GetIntegrationMethod () const override |
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... | |
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 void | Initialize (const ProcessInfo &rCurrentProcessInfo) |
virtual void | ResetConstitutiveLaw () |
virtual void | InitializeSolutionStep (const ProcessInfo &rCurrentProcessInfo) |
virtual void | InitializeNonLinearIteration (const ProcessInfo &rCurrentProcessInfo) |
virtual void | FinalizeNonLinearIteration (const ProcessInfo &rCurrentProcessInfo) |
virtual void | FinalizeSolutionStep (const ProcessInfo &rCurrentProcessInfo) |
virtual void | CalculateLeftHandSide (MatrixType &rLeftHandSideMatrix, const ProcessInfo &rCurrentProcessInfo) |
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 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 VectorType &rRHSVector, const Variable< VectorType > &rRHSVariable, const Variable< array_1d< double, 3 > > &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 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 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< 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) |
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 | 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... | |
void | PrintData (std::ostream &rOStream) const override |
Print object's data. 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 |
void | PrintData (std::ostream &rOStream) const override |
Print object's data. More... | |
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 | GetValuesArray (BoundedVector< double, TNumNodes > &rValues, const int Step=0) const |
Get the Values Array. More... | |
virtual void | CalculateGeometryData (Vector &rGaussWeights, Matrix &rNContainer, ShapeFunctionDerivativesArrayType &rDN_DX) const |
Calculates shape function data for this element. More... | |
void | AddLumpedMassMatrix (Matrix &rMassMatrix, const double Mass) const |
void | AddDampingMatrixGaussPointContributions (Matrix &rDampingMatrix, const double ReactionTerm, const double EffectiveKinematicViscosity, const Vector &rVelocityConvectiveTerms, const double GaussWeight, const Vector &rGaussShapeFunctions, const Matrix &rGaussdNa_dNb) const |
Serialization | |
class | Serializer |
Additional Inherited Members | |
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) |
using Kratos::ConvectionDiffusionReactionElement< TDim, TNumNodes, TConvectionDiffusionReactionData >::BaseType = Element |
using Kratos::ConvectionDiffusionReactionElement< TDim, TNumNodes, TConvectionDiffusionReactionData >::ConvectionDiffusionReactionDataType = TConvectionDiffusionReactionData |
using Kratos::ConvectionDiffusionReactionElement< TDim, TNumNodes, TConvectionDiffusionReactionData >::CurrentElementType = ConvectionDiffusionReactionElement<TDim, TNumNodes, TConvectionDiffusionReactionData> |
using Kratos::ConvectionDiffusionReactionElement< TDim, TNumNodes, TConvectionDiffusionReactionData >::DofsVectorType = std::vector<Dof<double>::Pointer> |
using Kratos::ConvectionDiffusionReactionElement< TDim, TNumNodes, TConvectionDiffusionReactionData >::EquationIdVectorType = std::vector<IndexType> |
using Kratos::ConvectionDiffusionReactionElement< TDim, TNumNodes, TConvectionDiffusionReactionData >::GeometryType = Geometry<NodeType> |
Geometry type (using with given NodeType)
using Kratos::ConvectionDiffusionReactionElement< TDim, TNumNodes, TConvectionDiffusionReactionData >::IndexType = std::size_t |
using Kratos::ConvectionDiffusionReactionElement< TDim, TNumNodes, TConvectionDiffusionReactionData >::MatrixType = Matrix |
Matrix type for local contributions to the linear system.
using Kratos::ConvectionDiffusionReactionElement< TDim, TNumNodes, TConvectionDiffusionReactionData >::NodesArrayType = Geometry<NodeType>::PointsArrayType |
Definition of nodes container type, redefined from GeometryType.
using Kratos::ConvectionDiffusionReactionElement< TDim, TNumNodes, TConvectionDiffusionReactionData >::NodeType = Node |
using Kratos::ConvectionDiffusionReactionElement< TDim, TNumNodes, TConvectionDiffusionReactionData >::PropertiesType = typename BaseType::PropertiesType |
using Kratos::ConvectionDiffusionReactionElement< TDim, TNumNodes, TConvectionDiffusionReactionData >::ShapeFunctionDerivativesArrayType = GeometryType::ShapeFunctionsGradientsType |
Type for an array of shape function gradient matrices.
using Kratos::ConvectionDiffusionReactionElement< TDim, TNumNodes, TConvectionDiffusionReactionData >::VectorType = Vector |
Vector type for local contributions to the linear system.
|
inlineexplicit |
Constructor.
|
inline |
Constructor using an array of nodes
|
inline |
Constructor using Geometry
|
inline |
Constructor using Properties
|
inline |
Copy Constructor
|
overridedefault |
Destructor
|
protected |
|
protected |
|
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::ConvectionDiffusionReactionResidualBasedFluxCorrectedElement< TDim, TNumNodes, TConvectionDiffusionReactionData >, Kratos::ConvectionDiffusionReactionResidualBasedFluxCorrectedElement< 2, 3, Kratos::KEpsilonElementData::EpsilonElementData< 2 > >, Kratos::ConvectionDiffusionReactionResidualBasedFluxCorrectedElement< 2, 3, Kratos::KEpsilonElementData::KElementData< 2 > >, Kratos::ConvectionDiffusionReactionResidualBasedFluxCorrectedElement< 3, 4, Kratos::KEpsilonElementData::KElementData< 3 > >, Kratos::ConvectionDiffusionReactionResidualBasedFluxCorrectedElement< 3, 4, Kratos::KOmegaSSTElementData::KElementData< 3 > >, Kratos::ConvectionDiffusionReactionResidualBasedFluxCorrectedElement< 2, 3, Kratos::KOmegaElementData::KElementData< 2 > >, Kratos::ConvectionDiffusionReactionResidualBasedFluxCorrectedElement< 2, 3, Kratos::KOmegaSSTElementData::KElementData< 2 > >, Kratos::ConvectionDiffusionReactionResidualBasedFluxCorrectedElement< 3, 4, Kratos::KOmegaElementData::OmegaElementData< 3 > >, Kratos::ConvectionDiffusionReactionResidualBasedFluxCorrectedElement< 2, 3, Kratos::KOmegaSSTElementData::OmegaElementData< 2 > >, Kratos::ConvectionDiffusionReactionResidualBasedFluxCorrectedElement< 3, 4, Kratos::KOmegaSSTElementData::OmegaElementData< 3 > >, Kratos::ConvectionDiffusionReactionResidualBasedFluxCorrectedElement< 2, 3, Kratos::KOmegaElementData::OmegaElementData< 2 > >, Kratos::ConvectionDiffusionReactionResidualBasedFluxCorrectedElement< 3, 4, Kratos::KEpsilonElementData::EpsilonElementData< 3 > >, Kratos::ConvectionDiffusionReactionResidualBasedFluxCorrectedElement< 3, 4, Kratos::KOmegaElementData::KElementData< 3 > >, Kratos::ConvectionDiffusionReactionCrossWindStabilizedElement< 2, 3, Kratos::KEpsilonElementData::EpsilonElementData< 2 > >, Kratos::ConvectionDiffusionReactionCrossWindStabilizedElement< 2, 3, Kratos::KEpsilonElementData::KElementData< 2 > >, Kratos::ConvectionDiffusionReactionCrossWindStabilizedElement< 3, 4, Kratos::KEpsilonElementData::KElementData< 3 > >, Kratos::ConvectionDiffusionReactionCrossWindStabilizedElement< 3, 4, Kratos::KOmegaSSTElementData::KElementData< 3 > >, Kratos::ConvectionDiffusionReactionCrossWindStabilizedElement< 2, 3, Kratos::KOmegaElementData::KElementData< 2 > >, Kratos::ConvectionDiffusionReactionCrossWindStabilizedElement< 2, 3, Kratos::KOmegaSSTElementData::KElementData< 2 > >, Kratos::ConvectionDiffusionReactionCrossWindStabilizedElement< 3, 4, Kratos::KOmegaElementData::OmegaElementData< 3 > >, Kratos::ConvectionDiffusionReactionCrossWindStabilizedElement< 2, 3, Kratos::KOmegaSSTElementData::OmegaElementData< 2 > >, Kratos::ConvectionDiffusionReactionCrossWindStabilizedElement< 3, 4, Kratos::KOmegaSSTElementData::OmegaElementData< 3 > >, Kratos::ConvectionDiffusionReactionCrossWindStabilizedElement< 2, 3, Kratos::KOmegaElementData::OmegaElementData< 2 > >, Kratos::ConvectionDiffusionReactionCrossWindStabilizedElement< 3, 4, Kratos::KEpsilonElementData::EpsilonElementData< 3 > >, and Kratos::ConvectionDiffusionReactionCrossWindStabilizedElement< 3, 4, Kratos::KOmegaElementData::KElementData< 3 > >.
|
protectedvirtual |
Calculates shape function data for this element.
rGaussWeights | Gauss point weights list |
rNContainer | Shape function values. Each row contains shape functions for respective gauss point |
rDN_DX | List of matrices containing shape function derivatives for each gauss point |
|
overridevirtual |
ELEMENTS inherited from this class have to implement next CalculateLocalSystem, CalculateLeftHandSide and CalculateRightHandSide methods they can be managed internally with a private method to do the same calculations only once: MANDATORY 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::ConvectionDiffusionReactionResidualBasedFluxCorrectedElement< TDim, TNumNodes, TConvectionDiffusionReactionData >, Kratos::ConvectionDiffusionReactionResidualBasedFluxCorrectedElement< 2, 3, Kratos::KEpsilonElementData::EpsilonElementData< 2 > >, Kratos::ConvectionDiffusionReactionResidualBasedFluxCorrectedElement< 2, 3, Kratos::KEpsilonElementData::KElementData< 2 > >, Kratos::ConvectionDiffusionReactionResidualBasedFluxCorrectedElement< 3, 4, Kratos::KEpsilonElementData::KElementData< 3 > >, Kratos::ConvectionDiffusionReactionResidualBasedFluxCorrectedElement< 3, 4, Kratos::KOmegaSSTElementData::KElementData< 3 > >, Kratos::ConvectionDiffusionReactionResidualBasedFluxCorrectedElement< 2, 3, Kratos::KOmegaElementData::KElementData< 2 > >, Kratos::ConvectionDiffusionReactionResidualBasedFluxCorrectedElement< 2, 3, Kratos::KOmegaSSTElementData::KElementData< 2 > >, Kratos::ConvectionDiffusionReactionResidualBasedFluxCorrectedElement< 3, 4, Kratos::KOmegaElementData::OmegaElementData< 3 > >, Kratos::ConvectionDiffusionReactionResidualBasedFluxCorrectedElement< 2, 3, Kratos::KOmegaSSTElementData::OmegaElementData< 2 > >, Kratos::ConvectionDiffusionReactionResidualBasedFluxCorrectedElement< 3, 4, Kratos::KOmegaSSTElementData::OmegaElementData< 3 > >, Kratos::ConvectionDiffusionReactionResidualBasedFluxCorrectedElement< 2, 3, Kratos::KOmegaElementData::OmegaElementData< 2 > >, Kratos::ConvectionDiffusionReactionResidualBasedFluxCorrectedElement< 3, 4, Kratos::KEpsilonElementData::EpsilonElementData< 3 > >, and Kratos::ConvectionDiffusionReactionResidualBasedFluxCorrectedElement< 3, 4, Kratos::KOmegaElementData::KElementData< 3 > >.
|
overridevirtual |
CalculateLocalVelocityContribution Calculate the local contribution in terms of velocity and pressure.
rDampMatrix | Local finite element system matrix (output) |
rRightHandSideVector | Local finite element residual vector (output) |
rCurrentProcessInfo | Current ProcessInfo values (input) |
Reimplemented from Kratos::Element.
Reimplemented in Kratos::ConvectionDiffusionReactionResidualBasedFluxCorrectedElement< TDim, TNumNodes, TConvectionDiffusionReactionData >, Kratos::ConvectionDiffusionReactionResidualBasedFluxCorrectedElement< 2, 3, Kratos::KEpsilonElementData::EpsilonElementData< 2 > >, Kratos::ConvectionDiffusionReactionResidualBasedFluxCorrectedElement< 2, 3, Kratos::KEpsilonElementData::KElementData< 2 > >, Kratos::ConvectionDiffusionReactionResidualBasedFluxCorrectedElement< 3, 4, Kratos::KEpsilonElementData::KElementData< 3 > >, Kratos::ConvectionDiffusionReactionResidualBasedFluxCorrectedElement< 3, 4, Kratos::KOmegaSSTElementData::KElementData< 3 > >, Kratos::ConvectionDiffusionReactionResidualBasedFluxCorrectedElement< 2, 3, Kratos::KOmegaElementData::KElementData< 2 > >, Kratos::ConvectionDiffusionReactionResidualBasedFluxCorrectedElement< 2, 3, Kratos::KOmegaSSTElementData::KElementData< 2 > >, Kratos::ConvectionDiffusionReactionResidualBasedFluxCorrectedElement< 3, 4, Kratos::KOmegaElementData::OmegaElementData< 3 > >, Kratos::ConvectionDiffusionReactionResidualBasedFluxCorrectedElement< 2, 3, Kratos::KOmegaSSTElementData::OmegaElementData< 2 > >, Kratos::ConvectionDiffusionReactionResidualBasedFluxCorrectedElement< 3, 4, Kratos::KOmegaSSTElementData::OmegaElementData< 3 > >, Kratos::ConvectionDiffusionReactionResidualBasedFluxCorrectedElement< 2, 3, Kratos::KOmegaElementData::OmegaElementData< 2 > >, Kratos::ConvectionDiffusionReactionResidualBasedFluxCorrectedElement< 3, 4, Kratos::KEpsilonElementData::EpsilonElementData< 3 > >, Kratos::ConvectionDiffusionReactionResidualBasedFluxCorrectedElement< 3, 4, Kratos::KOmegaElementData::KElementData< 3 > >, Kratos::ConvectionDiffusionReactionCrossWindStabilizedElement< 2, 3, Kratos::KEpsilonElementData::EpsilonElementData< 2 > >, Kratos::ConvectionDiffusionReactionCrossWindStabilizedElement< 2, 3, Kratos::KEpsilonElementData::KElementData< 2 > >, Kratos::ConvectionDiffusionReactionCrossWindStabilizedElement< 3, 4, Kratos::KEpsilonElementData::KElementData< 3 > >, Kratos::ConvectionDiffusionReactionCrossWindStabilizedElement< 3, 4, Kratos::KOmegaSSTElementData::KElementData< 3 > >, Kratos::ConvectionDiffusionReactionCrossWindStabilizedElement< 2, 3, Kratos::KOmegaElementData::KElementData< 2 > >, Kratos::ConvectionDiffusionReactionCrossWindStabilizedElement< 2, 3, Kratos::KOmegaSSTElementData::KElementData< 2 > >, Kratos::ConvectionDiffusionReactionCrossWindStabilizedElement< 3, 4, Kratos::KOmegaElementData::OmegaElementData< 3 > >, Kratos::ConvectionDiffusionReactionCrossWindStabilizedElement< 2, 3, Kratos::KOmegaSSTElementData::OmegaElementData< 2 > >, Kratos::ConvectionDiffusionReactionCrossWindStabilizedElement< 3, 4, Kratos::KOmegaSSTElementData::OmegaElementData< 3 > >, Kratos::ConvectionDiffusionReactionCrossWindStabilizedElement< 2, 3, Kratos::KOmegaElementData::OmegaElementData< 2 > >, Kratos::ConvectionDiffusionReactionCrossWindStabilizedElement< 3, 4, Kratos::KEpsilonElementData::EpsilonElementData< 3 > >, and Kratos::ConvectionDiffusionReactionCrossWindStabilizedElement< 3, 4, Kratos::KOmegaElementData::KElementData< 3 > >.
|
overridevirtual |
ELEMENTS inherited from this class must implement this methods if they need to add dynamic element contributions note: second derivatives means the accelerations if the displacements are the dof of the analysis note: time integration parameters must be set in the rCurrentProcessInfo before calling these methods CalculateSecondDerivativesContributions, CalculateSecondDerivativesLHS, CalculateSecondDerivativesRHS methods are : OPTIONAL 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::ConvectionDiffusionReactionResidualBasedFluxCorrectedElement< TDim, TNumNodes, TConvectionDiffusionReactionData >, Kratos::ConvectionDiffusionReactionResidualBasedFluxCorrectedElement< 2, 3, Kratos::KEpsilonElementData::EpsilonElementData< 2 > >, Kratos::ConvectionDiffusionReactionResidualBasedFluxCorrectedElement< 2, 3, Kratos::KEpsilonElementData::KElementData< 2 > >, Kratos::ConvectionDiffusionReactionResidualBasedFluxCorrectedElement< 3, 4, Kratos::KEpsilonElementData::KElementData< 3 > >, Kratos::ConvectionDiffusionReactionResidualBasedFluxCorrectedElement< 3, 4, Kratos::KOmegaSSTElementData::KElementData< 3 > >, Kratos::ConvectionDiffusionReactionResidualBasedFluxCorrectedElement< 2, 3, Kratos::KOmegaElementData::KElementData< 2 > >, Kratos::ConvectionDiffusionReactionResidualBasedFluxCorrectedElement< 2, 3, Kratos::KOmegaSSTElementData::KElementData< 2 > >, Kratos::ConvectionDiffusionReactionResidualBasedFluxCorrectedElement< 3, 4, Kratos::KOmegaElementData::OmegaElementData< 3 > >, Kratos::ConvectionDiffusionReactionResidualBasedFluxCorrectedElement< 2, 3, Kratos::KOmegaSSTElementData::OmegaElementData< 2 > >, Kratos::ConvectionDiffusionReactionResidualBasedFluxCorrectedElement< 3, 4, Kratos::KOmegaSSTElementData::OmegaElementData< 3 > >, Kratos::ConvectionDiffusionReactionResidualBasedFluxCorrectedElement< 2, 3, Kratos::KOmegaElementData::OmegaElementData< 2 > >, Kratos::ConvectionDiffusionReactionResidualBasedFluxCorrectedElement< 3, 4, Kratos::KEpsilonElementData::EpsilonElementData< 3 > >, Kratos::ConvectionDiffusionReactionResidualBasedFluxCorrectedElement< 3, 4, Kratos::KOmegaElementData::KElementData< 3 > >, Kratos::ConvectionDiffusionReactionCrossWindStabilizedElement< 2, 3, Kratos::KEpsilonElementData::EpsilonElementData< 2 > >, Kratos::ConvectionDiffusionReactionCrossWindStabilizedElement< 2, 3, Kratos::KEpsilonElementData::KElementData< 2 > >, Kratos::ConvectionDiffusionReactionCrossWindStabilizedElement< 3, 4, Kratos::KEpsilonElementData::KElementData< 3 > >, Kratos::ConvectionDiffusionReactionCrossWindStabilizedElement< 3, 4, Kratos::KOmegaSSTElementData::KElementData< 3 > >, Kratos::ConvectionDiffusionReactionCrossWindStabilizedElement< 2, 3, Kratos::KOmegaElementData::KElementData< 2 > >, Kratos::ConvectionDiffusionReactionCrossWindStabilizedElement< 2, 3, Kratos::KOmegaSSTElementData::KElementData< 2 > >, Kratos::ConvectionDiffusionReactionCrossWindStabilizedElement< 3, 4, Kratos::KOmegaElementData::OmegaElementData< 3 > >, Kratos::ConvectionDiffusionReactionCrossWindStabilizedElement< 2, 3, Kratos::KOmegaSSTElementData::OmegaElementData< 2 > >, Kratos::ConvectionDiffusionReactionCrossWindStabilizedElement< 3, 4, Kratos::KOmegaSSTElementData::OmegaElementData< 3 > >, Kratos::ConvectionDiffusionReactionCrossWindStabilizedElement< 2, 3, Kratos::KOmegaElementData::OmegaElementData< 2 > >, Kratos::ConvectionDiffusionReactionCrossWindStabilizedElement< 3, 4, Kratos::KEpsilonElementData::EpsilonElementData< 3 > >, and Kratos::ConvectionDiffusionReactionCrossWindStabilizedElement< 3, 4, Kratos::KOmegaElementData::KElementData< 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::ConvectionDiffusionReactionResidualBasedFluxCorrectedElement< TDim, TNumNodes, TConvectionDiffusionReactionData >, Kratos::ConvectionDiffusionReactionResidualBasedFluxCorrectedElement< 2, 3, Kratos::KEpsilonElementData::EpsilonElementData< 2 > >, Kratos::ConvectionDiffusionReactionResidualBasedFluxCorrectedElement< 2, 3, Kratos::KEpsilonElementData::KElementData< 2 > >, Kratos::ConvectionDiffusionReactionResidualBasedFluxCorrectedElement< 3, 4, Kratos::KEpsilonElementData::KElementData< 3 > >, Kratos::ConvectionDiffusionReactionResidualBasedFluxCorrectedElement< 3, 4, Kratos::KOmegaSSTElementData::KElementData< 3 > >, Kratos::ConvectionDiffusionReactionResidualBasedFluxCorrectedElement< 2, 3, Kratos::KOmegaElementData::KElementData< 2 > >, Kratos::ConvectionDiffusionReactionResidualBasedFluxCorrectedElement< 2, 3, Kratos::KOmegaSSTElementData::KElementData< 2 > >, Kratos::ConvectionDiffusionReactionResidualBasedFluxCorrectedElement< 3, 4, Kratos::KOmegaElementData::OmegaElementData< 3 > >, Kratos::ConvectionDiffusionReactionResidualBasedFluxCorrectedElement< 2, 3, Kratos::KOmegaSSTElementData::OmegaElementData< 2 > >, Kratos::ConvectionDiffusionReactionResidualBasedFluxCorrectedElement< 3, 4, Kratos::KOmegaSSTElementData::OmegaElementData< 3 > >, Kratos::ConvectionDiffusionReactionResidualBasedFluxCorrectedElement< 2, 3, Kratos::KOmegaElementData::OmegaElementData< 2 > >, Kratos::ConvectionDiffusionReactionResidualBasedFluxCorrectedElement< 3, 4, Kratos::KEpsilonElementData::EpsilonElementData< 3 > >, Kratos::ConvectionDiffusionReactionResidualBasedFluxCorrectedElement< 3, 4, Kratos::KOmegaElementData::KElementData< 3 > >, Kratos::ConvectionDiffusionReactionCrossWindStabilizedElement< 2, 3, Kratos::KEpsilonElementData::EpsilonElementData< 2 > >, Kratos::ConvectionDiffusionReactionCrossWindStabilizedElement< 2, 3, Kratos::KEpsilonElementData::KElementData< 2 > >, Kratos::ConvectionDiffusionReactionCrossWindStabilizedElement< 3, 4, Kratos::KEpsilonElementData::KElementData< 3 > >, Kratos::ConvectionDiffusionReactionCrossWindStabilizedElement< 3, 4, Kratos::KOmegaSSTElementData::KElementData< 3 > >, Kratos::ConvectionDiffusionReactionCrossWindStabilizedElement< 2, 3, Kratos::KOmegaElementData::KElementData< 2 > >, Kratos::ConvectionDiffusionReactionCrossWindStabilizedElement< 2, 3, Kratos::KOmegaSSTElementData::KElementData< 2 > >, Kratos::ConvectionDiffusionReactionCrossWindStabilizedElement< 3, 4, Kratos::KOmegaElementData::OmegaElementData< 3 > >, Kratos::ConvectionDiffusionReactionCrossWindStabilizedElement< 2, 3, Kratos::KOmegaSSTElementData::OmegaElementData< 2 > >, Kratos::ConvectionDiffusionReactionCrossWindStabilizedElement< 3, 4, Kratos::KOmegaSSTElementData::OmegaElementData< 3 > >, Kratos::ConvectionDiffusionReactionCrossWindStabilizedElement< 2, 3, Kratos::KOmegaElementData::OmegaElementData< 2 > >, Kratos::ConvectionDiffusionReactionCrossWindStabilizedElement< 3, 4, Kratos::KEpsilonElementData::EpsilonElementData< 3 > >, and Kratos::ConvectionDiffusionReactionCrossWindStabilizedElement< 3, 4, Kratos::KOmegaElementData::KElementData< 3 > >.
|
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::Element.
|
inlineoverridevirtual |
creates a new element pointer and clones the previous element data
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::ConvectionDiffusionReactionResidualBasedFluxCorrectedElement< TDim, TNumNodes, TConvectionDiffusionReactionData >, Kratos::ConvectionDiffusionReactionResidualBasedFluxCorrectedElement< 2, 3, Kratos::KEpsilonElementData::EpsilonElementData< 2 > >, Kratos::ConvectionDiffusionReactionResidualBasedFluxCorrectedElement< 2, 3, Kratos::KEpsilonElementData::KElementData< 2 > >, Kratos::ConvectionDiffusionReactionResidualBasedFluxCorrectedElement< 3, 4, Kratos::KEpsilonElementData::KElementData< 3 > >, Kratos::ConvectionDiffusionReactionResidualBasedFluxCorrectedElement< 3, 4, Kratos::KOmegaSSTElementData::KElementData< 3 > >, Kratos::ConvectionDiffusionReactionResidualBasedFluxCorrectedElement< 2, 3, Kratos::KOmegaElementData::KElementData< 2 > >, Kratos::ConvectionDiffusionReactionResidualBasedFluxCorrectedElement< 2, 3, Kratos::KOmegaSSTElementData::KElementData< 2 > >, Kratos::ConvectionDiffusionReactionResidualBasedFluxCorrectedElement< 3, 4, Kratos::KOmegaElementData::OmegaElementData< 3 > >, Kratos::ConvectionDiffusionReactionResidualBasedFluxCorrectedElement< 2, 3, Kratos::KOmegaSSTElementData::OmegaElementData< 2 > >, Kratos::ConvectionDiffusionReactionResidualBasedFluxCorrectedElement< 3, 4, Kratos::KOmegaSSTElementData::OmegaElementData< 3 > >, Kratos::ConvectionDiffusionReactionResidualBasedFluxCorrectedElement< 2, 3, Kratos::KOmegaElementData::OmegaElementData< 2 > >, Kratos::ConvectionDiffusionReactionResidualBasedFluxCorrectedElement< 3, 4, Kratos::KEpsilonElementData::EpsilonElementData< 3 > >, Kratos::ConvectionDiffusionReactionResidualBasedFluxCorrectedElement< 3, 4, Kratos::KOmegaElementData::KElementData< 3 > >, Kratos::ConvectionDiffusionReactionCrossWindStabilizedElement< 2, 3, Kratos::KEpsilonElementData::EpsilonElementData< 2 > >, Kratos::ConvectionDiffusionReactionCrossWindStabilizedElement< 2, 3, Kratos::KEpsilonElementData::KElementData< 2 > >, Kratos::ConvectionDiffusionReactionCrossWindStabilizedElement< 3, 4, Kratos::KEpsilonElementData::KElementData< 3 > >, Kratos::ConvectionDiffusionReactionCrossWindStabilizedElement< 3, 4, Kratos::KOmegaSSTElementData::KElementData< 3 > >, Kratos::ConvectionDiffusionReactionCrossWindStabilizedElement< 2, 3, Kratos::KOmegaElementData::KElementData< 2 > >, Kratos::ConvectionDiffusionReactionCrossWindStabilizedElement< 2, 3, Kratos::KOmegaSSTElementData::KElementData< 2 > >, Kratos::ConvectionDiffusionReactionCrossWindStabilizedElement< 3, 4, Kratos::KOmegaElementData::OmegaElementData< 3 > >, Kratos::ConvectionDiffusionReactionCrossWindStabilizedElement< 2, 3, Kratos::KOmegaSSTElementData::OmegaElementData< 2 > >, Kratos::ConvectionDiffusionReactionCrossWindStabilizedElement< 3, 4, Kratos::KOmegaSSTElementData::OmegaElementData< 3 > >, Kratos::ConvectionDiffusionReactionCrossWindStabilizedElement< 2, 3, Kratos::KOmegaElementData::OmegaElementData< 2 > >, Kratos::ConvectionDiffusionReactionCrossWindStabilizedElement< 3, 4, Kratos::KEpsilonElementData::EpsilonElementData< 3 > >, and Kratos::ConvectionDiffusionReactionCrossWindStabilizedElement< 3, 4, Kratos::KOmegaElementData::KElementData< 3 > >.
|
inlineoverridevirtual |
creates a new element pointer
NewId | the ID of the new element |
pGeom | the geometry to be employed |
pProperties | the properties assigned to the new element |
Reimplemented from Kratos::Element.
Reimplemented in Kratos::ConvectionDiffusionReactionResidualBasedFluxCorrectedElement< TDim, TNumNodes, TConvectionDiffusionReactionData >, Kratos::ConvectionDiffusionReactionResidualBasedFluxCorrectedElement< 2, 3, Kratos::KEpsilonElementData::EpsilonElementData< 2 > >, Kratos::ConvectionDiffusionReactionResidualBasedFluxCorrectedElement< 2, 3, Kratos::KEpsilonElementData::KElementData< 2 > >, Kratos::ConvectionDiffusionReactionResidualBasedFluxCorrectedElement< 3, 4, Kratos::KEpsilonElementData::KElementData< 3 > >, Kratos::ConvectionDiffusionReactionResidualBasedFluxCorrectedElement< 3, 4, Kratos::KOmegaSSTElementData::KElementData< 3 > >, Kratos::ConvectionDiffusionReactionResidualBasedFluxCorrectedElement< 2, 3, Kratos::KOmegaElementData::KElementData< 2 > >, Kratos::ConvectionDiffusionReactionResidualBasedFluxCorrectedElement< 2, 3, Kratos::KOmegaSSTElementData::KElementData< 2 > >, Kratos::ConvectionDiffusionReactionResidualBasedFluxCorrectedElement< 3, 4, Kratos::KOmegaElementData::OmegaElementData< 3 > >, Kratos::ConvectionDiffusionReactionResidualBasedFluxCorrectedElement< 2, 3, Kratos::KOmegaSSTElementData::OmegaElementData< 2 > >, Kratos::ConvectionDiffusionReactionResidualBasedFluxCorrectedElement< 3, 4, Kratos::KOmegaSSTElementData::OmegaElementData< 3 > >, Kratos::ConvectionDiffusionReactionResidualBasedFluxCorrectedElement< 2, 3, Kratos::KOmegaElementData::OmegaElementData< 2 > >, Kratos::ConvectionDiffusionReactionResidualBasedFluxCorrectedElement< 3, 4, Kratos::KEpsilonElementData::EpsilonElementData< 3 > >, Kratos::ConvectionDiffusionReactionResidualBasedFluxCorrectedElement< 3, 4, Kratos::KOmegaElementData::KElementData< 3 > >, Kratos::ConvectionDiffusionReactionCrossWindStabilizedElement< 2, 3, Kratos::KEpsilonElementData::EpsilonElementData< 2 > >, Kratos::ConvectionDiffusionReactionCrossWindStabilizedElement< 2, 3, Kratos::KEpsilonElementData::KElementData< 2 > >, Kratos::ConvectionDiffusionReactionCrossWindStabilizedElement< 3, 4, Kratos::KEpsilonElementData::KElementData< 3 > >, Kratos::ConvectionDiffusionReactionCrossWindStabilizedElement< 3, 4, Kratos::KOmegaSSTElementData::KElementData< 3 > >, Kratos::ConvectionDiffusionReactionCrossWindStabilizedElement< 2, 3, Kratos::KOmegaElementData::KElementData< 2 > >, Kratos::ConvectionDiffusionReactionCrossWindStabilizedElement< 2, 3, Kratos::KOmegaSSTElementData::KElementData< 2 > >, Kratos::ConvectionDiffusionReactionCrossWindStabilizedElement< 3, 4, Kratos::KOmegaElementData::OmegaElementData< 3 > >, Kratos::ConvectionDiffusionReactionCrossWindStabilizedElement< 2, 3, Kratos::KOmegaSSTElementData::OmegaElementData< 2 > >, Kratos::ConvectionDiffusionReactionCrossWindStabilizedElement< 3, 4, Kratos::KOmegaSSTElementData::OmegaElementData< 3 > >, Kratos::ConvectionDiffusionReactionCrossWindStabilizedElement< 2, 3, Kratos::KOmegaElementData::OmegaElementData< 2 > >, Kratos::ConvectionDiffusionReactionCrossWindStabilizedElement< 3, 4, Kratos::KEpsilonElementData::EpsilonElementData< 3 > >, and Kratos::ConvectionDiffusionReactionCrossWindStabilizedElement< 3, 4, Kratos::KOmegaElementData::KElementData< 3 > >.
|
inlineoverridevirtual |
ELEMENTS inherited from this class have to implement next Create and Clone methods: MANDATORY 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::ConvectionDiffusionReactionResidualBasedFluxCorrectedElement< TDim, TNumNodes, TConvectionDiffusionReactionData >, Kratos::ConvectionDiffusionReactionResidualBasedFluxCorrectedElement< 2, 3, Kratos::KEpsilonElementData::EpsilonElementData< 2 > >, Kratos::ConvectionDiffusionReactionResidualBasedFluxCorrectedElement< 2, 3, Kratos::KEpsilonElementData::KElementData< 2 > >, Kratos::ConvectionDiffusionReactionResidualBasedFluxCorrectedElement< 3, 4, Kratos::KEpsilonElementData::KElementData< 3 > >, Kratos::ConvectionDiffusionReactionResidualBasedFluxCorrectedElement< 3, 4, Kratos::KOmegaSSTElementData::KElementData< 3 > >, Kratos::ConvectionDiffusionReactionResidualBasedFluxCorrectedElement< 2, 3, Kratos::KOmegaElementData::KElementData< 2 > >, Kratos::ConvectionDiffusionReactionResidualBasedFluxCorrectedElement< 2, 3, Kratos::KOmegaSSTElementData::KElementData< 2 > >, Kratos::ConvectionDiffusionReactionResidualBasedFluxCorrectedElement< 3, 4, Kratos::KOmegaElementData::OmegaElementData< 3 > >, Kratos::ConvectionDiffusionReactionResidualBasedFluxCorrectedElement< 2, 3, Kratos::KOmegaSSTElementData::OmegaElementData< 2 > >, Kratos::ConvectionDiffusionReactionResidualBasedFluxCorrectedElement< 3, 4, Kratos::KOmegaSSTElementData::OmegaElementData< 3 > >, Kratos::ConvectionDiffusionReactionResidualBasedFluxCorrectedElement< 2, 3, Kratos::KOmegaElementData::OmegaElementData< 2 > >, Kratos::ConvectionDiffusionReactionResidualBasedFluxCorrectedElement< 3, 4, Kratos::KEpsilonElementData::EpsilonElementData< 3 > >, Kratos::ConvectionDiffusionReactionResidualBasedFluxCorrectedElement< 3, 4, Kratos::KOmegaElementData::KElementData< 3 > >, Kratos::ConvectionDiffusionReactionCrossWindStabilizedElement< 2, 3, Kratos::KEpsilonElementData::EpsilonElementData< 2 > >, Kratos::ConvectionDiffusionReactionCrossWindStabilizedElement< 2, 3, Kratos::KEpsilonElementData::KElementData< 2 > >, Kratos::ConvectionDiffusionReactionCrossWindStabilizedElement< 3, 4, Kratos::KEpsilonElementData::KElementData< 3 > >, Kratos::ConvectionDiffusionReactionCrossWindStabilizedElement< 3, 4, Kratos::KOmegaSSTElementData::KElementData< 3 > >, Kratos::ConvectionDiffusionReactionCrossWindStabilizedElement< 2, 3, Kratos::KOmegaElementData::KElementData< 2 > >, Kratos::ConvectionDiffusionReactionCrossWindStabilizedElement< 2, 3, Kratos::KOmegaSSTElementData::KElementData< 2 > >, Kratos::ConvectionDiffusionReactionCrossWindStabilizedElement< 3, 4, Kratos::KOmegaElementData::OmegaElementData< 3 > >, Kratos::ConvectionDiffusionReactionCrossWindStabilizedElement< 2, 3, Kratos::KOmegaSSTElementData::OmegaElementData< 2 > >, Kratos::ConvectionDiffusionReactionCrossWindStabilizedElement< 3, 4, Kratos::KOmegaSSTElementData::OmegaElementData< 3 > >, Kratos::ConvectionDiffusionReactionCrossWindStabilizedElement< 2, 3, Kratos::KOmegaElementData::OmegaElementData< 2 > >, Kratos::ConvectionDiffusionReactionCrossWindStabilizedElement< 3, 4, Kratos::KEpsilonElementData::EpsilonElementData< 3 > >, and Kratos::ConvectionDiffusionReactionCrossWindStabilizedElement< 3, 4, Kratos::KOmegaElementData::KElementData< 3 > >.
|
overridevirtual |
ELEMENTS inherited from this class have to implement next EquationIdVector and GetDofList methods: MANDATORY this determines the elemental equation ID vector for all elemental DOFs
rResult | the elemental equation ID vector |
rCurrentProcessInfo | the current process info instance |
Reimplemented from Kratos::Element.
|
overridevirtual |
determines the elemental list of DOFs
ElementalDofList | the list of DOFs |
rCurrentProcessInfo | the current process info instance |
Reimplemented from Kratos::Element.
|
overridevirtual |
Getting method to obtain the time derivative of variable which defines the degrees of freedom
Reimplemented from Kratos::Element.
|
overridevirtual |
returns the used integration method. In the general case this is the default integration method of the used geometry. I an other integration method is used the method has to be overwritten within the element
Reimplemented from Kratos::Element.
Reimplemented in Kratos::ConvectionDiffusionReactionResidualBasedFluxCorrectedElement< TDim, TNumNodes, TConvectionDiffusionReactionData >, Kratos::ConvectionDiffusionReactionResidualBasedFluxCorrectedElement< 2, 3, Kratos::KEpsilonElementData::EpsilonElementData< 2 > >, Kratos::ConvectionDiffusionReactionResidualBasedFluxCorrectedElement< 2, 3, Kratos::KEpsilonElementData::KElementData< 2 > >, Kratos::ConvectionDiffusionReactionResidualBasedFluxCorrectedElement< 3, 4, Kratos::KEpsilonElementData::KElementData< 3 > >, Kratos::ConvectionDiffusionReactionResidualBasedFluxCorrectedElement< 3, 4, Kratos::KOmegaSSTElementData::KElementData< 3 > >, Kratos::ConvectionDiffusionReactionResidualBasedFluxCorrectedElement< 2, 3, Kratos::KOmegaElementData::KElementData< 2 > >, Kratos::ConvectionDiffusionReactionResidualBasedFluxCorrectedElement< 2, 3, Kratos::KOmegaSSTElementData::KElementData< 2 > >, Kratos::ConvectionDiffusionReactionResidualBasedFluxCorrectedElement< 3, 4, Kratos::KOmegaElementData::OmegaElementData< 3 > >, Kratos::ConvectionDiffusionReactionResidualBasedFluxCorrectedElement< 2, 3, Kratos::KOmegaSSTElementData::OmegaElementData< 2 > >, Kratos::ConvectionDiffusionReactionResidualBasedFluxCorrectedElement< 3, 4, Kratos::KOmegaSSTElementData::OmegaElementData< 3 > >, Kratos::ConvectionDiffusionReactionResidualBasedFluxCorrectedElement< 2, 3, Kratos::KOmegaElementData::OmegaElementData< 2 > >, Kratos::ConvectionDiffusionReactionResidualBasedFluxCorrectedElement< 3, 4, Kratos::KEpsilonElementData::EpsilonElementData< 3 > >, and Kratos::ConvectionDiffusionReactionResidualBasedFluxCorrectedElement< 3, 4, Kratos::KOmegaElementData::KElementData< 3 > >.
|
overridevirtual |
Getting method to obtain the second time derivative of variable which defines the degrees of freedom
Reimplemented from Kratos::Element.
|
protected |
Get the Values Array.
rValues | Return values array |
Step | Step |
|
overridevirtual |
ELEMENTS inherited from this class must implement this methods if they need the values of the time derivatives of any of the dof set by the element. If the derivatives do not exist can set to zero these methods are: MANDATORY ( when compatibility with dynamics is required ) Getting method to obtain the variable which defines the degrees of freedom
Reimplemented from Kratos::Element.
|
inlineoverridevirtual |
Turn back information as a string.
Reimplemented from Kratos::Element.
Reimplemented in Kratos::ConvectionDiffusionReactionResidualBasedFluxCorrectedElement< TDim, TNumNodes, TConvectionDiffusionReactionData >, Kratos::ConvectionDiffusionReactionResidualBasedFluxCorrectedElement< 2, 3, Kratos::KEpsilonElementData::EpsilonElementData< 2 > >, Kratos::ConvectionDiffusionReactionResidualBasedFluxCorrectedElement< 2, 3, Kratos::KEpsilonElementData::KElementData< 2 > >, Kratos::ConvectionDiffusionReactionResidualBasedFluxCorrectedElement< 3, 4, Kratos::KEpsilonElementData::KElementData< 3 > >, Kratos::ConvectionDiffusionReactionResidualBasedFluxCorrectedElement< 3, 4, Kratos::KOmegaSSTElementData::KElementData< 3 > >, Kratos::ConvectionDiffusionReactionResidualBasedFluxCorrectedElement< 2, 3, Kratos::KOmegaElementData::KElementData< 2 > >, Kratos::ConvectionDiffusionReactionResidualBasedFluxCorrectedElement< 2, 3, Kratos::KOmegaSSTElementData::KElementData< 2 > >, Kratos::ConvectionDiffusionReactionResidualBasedFluxCorrectedElement< 3, 4, Kratos::KOmegaElementData::OmegaElementData< 3 > >, Kratos::ConvectionDiffusionReactionResidualBasedFluxCorrectedElement< 2, 3, Kratos::KOmegaSSTElementData::OmegaElementData< 2 > >, Kratos::ConvectionDiffusionReactionResidualBasedFluxCorrectedElement< 3, 4, Kratos::KOmegaSSTElementData::OmegaElementData< 3 > >, Kratos::ConvectionDiffusionReactionResidualBasedFluxCorrectedElement< 2, 3, Kratos::KOmegaElementData::OmegaElementData< 2 > >, Kratos::ConvectionDiffusionReactionResidualBasedFluxCorrectedElement< 3, 4, Kratos::KEpsilonElementData::EpsilonElementData< 3 > >, Kratos::ConvectionDiffusionReactionResidualBasedFluxCorrectedElement< 3, 4, Kratos::KOmegaElementData::KElementData< 3 > >, Kratos::ConvectionDiffusionReactionCrossWindStabilizedElement< 2, 3, Kratos::KEpsilonElementData::EpsilonElementData< 2 > >, Kratos::ConvectionDiffusionReactionCrossWindStabilizedElement< 2, 3, Kratos::KEpsilonElementData::KElementData< 2 > >, Kratos::ConvectionDiffusionReactionCrossWindStabilizedElement< 3, 4, Kratos::KEpsilonElementData::KElementData< 3 > >, Kratos::ConvectionDiffusionReactionCrossWindStabilizedElement< 3, 4, Kratos::KOmegaSSTElementData::KElementData< 3 > >, Kratos::ConvectionDiffusionReactionCrossWindStabilizedElement< 2, 3, Kratos::KOmegaElementData::KElementData< 2 > >, Kratos::ConvectionDiffusionReactionCrossWindStabilizedElement< 2, 3, Kratos::KOmegaSSTElementData::KElementData< 2 > >, Kratos::ConvectionDiffusionReactionCrossWindStabilizedElement< 3, 4, Kratos::KOmegaElementData::OmegaElementData< 3 > >, Kratos::ConvectionDiffusionReactionCrossWindStabilizedElement< 2, 3, Kratos::KOmegaSSTElementData::OmegaElementData< 2 > >, Kratos::ConvectionDiffusionReactionCrossWindStabilizedElement< 3, 4, Kratos::KOmegaSSTElementData::OmegaElementData< 3 > >, Kratos::ConvectionDiffusionReactionCrossWindStabilizedElement< 2, 3, Kratos::KOmegaElementData::OmegaElementData< 2 > >, Kratos::ConvectionDiffusionReactionCrossWindStabilizedElement< 3, 4, Kratos::KEpsilonElementData::EpsilonElementData< 3 > >, and Kratos::ConvectionDiffusionReactionCrossWindStabilizedElement< 3, 4, Kratos::KOmegaElementData::KElementData< 3 > >.
Kratos::ConvectionDiffusionReactionElement< TDim, TNumNodes, TConvectionDiffusionReactionData >::KRATOS_CLASS_INTRUSIVE_POINTER_DEFINITION | ( | ConvectionDiffusionReactionElement< TDim, TNumNodes, TConvectionDiffusionReactionData > | ) |
|
inlineoverridevirtual |
Print information about this object.
Reimplemented from Kratos::Element.
Reimplemented in Kratos::ConvectionDiffusionReactionResidualBasedFluxCorrectedElement< TDim, TNumNodes, TConvectionDiffusionReactionData >, Kratos::ConvectionDiffusionReactionResidualBasedFluxCorrectedElement< 2, 3, Kratos::KEpsilonElementData::EpsilonElementData< 2 > >, Kratos::ConvectionDiffusionReactionResidualBasedFluxCorrectedElement< 2, 3, Kratos::KEpsilonElementData::KElementData< 2 > >, Kratos::ConvectionDiffusionReactionResidualBasedFluxCorrectedElement< 3, 4, Kratos::KEpsilonElementData::KElementData< 3 > >, Kratos::ConvectionDiffusionReactionResidualBasedFluxCorrectedElement< 3, 4, Kratos::KOmegaSSTElementData::KElementData< 3 > >, Kratos::ConvectionDiffusionReactionResidualBasedFluxCorrectedElement< 2, 3, Kratos::KOmegaElementData::KElementData< 2 > >, Kratos::ConvectionDiffusionReactionResidualBasedFluxCorrectedElement< 2, 3, Kratos::KOmegaSSTElementData::KElementData< 2 > >, Kratos::ConvectionDiffusionReactionResidualBasedFluxCorrectedElement< 3, 4, Kratos::KOmegaElementData::OmegaElementData< 3 > >, Kratos::ConvectionDiffusionReactionResidualBasedFluxCorrectedElement< 2, 3, Kratos::KOmegaSSTElementData::OmegaElementData< 2 > >, Kratos::ConvectionDiffusionReactionResidualBasedFluxCorrectedElement< 3, 4, Kratos::KOmegaSSTElementData::OmegaElementData< 3 > >, Kratos::ConvectionDiffusionReactionResidualBasedFluxCorrectedElement< 2, 3, Kratos::KOmegaElementData::OmegaElementData< 2 > >, Kratos::ConvectionDiffusionReactionResidualBasedFluxCorrectedElement< 3, 4, Kratos::KEpsilonElementData::EpsilonElementData< 3 > >, Kratos::ConvectionDiffusionReactionResidualBasedFluxCorrectedElement< 3, 4, Kratos::KOmegaElementData::KElementData< 3 > >, Kratos::ConvectionDiffusionReactionCrossWindStabilizedElement< 2, 3, Kratos::KEpsilonElementData::EpsilonElementData< 2 > >, Kratos::ConvectionDiffusionReactionCrossWindStabilizedElement< 2, 3, Kratos::KEpsilonElementData::KElementData< 2 > >, Kratos::ConvectionDiffusionReactionCrossWindStabilizedElement< 3, 4, Kratos::KEpsilonElementData::KElementData< 3 > >, Kratos::ConvectionDiffusionReactionCrossWindStabilizedElement< 3, 4, Kratos::KOmegaSSTElementData::KElementData< 3 > >, Kratos::ConvectionDiffusionReactionCrossWindStabilizedElement< 2, 3, Kratos::KOmegaElementData::KElementData< 2 > >, Kratos::ConvectionDiffusionReactionCrossWindStabilizedElement< 2, 3, Kratos::KOmegaSSTElementData::KElementData< 2 > >, Kratos::ConvectionDiffusionReactionCrossWindStabilizedElement< 3, 4, Kratos::KOmegaElementData::OmegaElementData< 3 > >, Kratos::ConvectionDiffusionReactionCrossWindStabilizedElement< 2, 3, Kratos::KOmegaSSTElementData::OmegaElementData< 2 > >, Kratos::ConvectionDiffusionReactionCrossWindStabilizedElement< 3, 4, Kratos::KOmegaSSTElementData::OmegaElementData< 3 > >, Kratos::ConvectionDiffusionReactionCrossWindStabilizedElement< 2, 3, Kratos::KOmegaElementData::OmegaElementData< 2 > >, Kratos::ConvectionDiffusionReactionCrossWindStabilizedElement< 3, 4, Kratos::KEpsilonElementData::EpsilonElementData< 3 > >, and Kratos::ConvectionDiffusionReactionCrossWindStabilizedElement< 3, 4, Kratos::KOmegaElementData::KElementData< 3 > >.
|
friend |