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.
List of all members
Kratos::FractionalStepStrategy< TSparseSpace, TDenseSpace, TLinearSolver > Class Template Reference

Fractional-step strategy for incompressible Navier-Stokes formulation This strategy implements a splitting scheme for the incompressible Navier-Stokes equations. It is intended to be used in combination with the FractionalStep element in the FluidDynamicsApplication. The fractional step index, which is stored in the ProcessInfo, takes the values 1 : Momentum step (calculate fractional step velocity) 2-3 : Unused (reserved for componentwise calculation of frac step velocity) 4 : Pressure step 5 : Computation of projections 6 : End of step velocity. More...

#include <fractional_step_strategy.h>

Inheritance diagram for Kratos::FractionalStepStrategy< TSparseSpace, TDenseSpace, TLinearSolver >:
Collaboration diagram for Kratos::FractionalStepStrategy< TSparseSpace, TDenseSpace, TLinearSolver >:

Public Member Functions

Life Cycle
 FractionalStepStrategy (ModelPart &rModelPart, SolverSettingsType &rSolverConfig, bool PredictorCorrector)
 
 FractionalStepStrategy (ModelPart &rModelPart, SolverSettingsType &rSolverConfig, bool PredictorCorrector, const Kratos::Variable< int > &PeriodicVar)
 
 FractionalStepStrategy (ModelPart &rModelPart, SolverSettingsType &rSolverConfig, bool PredictorCorrector, bool CalculateReactionsFlag)
 
 FractionalStepStrategy (ModelPart &rModelPart, SolverSettingsType &rSolverConfig, bool PredictorCorrector, bool CalculateReactionsFlag, const Kratos::Variable< int > &PeriodicVar)
 
 ~FractionalStepStrategy () override
 Destructor. More...
 
Operations
void Initialize () override
 Initialization of member variables and prior operations. More...
 
int Check () override
 Function to perform expensive checks. More...
 
void InitializeSolutionStep () override
 Performs all the required operations that should be done (for each step) before solving the solution step. More...
 
bool SolveSolutionStep () override
 Solves the current step. This function returns true if a solution has been found, false otherwise. More...
 
void FinalizeSolutionStep () override
 Performs all the required operations that should be done (for each step) after solving the solution step. More...
 
virtual void CalculateReactions ()
 Calculates the reactions This methods calculates the reactions of the momentum equation. These are computed as minus the RHS and saved in the REACTION variable. More...
 
virtual void AddIterationStep (Process::Pointer pNewStep)
 
virtual void ClearExtraIterationSteps ()
 
void Clear () override
 Clears the internal storage. More...
 
Access
void SetEchoLevel (int Level) override
 This sets the level of echo for the solving strategy. More...
 
void SetCalculateReactionsFlag (bool CalculateReactionsFlag)
 This method sets the flag mCalculateReactionsFlag. More...
 
bool GetCalculateReactionsFlag ()
 This method returns the flag mCalculateReactionsFlag. More...
 
Input and output
std::string Info () const override
 Turn back information as a string. More...
 
void PrintInfo (std::ostream &rOStream) const override
 Print information about this object. More...
 
void PrintData (std::ostream &rOStream) const override
 Print object's data. More...
 
- Public Member Functions inherited from Kratos::ImplicitSolvingStrategy< TSparseSpace, TDenseSpace, TLinearSolver >
 ImplicitSolvingStrategy ()
 Default constructor. More...
 
 ImplicitSolvingStrategy (ModelPart &rModelPart, Parameters ThisParameters)
 Default constructor. (with parameters) More...
 
 ImplicitSolvingStrategy (ModelPart &rModelPart, bool MoveMeshFlag=false)
 Default constructor. More...
 
virtual ~ImplicitSolvingStrategy ()
 
BaseType::Pointer Create (ModelPart &rModelPart, Parameters ThisParameters) const override
 Create method. More...
 
void SetRebuildLevel (int Level) override
 This sets the build level. More...
 
int GetRebuildLevel () const override
 This returns the build level. More...
 
void SetStiffnessMatrixIsBuilt (const bool StiffnessMatrixIsBuilt)
 This method sets the flag mStiffnessMatrixIsBuilt. More...
 
bool GetStiffnessMatrixIsBuilt () const
 This method gets the flag mStiffnessMatrixIsBuilt. More...
 
 KRATOS_CLASS_POINTER_DEFINITION (ImplicitSolvingStrategy)
 
Parameters GetDefaultParameters () const override
 This method provides the defaults parameters to avoid conflicts between the different constructors. More...
 
- Public Member Functions inherited from Kratos::SolvingStrategy< TSparseSpace, TDenseSpace >
 SolvingStrategy ()
 Default constructor. More...
 
 SolvingStrategy (ModelPart &rModelPart, Parameters ThisParameters)
 Default constructor. (with parameters) More...
 
 SolvingStrategy (ModelPart &rModelPart, bool MoveMeshFlag=false)
 Default constructor. More...
 
virtual ~SolvingStrategy ()
 
 KRATOS_CLASS_POINTER_DEFINITION (SolvingStrategy)
 
virtual void Predict ()
 Operation to predict the solution ... if it is not called a trivial predictor is used in which the values of the solution step of interest are assumed equal to the old values. More...
 
virtual double Solve ()
 The problem of interest is solved. More...
 
virtual bool IsConverged ()
 This should be considered as a "post solution" convergence check which is useful for coupled analysis. More...
 
virtual void CalculateOutputData ()
 This operations should be called before printing the results when non trivial results (e.g. stresses) need to be calculated given the solution of the step. More...
 
int GetEchoLevel ()
 This returns the level of echo for the solving strategy. More...
 
void SetMoveMeshFlag (bool Flag)
 This function sets the flag that says if the mesh is moved. More...
 
bool MoveMeshFlag ()
 This function returns the flag that says if the mesh is moved. More...
 
bool GetMoveMeshFlag ()
 This function returns the flag that says if the mesh is moved. More...
 
virtual void MoveMesh ()
 This function is designed to move the mesh. More...
 
ModelPartGetModelPart ()
 Operations to get the pointer to the model. More...
 
const ModelPartGetModelPart () const
 Operations to get the pointer to the model. More...
 
virtual double GetResidualNorm ()
 Operations to get the residual norm. More...
 
virtual TSystemMatrixTypeGetSystemMatrix ()
 This method returns the LHS matrix. More...
 
virtual TSystemVectorTypeGetSystemVector ()
 This method returns the RHS vector. More...
 
virtual TSystemVectorTypeGetSolutionVector ()
 This method returns the solution vector. More...
 

Protected Member Functions

Protected Operations
void SetTimeCoefficients ()
 Set the Time Coefficients object Calculate the coefficients for the BDF2 time iteration. These are stored in the BDF_COEFFICIENTS variable of the ProcessInfo container. More...
 
virtual std::tuple< bool, doubleSolveStep ()
 
bool CheckFractionalStepConvergence (const double NormDv)
 
bool CheckPressureConvergence (const double NormDp)
 
virtual void ComputeSplitOssProjections (ModelPart &rModelPart)
 
virtual void CalculateEndOfStepVelocity ()
 
void EnforceSlipCondition (const Kratos::Flags &rSlipWallFlag)
 Substract wall-normal component of velocity update to ensure that the final velocity satisfies slip conditions. More...
 
void PeriodicConditionProjectionCorrection (ModelPart &rModelPart)
 
void PeriodicConditionVelocityCorrection (ModelPart &rModelPart)
 
- Protected Member Functions inherited from Kratos::ImplicitSolvingStrategy< TSparseSpace, TDenseSpace, TLinearSolver >
void AssignSettings (const Parameters ThisParameters) override
 This method assigns settings to member variables. More...
 
- Protected Member Functions inherited from Kratos::SolvingStrategy< TSparseSpace, TDenseSpace >
virtual Parameters ValidateAndAssignParameters (Parameters ThisParameters, const Parameters DefaultParameters) const
 This method validate and assign default parameters. More...
 

Protected Attributes

Protected member Variables
double mVelocityTolerance
 
double mPressureTolerance
 
double mPressureGradientRelaxationFactor
 
unsigned int mMaxVelocityIter
 
unsigned int mMaxPressureIter
 
unsigned int mDomainSize
 
unsigned int mTimeOrder
 
bool mPredictorCorrector
 
bool mUseSlipConditions
 
bool mReformDofSet
 
bool mCalculateReactionsFlag
 
StrategyPointerType mpMomentumStrategy
 Scheme for the solution of the momentum equation. More...
 
StrategyPointerType mpPressureStrategy
 Scheme for the solution of the mass equation. More...
 
std::vector< Process::Pointer > mExtraIterationSteps
 
const Kratos::Variable< int > & mrPeriodicIdVar
 
- Protected Attributes inherited from Kratos::ImplicitSolvingStrategy< TSparseSpace, TDenseSpace, TLinearSolver >
int mRebuildLevel
 
bool mStiffnessMatrixIsBuilt
 The current rebuild level. More...
 
- Protected Attributes inherited from Kratos::SolvingStrategy< TSparseSpace, TDenseSpace >
int mEchoLevel
 

Type Definitions

typedef ImplicitSolvingStrategy< TSparseSpace, TDenseSpace, TLinearSolver > BaseType
 
typedef BaseType::LocalSystemVectorType LocalSystemVectorType
 
typedef BaseType::LocalSystemMatrixType LocalSystemMatrixType
 
typedef ImplicitSolvingStrategy< TSparseSpace, TDenseSpace, TLinearSolver >::Pointer StrategyPointerType
 
typedef SolverSettings< TSparseSpace, TDenseSpace, TLinearSolver > SolverSettingsType
 
 KRATOS_CLASS_POINTER_DEFINITION (FractionalStepStrategy)
 Counted pointer of FractionalStepStrategy. More...
 

Additional Inherited Members

- Public Types inherited from Kratos::ImplicitSolvingStrategy< TSparseSpace, TDenseSpace, TLinearSolver >
typedef SolvingStrategy< TSparseSpace, TDenseSpace > BaseType
 
typedef BaseType::TDataType TDataType
 
typedef BaseType::TSystemMatrixType TSystemMatrixType
 
typedef BaseType::TSystemVectorType TSystemVectorType
 
typedef BaseType::TSystemMatrixPointerType TSystemMatrixPointerType
 
typedef BaseType::TSystemVectorPointerType TSystemVectorPointerType
 
typedef BaseType::LocalSystemMatrixType LocalSystemMatrixType
 
typedef BaseType::LocalSystemVectorType LocalSystemVectorType
 
typedef Scheme< TSparseSpace, TDenseSpace > TSchemeType
 
typedef BuilderAndSolver< TSparseSpace, TDenseSpace, TLinearSolver > TBuilderAndSolverType
 
typedef ImplicitSolvingStrategy< TSparseSpace, TDenseSpace, TLinearSolver > ClassType
 
typedef BaseType::TDofType TDofType
 
typedef BaseType::DofsArrayType DofsArrayType
 
typedef BaseType::NodesArrayType NodesArrayType
 
typedef BaseType::ElementsArrayType ElementsArrayType
 
typedef BaseType::ConditionsArrayType ConditionsArrayType
 
- Public Types inherited from Kratos::SolvingStrategy< TSparseSpace, TDenseSpace >
typedef TSparseSpace::DataType TDataType
 
typedef TSparseSpace::MatrixType TSystemMatrixType
 
typedef TSparseSpace::VectorType TSystemVectorType
 
typedef TSparseSpace::MatrixPointerType TSystemMatrixPointerType
 
typedef TSparseSpace::VectorPointerType TSystemVectorPointerType
 
typedef TDenseSpace::MatrixType LocalSystemMatrixType
 
typedef TDenseSpace::VectorType LocalSystemVectorType
 
typedef SolvingStrategy< TSparseSpace, TDenseSpace > ClassType
 
typedef ModelPart::DofType TDofType
 
typedef ModelPart::DofsArrayType DofsArrayType
 
typedef ModelPart::NodesContainerType NodesArrayType
 
typedef ModelPart::ElementsContainerType ElementsArrayType
 
typedef ModelPart::ConditionsContainerType ConditionsArrayType
 
- Static Public Member Functions inherited from Kratos::ImplicitSolvingStrategy< TSparseSpace, TDenseSpace, TLinearSolver >
static std::string Name ()
 Returns the name of the class as used in the settings (snake_case format) More...
 
- Static Public Member Functions inherited from Kratos::SolvingStrategy< TSparseSpace, TDenseSpace >
static std::string Name ()
 Returns the name of the class as used in the settings (snake_case format) More...
 

Detailed Description

template<class TSparseSpace, class TDenseSpace, class TLinearSolver>
class Kratos::FractionalStepStrategy< TSparseSpace, TDenseSpace, TLinearSolver >

Fractional-step strategy for incompressible Navier-Stokes formulation This strategy implements a splitting scheme for the incompressible Navier-Stokes equations. It is intended to be used in combination with the FractionalStep element in the FluidDynamicsApplication. The fractional step index, which is stored in the ProcessInfo, takes the values 1 : Momentum step (calculate fractional step velocity) 2-3 : Unused (reserved for componentwise calculation of frac step velocity) 4 : Pressure step 5 : Computation of projections 6 : End of step velocity.

Template Parameters
TSparseSpaceSparse space template type
TDenseSpaceDense space template type
TLinearSolverLinear solver template type

Member Typedef Documentation

◆ BaseType

template<class TSparseSpace , class TDenseSpace , class TLinearSolver >
typedef ImplicitSolvingStrategy<TSparseSpace, TDenseSpace, TLinearSolver> Kratos::FractionalStepStrategy< TSparseSpace, TDenseSpace, TLinearSolver >::BaseType

◆ LocalSystemMatrixType

template<class TSparseSpace , class TDenseSpace , class TLinearSolver >
typedef BaseType::LocalSystemMatrixType Kratos::FractionalStepStrategy< TSparseSpace, TDenseSpace, TLinearSolver >::LocalSystemMatrixType

◆ LocalSystemVectorType

template<class TSparseSpace , class TDenseSpace , class TLinearSolver >
typedef BaseType::LocalSystemVectorType Kratos::FractionalStepStrategy< TSparseSpace, TDenseSpace, TLinearSolver >::LocalSystemVectorType

◆ SolverSettingsType

template<class TSparseSpace , class TDenseSpace , class TLinearSolver >
typedef SolverSettings<TSparseSpace,TDenseSpace,TLinearSolver> Kratos::FractionalStepStrategy< TSparseSpace, TDenseSpace, TLinearSolver >::SolverSettingsType

◆ StrategyPointerType

template<class TSparseSpace , class TDenseSpace , class TLinearSolver >
typedef ImplicitSolvingStrategy<TSparseSpace, TDenseSpace, TLinearSolver>::Pointer Kratos::FractionalStepStrategy< TSparseSpace, TDenseSpace, TLinearSolver >::StrategyPointerType

Constructor & Destructor Documentation

◆ FractionalStepStrategy() [1/4]

template<class TSparseSpace , class TDenseSpace , class TLinearSolver >
Kratos::FractionalStepStrategy< TSparseSpace, TDenseSpace, TLinearSolver >::FractionalStepStrategy ( ModelPart rModelPart,
SolverSettingsType rSolverConfig,
bool  PredictorCorrector 
)
inline

◆ FractionalStepStrategy() [2/4]

template<class TSparseSpace , class TDenseSpace , class TLinearSolver >
Kratos::FractionalStepStrategy< TSparseSpace, TDenseSpace, TLinearSolver >::FractionalStepStrategy ( ModelPart rModelPart,
SolverSettingsType rSolverConfig,
bool  PredictorCorrector,
const Kratos::Variable< int > &  PeriodicVar 
)
inline

◆ FractionalStepStrategy() [3/4]

template<class TSparseSpace , class TDenseSpace , class TLinearSolver >
Kratos::FractionalStepStrategy< TSparseSpace, TDenseSpace, TLinearSolver >::FractionalStepStrategy ( ModelPart rModelPart,
SolverSettingsType rSolverConfig,
bool  PredictorCorrector,
bool  CalculateReactionsFlag 
)
inline

◆ FractionalStepStrategy() [4/4]

template<class TSparseSpace , class TDenseSpace , class TLinearSolver >
Kratos::FractionalStepStrategy< TSparseSpace, TDenseSpace, TLinearSolver >::FractionalStepStrategy ( ModelPart rModelPart,
SolverSettingsType rSolverConfig,
bool  PredictorCorrector,
bool  CalculateReactionsFlag,
const Kratos::Variable< int > &  PeriodicVar 
)
inline

◆ ~FractionalStepStrategy()

template<class TSparseSpace , class TDenseSpace , class TLinearSolver >
Kratos::FractionalStepStrategy< TSparseSpace, TDenseSpace, TLinearSolver >::~FractionalStepStrategy ( )
inlineoverride

Destructor.

Member Function Documentation

◆ AddIterationStep()

template<class TSparseSpace , class TDenseSpace , class TLinearSolver >
virtual void Kratos::FractionalStepStrategy< TSparseSpace, TDenseSpace, TLinearSolver >::AddIterationStep ( Process::Pointer  pNewStep)
inlinevirtual

◆ CalculateEndOfStepVelocity()

template<class TSparseSpace , class TDenseSpace , class TLinearSolver >
virtual void Kratos::FractionalStepStrategy< TSparseSpace, TDenseSpace, TLinearSolver >::CalculateEndOfStepVelocity ( )
inlineprotectedvirtual

◆ CalculateReactions()

template<class TSparseSpace , class TDenseSpace , class TLinearSolver >
virtual void Kratos::FractionalStepStrategy< TSparseSpace, TDenseSpace, TLinearSolver >::CalculateReactions ( )
inlinevirtual

Calculates the reactions This methods calculates the reactions of the momentum equation. These are computed as minus the RHS and saved in the REACTION variable.

◆ Check()

template<class TSparseSpace , class TDenseSpace , class TLinearSolver >
int Kratos::FractionalStepStrategy< TSparseSpace, TDenseSpace, TLinearSolver >::Check ( )
inlineoverridevirtual

Function to perform expensive checks.

It is designed to be called ONCE to verify that the input is correct.

Reimplemented from Kratos::SolvingStrategy< TSparseSpace, TDenseSpace >.

◆ CheckFractionalStepConvergence()

template<class TSparseSpace , class TDenseSpace , class TLinearSolver >
bool Kratos::FractionalStepStrategy< TSparseSpace, TDenseSpace, TLinearSolver >::CheckFractionalStepConvergence ( const double  NormDv)
inlineprotected

◆ CheckPressureConvergence()

template<class TSparseSpace , class TDenseSpace , class TLinearSolver >
bool Kratos::FractionalStepStrategy< TSparseSpace, TDenseSpace, TLinearSolver >::CheckPressureConvergence ( const double  NormDp)
inlineprotected

◆ Clear()

template<class TSparseSpace , class TDenseSpace , class TLinearSolver >
void Kratos::FractionalStepStrategy< TSparseSpace, TDenseSpace, TLinearSolver >::Clear ( )
inlineoverridevirtual

Clears the internal storage.

Reimplemented from Kratos::SolvingStrategy< TSparseSpace, TDenseSpace >.

◆ ClearExtraIterationSteps()

template<class TSparseSpace , class TDenseSpace , class TLinearSolver >
virtual void Kratos::FractionalStepStrategy< TSparseSpace, TDenseSpace, TLinearSolver >::ClearExtraIterationSteps ( )
inlinevirtual

◆ ComputeSplitOssProjections()

template<class TSparseSpace , class TDenseSpace , class TLinearSolver >
virtual void Kratos::FractionalStepStrategy< TSparseSpace, TDenseSpace, TLinearSolver >::ComputeSplitOssProjections ( ModelPart rModelPart)
inlineprotectedvirtual

◆ EnforceSlipCondition()

template<class TSparseSpace , class TDenseSpace , class TLinearSolver >
void Kratos::FractionalStepStrategy< TSparseSpace, TDenseSpace, TLinearSolver >::EnforceSlipCondition ( const Kratos::Flags rSlipWallFlag)
inlineprotected

Substract wall-normal component of velocity update to ensure that the final velocity satisfies slip conditions.

Parameters
rSlipWallFlagIf Node.Is(rSlipWallFlag) == true, the node is in the wall.

◆ FinalizeSolutionStep()

template<class TSparseSpace , class TDenseSpace , class TLinearSolver >
void Kratos::FractionalStepStrategy< TSparseSpace, TDenseSpace, TLinearSolver >::FinalizeSolutionStep ( )
inlineoverridevirtual

Performs all the required operations that should be done (for each step) after solving the solution step.

A member variable should be used as a flag to make sure this function is called only once per step.

Reimplemented from Kratos::SolvingStrategy< TSparseSpace, TDenseSpace >.

◆ GetCalculateReactionsFlag()

template<class TSparseSpace , class TDenseSpace , class TLinearSolver >
bool Kratos::FractionalStepStrategy< TSparseSpace, TDenseSpace, TLinearSolver >::GetCalculateReactionsFlag ( )
inline

This method returns the flag mCalculateReactionsFlag.

Returns
The flag that tells if the reactions are computed

◆ Info()

template<class TSparseSpace , class TDenseSpace , class TLinearSolver >
std::string Kratos::FractionalStepStrategy< TSparseSpace, TDenseSpace, TLinearSolver >::Info ( ) const
inlineoverridevirtual

Turn back information as a string.

Reimplemented from Kratos::ImplicitSolvingStrategy< TSparseSpace, TDenseSpace, TLinearSolver >.

◆ Initialize()

template<class TSparseSpace , class TDenseSpace , class TLinearSolver >
void Kratos::FractionalStepStrategy< TSparseSpace, TDenseSpace, TLinearSolver >::Initialize ( void  )
inlineoverridevirtual

Initialization of member variables and prior operations.

Reimplemented from Kratos::SolvingStrategy< TSparseSpace, TDenseSpace >.

◆ InitializeSolutionStep()

template<class TSparseSpace , class TDenseSpace , class TLinearSolver >
void Kratos::FractionalStepStrategy< TSparseSpace, TDenseSpace, TLinearSolver >::InitializeSolutionStep ( )
inlineoverridevirtual

Performs all the required operations that should be done (for each step) before solving the solution step.

A member variable should be used as a flag to make sure this function is called only once per step.

Reimplemented from Kratos::SolvingStrategy< TSparseSpace, TDenseSpace >.

◆ KRATOS_CLASS_POINTER_DEFINITION()

template<class TSparseSpace , class TDenseSpace , class TLinearSolver >
Kratos::FractionalStepStrategy< TSparseSpace, TDenseSpace, TLinearSolver >::KRATOS_CLASS_POINTER_DEFINITION ( FractionalStepStrategy< TSparseSpace, TDenseSpace, TLinearSolver >  )

Counted pointer of FractionalStepStrategy.

◆ PeriodicConditionProjectionCorrection()

template<class TSparseSpace , class TDenseSpace , class TLinearSolver >
void Kratos::FractionalStepStrategy< TSparseSpace, TDenseSpace, TLinearSolver >::PeriodicConditionProjectionCorrection ( ModelPart rModelPart)
inlineprotected

On periodic boundaries, the nodal area and the values to project need to take into account contributions from elements on both sides of the boundary. This is done using the conditions and the non-historical nodal data containers as follows:
1- The partition that owns the PeriodicCondition adds the values on both nodes to their non-historical containers.
2- The non-historical containers are added across processes, transmiting the right value from the condition owner to all partitions.
3- The value on all periodic nodes is replaced by the one received in step 2.

◆ PeriodicConditionVelocityCorrection()

template<class TSparseSpace , class TDenseSpace , class TLinearSolver >
void Kratos::FractionalStepStrategy< TSparseSpace, TDenseSpace, TLinearSolver >::PeriodicConditionVelocityCorrection ( ModelPart rModelPart)
inlineprotected

◆ PrintData()

template<class TSparseSpace , class TDenseSpace , class TLinearSolver >
void Kratos::FractionalStepStrategy< TSparseSpace, TDenseSpace, TLinearSolver >::PrintData ( std::ostream &  rOStream) const
inlineoverridevirtual

Print object's data.

Reimplemented from Kratos::SolvingStrategy< TSparseSpace, TDenseSpace >.

◆ PrintInfo()

template<class TSparseSpace , class TDenseSpace , class TLinearSolver >
void Kratos::FractionalStepStrategy< TSparseSpace, TDenseSpace, TLinearSolver >::PrintInfo ( std::ostream &  rOStream) const
inlineoverridevirtual

Print information about this object.

Reimplemented from Kratos::SolvingStrategy< TSparseSpace, TDenseSpace >.

◆ SetCalculateReactionsFlag()

template<class TSparseSpace , class TDenseSpace , class TLinearSolver >
void Kratos::FractionalStepStrategy< TSparseSpace, TDenseSpace, TLinearSolver >::SetCalculateReactionsFlag ( bool  CalculateReactionsFlag)
inline

This method sets the flag mCalculateReactionsFlag.

Parameters
CalculateReactionsFlagThe flag that tells if the reactions are computed

◆ SetEchoLevel()

template<class TSparseSpace , class TDenseSpace , class TLinearSolver >
void Kratos::FractionalStepStrategy< TSparseSpace, TDenseSpace, TLinearSolver >::SetEchoLevel ( int  Level)
inlineoverridevirtual

This sets the level of echo for the solving strategy.

Parameters
Levelof echo for the solving strategy

{ 0 -> Mute... no echo at all 1 -> Printing time and basic information 2 -> Printing linear solver data 3 -> Print of debug information: Echo of stiffness matrix, Dx, b... }

Reimplemented from Kratos::SolvingStrategy< TSparseSpace, TDenseSpace >.

◆ SetTimeCoefficients()

template<class TSparseSpace , class TDenseSpace , class TLinearSolver >
void Kratos::FractionalStepStrategy< TSparseSpace, TDenseSpace, TLinearSolver >::SetTimeCoefficients ( )
inlineprotected

Set the Time Coefficients object Calculate the coefficients for the BDF2 time iteration. These are stored in the BDF_COEFFICIENTS variable of the ProcessInfo container.

◆ SolveSolutionStep()

template<class TSparseSpace , class TDenseSpace , class TLinearSolver >
bool Kratos::FractionalStepStrategy< TSparseSpace, TDenseSpace, TLinearSolver >::SolveSolutionStep ( )
inlineoverridevirtual

Solves the current step. This function returns true if a solution has been found, false otherwise.

Reimplemented from Kratos::SolvingStrategy< TSparseSpace, TDenseSpace >.

◆ SolveStep()

template<class TSparseSpace , class TDenseSpace , class TLinearSolver >
virtual std::tuple<bool,double> Kratos::FractionalStepStrategy< TSparseSpace, TDenseSpace, TLinearSolver >::SolveStep ( )
inlineprotectedvirtual

Member Data Documentation

◆ mCalculateReactionsFlag

template<class TSparseSpace , class TDenseSpace , class TLinearSolver >
bool Kratos::FractionalStepStrategy< TSparseSpace, TDenseSpace, TLinearSolver >::mCalculateReactionsFlag
protected

◆ mDomainSize

template<class TSparseSpace , class TDenseSpace , class TLinearSolver >
unsigned int Kratos::FractionalStepStrategy< TSparseSpace, TDenseSpace, TLinearSolver >::mDomainSize
protected

◆ mExtraIterationSteps

template<class TSparseSpace , class TDenseSpace , class TLinearSolver >
std::vector< Process::Pointer > Kratos::FractionalStepStrategy< TSparseSpace, TDenseSpace, TLinearSolver >::mExtraIterationSteps
protected

◆ mMaxPressureIter

template<class TSparseSpace , class TDenseSpace , class TLinearSolver >
unsigned int Kratos::FractionalStepStrategy< TSparseSpace, TDenseSpace, TLinearSolver >::mMaxPressureIter
protected

◆ mMaxVelocityIter

template<class TSparseSpace , class TDenseSpace , class TLinearSolver >
unsigned int Kratos::FractionalStepStrategy< TSparseSpace, TDenseSpace, TLinearSolver >::mMaxVelocityIter
protected

◆ mpMomentumStrategy

template<class TSparseSpace , class TDenseSpace , class TLinearSolver >
StrategyPointerType Kratos::FractionalStepStrategy< TSparseSpace, TDenseSpace, TLinearSolver >::mpMomentumStrategy
protected

Scheme for the solution of the momentum equation.

◆ mpPressureStrategy

template<class TSparseSpace , class TDenseSpace , class TLinearSolver >
StrategyPointerType Kratos::FractionalStepStrategy< TSparseSpace, TDenseSpace, TLinearSolver >::mpPressureStrategy
protected

Scheme for the solution of the mass equation.

◆ mPredictorCorrector

template<class TSparseSpace , class TDenseSpace , class TLinearSolver >
bool Kratos::FractionalStepStrategy< TSparseSpace, TDenseSpace, TLinearSolver >::mPredictorCorrector
protected

◆ mPressureGradientRelaxationFactor

template<class TSparseSpace , class TDenseSpace , class TLinearSolver >
double Kratos::FractionalStepStrategy< TSparseSpace, TDenseSpace, TLinearSolver >::mPressureGradientRelaxationFactor
protected

◆ mPressureTolerance

template<class TSparseSpace , class TDenseSpace , class TLinearSolver >
double Kratos::FractionalStepStrategy< TSparseSpace, TDenseSpace, TLinearSolver >::mPressureTolerance
protected

◆ mReformDofSet

template<class TSparseSpace , class TDenseSpace , class TLinearSolver >
bool Kratos::FractionalStepStrategy< TSparseSpace, TDenseSpace, TLinearSolver >::mReformDofSet
protected

◆ mrPeriodicIdVar

template<class TSparseSpace , class TDenseSpace , class TLinearSolver >
const Kratos::Variable<int>& Kratos::FractionalStepStrategy< TSparseSpace, TDenseSpace, TLinearSolver >::mrPeriodicIdVar
protected

◆ mTimeOrder

template<class TSparseSpace , class TDenseSpace , class TLinearSolver >
unsigned int Kratos::FractionalStepStrategy< TSparseSpace, TDenseSpace, TLinearSolver >::mTimeOrder
protected

◆ mUseSlipConditions

template<class TSparseSpace , class TDenseSpace , class TLinearSolver >
bool Kratos::FractionalStepStrategy< TSparseSpace, TDenseSpace, TLinearSolver >::mUseSlipConditions
protected

◆ mVelocityTolerance

template<class TSparseSpace , class TDenseSpace , class TLinearSolver >
double Kratos::FractionalStepStrategy< TSparseSpace, TDenseSpace, TLinearSolver >::mVelocityTolerance
protected

The documentation for this class was generated from the following file: