![]() |
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 <embedded_navier_stokes.h>
Classes | |
struct | EmbeddedElementDataStruct |
Public Member Functions | |
Life Cycle | |
EmbeddedNavierStokes (IndexType NewId, GeometryPointerType pGeometry) | |
Default constructor. More... | |
EmbeddedNavierStokes (IndexType NewId, GeometryPointerType pGeometry, PropertiesPointerType pProperties) | |
~EmbeddedNavierStokes () override | |
Destructor. More... | |
Operations | |
Element::Pointer | Create (IndexType NewId, NodesArrayType const &rThisNodes, Element::PropertiesType::Pointer pProperties) const override |
Element::Pointer | Create (IndexType NewId, Element::GeometryType::Pointer pGeom, Element::PropertiesType::Pointer pProperties) const override |
Element::Pointer | Clone (IndexType NewId, NodesArrayType const &rThisNodes) const override |
void | FillEmbeddedElementData (EmbeddedElementDataStruct &rData, const ProcessInfo &rCurrentProcessInfo) |
void | CalculateLocalSystem (MatrixType &rLeftHandSideMatrix, VectorType &rRightHandSideVector, const ProcessInfo &rCurrentProcessInfo) override |
template<unsigned int MatrixSize> | |
void | ComputeElementAsFluid (MatrixType &rLeftHandSideMatrix, VectorType &rRightHandSideVector, EmbeddedElementDataStruct &rData, const ProcessInfo &rCurrentProcessInfo) |
template<unsigned int MatrixSize> | |
void | ComputeElementAsMixed (MatrixType &rLeftHandSideMatrix, VectorType &rRightHandSideVector, EmbeddedElementDataStruct &rData, const ProcessInfo &rCurrentProcessInfo) |
int | Check (const ProcessInfo &rCurrentProcessInfo) const override |
void | Calculate (const Variable< array_1d< double, 3 >> &rVariable, array_1d< double, 3 > &rOutput, const ProcessInfo &rCurrentProcessInfo) override |
void | Calculate (const Variable< double > &rVariable, double &Output, const ProcessInfo &rCurrentProcessInfo) override |
void | Calculate (const Variable< Vector > &rVariable, Vector &Output, const ProcessInfo &rCurrentProcessInfo) override |
void | Calculate (const Variable< Matrix > &rVariable, Matrix &Output, const ProcessInfo &rCurrentProcessInfo) override |
Input and output | |
std::string | Info () const override |
Turn back information as a string. More... | |
![]() | |
KRATOS_CLASS_INTRUSIVE_POINTER_DEFINITION (NavierStokes) | |
Counted pointer of. More... | |
NavierStokes (IndexType NewId, GeometryType::Pointer pGeometry) | |
Default constructor. More... | |
NavierStokes (IndexType NewId, GeometryType::Pointer pGeometry, PropertiesType::Pointer pProperties) | |
~NavierStokes () override | |
Destructor. More... | |
Element::Pointer | Create (IndexType NewId, NodesArrayType const &rThisNodes, PropertiesType::Pointer pProperties) const override |
It creates a new element pointer. More... | |
Element::Pointer | Create (IndexType NewId, GeometryType::Pointer pGeom, PropertiesType::Pointer pProperties) const override |
It creates a new element pointer. More... | |
void | CalculateLocalSystem (MatrixType &rLeftHandSideMatrix, VectorType &rRightHandSideVector, const ProcessInfo &rCurrentProcessInfo) override |
void | CalculateRightHandSide (VectorType &rRightHandSideVector, const ProcessInfo &rCurrentProcessInfo) override |
int | Check (const ProcessInfo &rCurrentProcessInfo) const override |
Checks the input and that all required Kratos variables have been registered. More... | |
void | Calculate (const Variable< double > &rVariable, double &rOutput, const ProcessInfo &rCurrentProcessInfo) override |
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... | |
![]() | |
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 IntegrationMethod | GetIntegrationMethod () const |
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 | 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 | CalculateMassMatrix (MatrixType &rMassMatrix, const ProcessInfo &rCurrentProcessInfo) |
virtual void | CalculateDampingMatrix (MatrixType &rDampingMatrix, 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< array_1d< double, 3 > > &rVariable, array_1d< double, 3 > &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 | CalculateLocalVelocityContribution (MatrixType &rDampingMatrix, VectorType &rRightHandSideVector, const ProcessInfo &rCurrentProcessInfo) |
virtual void | CalculateSensitivityMatrix (const Variable< double > &rDesignVariable, Matrix &rOutput, const ProcessInfo &rCurrentProcessInfo) |
virtual void | CalculateSensitivityMatrix (const Variable< array_1d< double, 3 > > &rDesignVariable, Matrix &rOutput, const ProcessInfo &rCurrentProcessInfo) |
PropertiesType::Pointer | pGetProperties () |
returns the pointer to the property of the element. Does not throw an error, to allow copying of elements which don't have any property assigned. More... | |
const PropertiesType::Pointer | pGetProperties () const |
PropertiesType & | GetProperties () |
PropertiesType const & | GetProperties () const |
void | SetProperties (PropertiesType::Pointer pProperties) |
bool | HasProperties () const |
Check that the Element has a correctly initialized pointer to a Properties instance. More... | |
virtual const Parameters | GetSpecifications () const |
This method provides the specifications/requirements of the element. More... | |
void | PrintData (std::ostream &rOStream) const override |
Print object's data. More... | |
KRATOS_CLASS_INTRUSIVE_POINTER_DEFINITION (Element) | |
![]() | |
GeometricalObject (IndexType NewId=0) | |
Default constructor. More... | |
GeometricalObject (IndexType NewId, GeometryType::Pointer pGeometry) | |
Default constructor. More... | |
~GeometricalObject () override | |
Destructor. More... | |
GeometricalObject (GeometricalObject const &rOther) | |
Copy constructor. More... | |
GeometricalObject & | operator= (GeometricalObject const &rOther) |
Assignment operator. More... | |
virtual void | SetGeometry (GeometryType::Pointer pGeometry) |
Sets the pointer to the geometry. More... | |
GeometryType::Pointer | pGetGeometry () |
Returns the pointer to the geometry. More... | |
const GeometryType::Pointer | pGetGeometry () const |
Returns the pointer to the geometry (const version) More... | |
GeometryType & | GetGeometry () |
Returns the reference of the geometry. More... | |
GeometryType const & | GetGeometry () const |
Returns the reference of the geometry (const version) More... | |
Flags & | GetFlags () |
Returns the flags of the object. More... | |
Flags const & | GetFlags () const |
Returns the flags of the object (const version) More... | |
void | SetFlags (Flags const &rThisFlags) |
Sets the flags of the object. More... | |
DataValueContainer & | Data () |
DataValueContainer & | GetData () |
DataValueContainer const & | GetData () const |
void | SetData (DataValueContainer const &rThisData) |
template<class TDataType > | |
bool | Has (const Variable< TDataType > &rThisVariable) const |
template<class TVariableType > | |
void | SetValue (const TVariableType &rThisVariable, typename TVariableType::Type const &rValue) |
template<class TVariableType > | |
TVariableType::Type & | GetValue (const TVariableType &rThisVariable) |
template<class TVariableType > | |
TVariableType::Type const & | GetValue (const TVariableType &rThisVariable) const |
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... | |
![]() | |
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 Operators | |
EmbeddedNavierStokes () | |
Protected Operations | |
void | AddIntersectionBoundaryTermsContribution (MatrixType &rLeftHandSideMatrix, VectorType &rRightHandSideVector, const EmbeddedElementDataStruct &rData) |
double | ComputePenaltyCoefficient (const EmbeddedElementDataStruct &rData, const ProcessInfo &rCurrentProcessInfo) |
void | AddBoundaryConditionPenaltyContribution (MatrixType &rLeftHandSideMatrix, VectorType &rRightHandSideVector, const EmbeddedElementDataStruct &rData, const ProcessInfo &rCurrentProcessInfo) |
void | AddBoundaryConditionModifiedNitcheContribution (MatrixType &rLeftHandSideMatrix, VectorType &rRightHandSideVector, const EmbeddedElementDataStruct &rData) |
void | DropOuterNodesVelocityContribution (MatrixType &rLeftHandSideMatrix, VectorType &rRightHandSideVector, const EmbeddedElementDataStruct &rData) |
void | AddSlipWinterNormalPenaltyContribution (MatrixType &rLeftHandSideMatrix, VectorType &rRightHandSideVector, const EmbeddedElementDataStruct &rData, const ProcessInfo &rCurrentProcessInfo) |
void | AddSlipWinterNormalSymmetricCounterpartContribution (MatrixType &rLeftHandSideMatrix, VectorType &rRightHandSideVector, const EmbeddedElementDataStruct &rData) |
void | AddSlipWinterTangentialPenaltyContribution (MatrixType &rLeftHandSideMatrix, VectorType &rRightHandSideVector, const EmbeddedElementDataStruct &rData, const ProcessInfo &rCurrentProcessInfo) |
void | AddSlipWinterTangentialSymmetricCounterpartContribution (MatrixType &rLeftHandSideMatrix, VectorType &rRightHandSideVector, const EmbeddedElementDataStruct &rData, const ProcessInfo &rCurrentProcessInfo) |
void | AddBoundaryConditionElementContribution (MatrixType &rLeftHandSideMatrix, VectorType &rRightHandSideVector, const EmbeddedElementDataStruct &rData, const ProcessInfo &rCurrentProcessInfo) |
void | SetInterfaceStrainMatrix (const BoundedMatrix< double, TNumNodes, TDim > &rDN_DX, BoundedMatrix< double,(TDim-1) *3, TNumNodes *(TDim+1)> &rB_matrix) |
void | SetNormalProjectionMatrix (const array_1d< double, 3 > &rUnitNormal, BoundedMatrix< double, TDim, TDim > &rNormProjMatrix) |
void | SetTangentialProjectionMatrix (const array_1d< double, 3 > &rUnitNormal, BoundedMatrix< double, TDim, TDim > &rTangProjMatrix) |
void | SetVoigtNormalProjectionMatrix (const array_1d< double, 3 > &rUnitNormal, BoundedMatrix< double, TDim,(TDim-1) *3 > &rVoigtNormProjMatrix) |
void | GetPreviousSolutionVector (const ElementDataType &rData, array_1d< double, TNumNodes *(TDim+1)> &rPrevSolVector) |
![]() | |
void | GetDofList (DofsVectorType &ElementalDofList, const ProcessInfo &rCurrentProcessInfo) const |
void | GetDofList (DofsVectorType &ElementalDofList, const ProcessInfo &rCurrentProcessInfo) const |
void | EquationIdVector (EquationIdVectorType &rResult, const ProcessInfo &rCurrentProcessInfo) const |
void | EquationIdVector (EquationIdVectorType &rResult, const ProcessInfo &rCurrentProcessInfo) const |
void | ComputeGaussPointLHSContribution (BoundedMatrix< double, 16, 16 > &lhs, const ElementDataStruct &data) |
void | ComputeGaussPointLHSContribution (BoundedMatrix< double, 9, 9 > &lhs, const ElementDataStruct &data) |
void | ComputeGaussPointRHSContribution (array_1d< double, 16 > &rhs, const ElementDataStruct &data) |
void | ComputeGaussPointRHSContribution (array_1d< double, 9 > &rhs, const ElementDataStruct &data) |
double | SubscaleErrorEstimate (const ElementDataStruct &data) |
double | SubscaleErrorEstimate (const ElementDataStruct &data) |
NavierStokes () | |
void | Initialize (const ProcessInfo &rCurrentProcessInfo) override |
void | FillElementData (ElementDataStruct &rData, const ProcessInfo &rCurrentProcessInfo) |
double | ComputeH (BoundedMatrix< double, TNumNodes, TDim > &DN_DX) |
void | GetShapeFunctionsOnGauss (BoundedMatrix< double, 4, 4 > &Ncontainer) |
void | GetShapeFunctionsOnGauss (BoundedMatrix< double, 3, 3 > &Ncontainer) |
void | GetShapeFunctionsOnUniqueGauss (BoundedMatrix< double, 1, 4 > &Ncontainer) |
void | GetShapeFunctionsOnUniqueGauss (BoundedMatrix< double, 1, 3 > &Ncontainer) |
void | ComputeStrain (ElementDataStruct &rData, const unsigned int &strain_size) |
virtual void | ComputeConstitutiveResponse (ElementDataStruct &rData, const ProcessInfo &rCurrentProcessInfo) |
virtual double | ComputeEffectiveViscosity (const ElementDataStruct &rData) |
void | GetDofList (DofsVectorType &ElementalDofList, const ProcessInfo &rCurrentProcessInfo) const override |
void | EquationIdVector (EquationIdVectorType &rResult, const ProcessInfo &rCurrentProcessInfo) const override |
void | ComputeGaussPointLHSContribution (BoundedMatrix< double, TNumNodes *(TDim+1), TNumNodes *(TDim+1)> &lhs, const ElementDataStruct &data) |
void | ComputeGaussPointRHSContribution (array_1d< double, TNumNodes *(TDim+1)> &rhs, const ElementDataStruct &data) |
double | SubscaleErrorEstimate (const ElementDataStruct &data) |
Type Definitions | |
typedef NavierStokes< TDim, TNumNodes > | BaseType |
typedef BaseType::ElementDataStruct | ElementDataType |
typedef BaseType::VectorType | VectorType |
typedef BaseType::MatrixType | MatrixType |
typedef BaseType::IndexType | IndexType |
typedef BaseType::GeometryType::Pointer | GeometryPointerType |
typedef BaseType::NodesArrayType | NodesArrayType |
typedef BaseType::PropertiesType::Pointer | PropertiesPointerType |
typedef BaseType::GeometryType::ShapeFunctionsGradientsType | ShapeFunctionsGradientsType |
KRATOS_CLASS_INTRUSIVE_POINTER_DEFINITION (EmbeddedNavierStokes) | |
Counted pointer of. More... | |
Serialization | |
class | Serializer |
Additional Inherited Members | |
![]() | |
typedef Element | ElementType |
definition of element type More... | |
typedef GeometricalObject | BaseType |
base type: an GeometricalObject that automatically has a unique number More... | |
typedef Node | NodeType |
definition of node type (default is: Node) More... | |
typedef Properties | PropertiesType |
typedef Geometry< NodeType > | GeometryType |
definition of the geometry type with given NodeType More... | |
typedef Geometry< NodeType >::PointsArrayType | NodesArrayType |
definition of nodes container type, redefined from GeometryType More... | |
typedef Vector | VectorType |
typedef Matrix | MatrixType |
typedef std::size_t | IndexType |
typedef std::size_t | SizeType |
typedef Dof< double > | DofType |
typedef std::vector< std::size_t > | EquationIdVectorType |
typedef std::vector< DofType::Pointer > | DofsVectorType |
typedef PointerVectorSet< DofType > | DofsArrayType |
typedef GeometryData::IntegrationMethod | IntegrationMethod |
Type definition for integration methods. More... | |
typedef GeometryData | GeometryDataType |
![]() | |
typedef Node | NodeType |
Definition of the node type. More... | |
typedef Geometry< NodeType > | GeometryType |
The geometry type definition. More... | |
typedef std::size_t | IndexType |
Defines the index type. More... | |
typedef std::size_t | result_type |
Defines the result type. More... | |
![]() | |
typedef std::size_t | IndexType |
The definition of the index type. More... | |
typedef std::size_t | result_type |
The definition of the result_type. More... | |
![]() | |
enum | FlagsList { Flag0 = BlockType(1) , Flag1 = BlockType(1) << 1 , Flag2 = BlockType(1) << 2 , Flag3 = BlockType(1) << 3 , Flag4 = BlockType(1) << 4 , Flag5 = BlockType(1) << 5 , Flag6 = BlockType(1) << 6 , Flag7 = BlockType(1) << 7 , Flag8 = BlockType(1) << 8 , Flag9 = BlockType(1) << 9 , Flag10 = BlockType(1) << 10 , Flag11 = BlockType(1) << 11 , Flag12 = BlockType(1) << 12 , Flag13 = BlockType(1) << 13 , Flag14 = BlockType(1) << 14 , Flag15 = BlockType(1) << 15 , Flag16 = BlockType(1) << 16 , Flag17 = BlockType(1) << 17 , Flag18 = BlockType(1) << 18 , Flag19 = BlockType(1) << 19 , Flag20 = BlockType(1) << 20 , Flag21 = BlockType(1) << 21 , Flag22 = BlockType(1) << 22 , Flag23 = BlockType(1) << 23 , Flag24 = BlockType(1) << 24 , Flag25 = BlockType(1) << 25 , Flag26 = BlockType(1) << 26 , Flag27 = BlockType(1) << 27 , Flag28 = BlockType(1) << 28 , Flag29 = BlockType(1) << 29 , Flag30 = BlockType(1) << 30 } |
typedef int64_t | BlockType |
typedef int64_t | FlagType |
typedef std::size_t | IndexType |
![]() | |
static bool | HasSameType (const GeometricalObject &rLHS, const GeometricalObject &rRHS) |
Checks if two GeometricalObject have the same type. More... | |
static bool | HasSameType (const GeometricalObject *rLHS, const GeometricalObject *rRHS) |
Checks if two GeometricalObject have the same type (pointer version) More... | |
static bool | HasSameGeometryType (const GeometricalObject &rLHS, const GeometricalObject &rRHS) |
Checks if two GeometricalObject have the same geometry type. More... | |
static bool | HasSameGeometryType (const GeometricalObject *rLHS, const GeometricalObject *rRHS) |
Checks if two GeometricalObject have the same geometry type (pointer version) More... | |
static bool | IsSame (const GeometricalObject &rLHS, const GeometricalObject &rRHS) |
Checks if two GeometricalObject are the same. More... | |
static bool | IsSame (const GeometricalObject *rLHS, const GeometricalObject *rRHS) |
Checks if two GeometricalObject are the same (pointer version) More... | |
![]() | |
static const Flags | AllDefined () |
static const Flags | AllTrue () |
static Flags | Create (IndexType ThisPosition, bool Value=true) |
![]() | |
ConstitutiveLaw::Pointer | mpConstitutiveLaw |
This is a 2D and 3D Navier-Stokes embedded element, stabilized by employing an ASGS stabilization Both the formulation and the symbolic implementation can be found in the symbolic_generation folder of the FluidDynamicsApplication.
typedef NavierStokes<TDim, TNumNodes> Kratos::EmbeddedNavierStokes< TDim, TNumNodes >::BaseType |
typedef BaseType::ElementDataStruct Kratos::EmbeddedNavierStokes< TDim, TNumNodes >::ElementDataType |
typedef BaseType::GeometryType::Pointer Kratos::EmbeddedNavierStokes< TDim, TNumNodes >::GeometryPointerType |
typedef BaseType::IndexType Kratos::EmbeddedNavierStokes< TDim, TNumNodes >::IndexType |
typedef BaseType::MatrixType Kratos::EmbeddedNavierStokes< TDim, TNumNodes >::MatrixType |
typedef BaseType::NodesArrayType Kratos::EmbeddedNavierStokes< TDim, TNumNodes >::NodesArrayType |
typedef BaseType::PropertiesType::Pointer Kratos::EmbeddedNavierStokes< TDim, TNumNodes >::PropertiesPointerType |
typedef BaseType::GeometryType::ShapeFunctionsGradientsType Kratos::EmbeddedNavierStokes< TDim, TNumNodes >::ShapeFunctionsGradientsType |
typedef BaseType::VectorType Kratos::EmbeddedNavierStokes< TDim, TNumNodes >::VectorType |
|
inline |
Default constructor.
|
inline |
|
inlineoverride |
Destructor.
|
inlineprotected |
|
inlineprotected |
This functions collects and adds all the level set boundary condition contributions
rLeftHandSideMatrix | reference to the LHS matrix |
rRightHandSideVector | reference to the RHS vector |
rData | reference to element data structure |
|
inlineprotected |
This functions adds the level set strong boundary condition imposition contribution.
rLeftHandSideMatrix | reference to the LHS matrix |
rRightHandSideVector | reference to the RHS vector |
rData | reference to element data structure |
|
inlineprotected |
This functions adds the penalty extra term level set contribution.
rLeftHandSideMatrix | reference to the LHS matrix |
rRightHandSideVector | reference to the RHS vector |
rData | reference to element data structure |
|
inlineprotected |
This functions adds the contribution of the boundary terms in the level set cut These terms, which do not vanish at the level set since the test function is not zero at the intersection points, come from the integration by parts of the stress term.
rLeftHandSideMatrix | reference to the LHS matrix |
rRightHandSideVector | reference to the RHS vector |
rData | reference to element data structure |
|
inlineprotected |
This function adds the Nitsche normal component of the penalty contribution (Winter formulation).
rLeftHandSideMatrix | reference to the LHS matrix |
rRightHandSideVector | reference to the RHS vector |
rData | reference to element data structure |
|
inlineprotected |
This function adds the Nitsche normal component of the symmetric counterpart of the fluxes (Winter formulation).
rLeftHandSideMatrix | reference to the LHS matrix |
rRightHandSideVector | reference to the RHS vector |
rData | reference to element data structure |
|
inlineprotected |
This function adds the Nitsche tangential component of the penalty contribution (Winter formulation).
rLeftHandSideMatrix | reference to the LHS matrix |
rRightHandSideVector | reference to the RHS vector |
rData | reference to element data structure |
|
inlineprotected |
This function adds the Nitsche tangential component of the symmetric counterpart of the fluxes (Winter formulation).
rLeftHandSideMatrix | reference to the LHS matrix |
rRightHandSideVector | reference to the RHS vector |
rData | reference to element data structure |
|
inlineoverride |
Given a vector variable, this function computes its value inside de element. If the function has not implemented this variable computation, throws an error.
rVariable | Variable to be computed. |
rOutput | Reference to the output array. |
rCurrentProcessInfo | Reference to the process info. |
|
inlineoverridevirtual |
Calculate a Element variable usually associated to a integration point the Output is given on integration points and characterizes the element Calculate(..) methods are: OPTIONAL
Reimplemented from Kratos::Element.
|
inlineoverridevirtual |
Reimplemented from Kratos::Element.
|
inlineoverridevirtual |
Reimplemented from Kratos::Element.
|
inlineoverridevirtual |
Calculates both LHS and RHS contributions
rLeftHandSideMatrix | reference to the LHS matrix |
rRightHandSideVector | reference to the RHS vector |
rCurrentProcessInfo | reference to the ProcessInfo |
Reimplemented from Kratos::Element.
|
inlineoverridevirtual |
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 ProcessInfo of the ModelPart that contains this element. |
Reimplemented from Kratos::Element.
|
inlineoverridevirtual |
Clones the selected element variables, creating a new one
NewId | the ID of the new element |
rThisNodes | the nodes of the new element |
Reimplemented from Kratos::Element.
|
inline |
Calculates both LHS and RHS elemental contributions for those cases in where all the nodes belong to the fluid domain.
rLeftHandSideMatrix | reference to the LHS matrix |
rRightHandSideVector | reference to the RHS vector |
rData | reference to element data structure |
rCurrentProcessInfo | reference to the ProcessInfo |
|
inline |
Calculates both LHS and RHS elemental contributions for those cases in where the element has both fluid and structure nodes.
rLeftHandSideMatrix | reference to the LHS matrix |
rRightHandSideVector | reference to the RHS vector |
rData | reference to element data structure |
rCurrentProcessInfo | reference to the ProcessInfo |
|
inlineprotected |
This function computes the penalty coefficient for the level set BC imposition
rLeftHandSideMatrix | reference to the LHS matrix |
rData | reference to element data structure |
|
inlineoverride |
|
inlineoverride |
|
inlineprotected |
This drops the outer nodes velocity constributions in both LHS and RHS matrices.
rLeftHandSideMatrix | reference to the LHS matrix |
rRightHandSideVector | reference to the RHS vector |
rData | reference to element data structure |
|
inline |
Fill the element data structure. If the element is split, calls the modified shape functions calculator.
rData | reference to the element data structure |
rCurrentProcessInfo | reference to the ProcessInfo |
|
inlineprotected |
This functions sets a vector containing the element previous solution
rData | reference to the element data structure |
rPrevSolVector | reference to the previous solution vector |
|
inlineoverridevirtual |
Turn back information as a string.
Reimplemented from Kratos::Element.
Kratos::EmbeddedNavierStokes< TDim, TNumNodes >::KRATOS_CLASS_INTRUSIVE_POINTER_DEFINITION | ( | EmbeddedNavierStokes< TDim, TNumNodes > | ) |
Counted pointer of.
|
inlineprotected |
This functions sets the B strain matrix (pressure columns are set to zero)
rDN_DX | reference to the current Gauss pt. shape function gradients |
rB_matrix | reference to the computed B strain matrix |
|
inlineprotected |
This functions sets the normal projection matrix nxn
rUnitNormal | reference to Gauss pt. unit normal vector |
rNormProjMatrix | reference to the computed normal projection matrix |
|
inlineprotected |
This functions sets the tangential projection matrix I - nxn
rUnitNormal | reference to Gauss pt. unit normal vector |
rTangProjMatrix | reference to the computed tangential projection matrix |
|
inlineprotected |
This functions sets the auxiliar matrix to compute the normal projection in Voigt notation
rUnitNormal | reference to Gauss pt. unit normal vector |
rVoigtNormProjMatrix | reference to the computed normal projection auxiliar matrix |
|
friend |