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::TrilinosBlockBuilderAndSolverPeriodic< TSparseSpace, TDenseSpace, TLinearSolver > Class Template Reference

#include <trilinos_block_builder_and_solver_periodic.h>

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

Public Member Functions

Life Cycle
 TrilinosBlockBuilderAndSolverPeriodic (Epetra_MpiComm &Comm, int guess_row_size, typename TLinearSolver::Pointer pNewLinearSystemSolver, const Kratos::Variable< int > &PeriodicIdVar)
 
virtual ~TrilinosBlockBuilderAndSolverPeriodic ()
 
Operations
void SetUpSystem (ModelPart &rModelPart) override
 Assign an Equation Id to all degrees of freedom in the system. More...
 
- Public Member Functions inherited from Kratos::TrilinosBlockBuilderAndSolver< TSparseSpace, TDenseSpace, TLinearSolver >
 TrilinosBlockBuilderAndSolver ()=default
 Default constructor (empty) More...
 
 TrilinosBlockBuilderAndSolver (EpetraCommunicatorType &rComm, int GuessRowSize, typename TLinearSolver::Pointer pNewLinearSystemSolver)
 Default constructor. More...
 
 TrilinosBlockBuilderAndSolver (EpetraCommunicatorType &rComm, typename TLinearSolver::Pointer pNewLinearSystemSolver, Parameters ThisParameters)
 Default constructor. (with parameters) More...
 
 TrilinosBlockBuilderAndSolver (const TrilinosBlockBuilderAndSolver &rOther)=delete
 
TrilinosBlockBuilderAndSolveroperator= (const TrilinosBlockBuilderAndSolver &rOther)=delete
 
TSparseSpace::MatrixType & GetConstraintRelationMatrix () override
 This method returns constraint relation (T) matrix. More...
 
TSparseSpace::VectorType & GetConstraintConstantVector () override
 This method returns constraint constant vector. More...
 
double GetScaleFactor ()
 Retrieves the current scale factor. This function returns the current scale factor value. More...
 
void SetScaleFactor (const double ScaleFactor)
 Sets the scale factor. This function sets a new value for the scale factor. More...
 
std::string Info () const override
 Turn back information as a string. More...
 
void PrintInfo (std::ostream &rOStream) const override
 Print information about this object. More...
 
void PrintData (std::ostream &rOStream) const override
 Print object's data. More...
 
 KRATOS_DEFINE_LOCAL_FLAG (SILENT_WARNINGS)
 Definition of the flags. More...
 
 KRATOS_CLASS_POINTER_DEFINITION (TrilinosBlockBuilderAndSolver)
 Definition of the pointer. More...
 
void Build (typename TSchemeType::Pointer pScheme, ModelPart &rModelPart, TSystemMatrixType &rA, TSystemVectorType &rb) override
 Function to perform the build the system matrix and the residual vector. More...
 
void BuildLHS (typename TSchemeType::Pointer pScheme, ModelPart &rModelPart, TSystemMatrixType &rA) override
 Function to perform the building of the LHS. More...
 
void BuildLHS_CompleteOnFreeRows (typename TSchemeType::Pointer pScheme, ModelPart &rModelPart, TSystemMatrixType &A) override
 Build a rectangular matrix of size n*N where "n" is the number of unrestrained degrees of freedom and "N" is the total number of degrees of freedom involved. More...
 
void SystemSolve (TSystemMatrixType &rA, TSystemVectorType &rDx, TSystemVectorType &rb) override
 This is a call to the linear system solver. More...
 
void SystemSolveWithPhysics (TSystemMatrixType &rA, TSystemVectorType &rDx, TSystemVectorType &rb, ModelPart &rModelPart)
 This is a call to the linear system solver (taking into account some physical particularities of the problem) More...
 
void InternalSystemSolveWithPhysics (TSystemMatrixType &rA, TSystemVectorType &rDx, TSystemVectorType &rb, ModelPart &rModelPart)
 This is a call to the linear system solver (taking into account some physical particularities of the problem) More...
 
void BuildAndSolve (typename TSchemeType::Pointer pScheme, ModelPart &rModelPart, TSystemMatrixType &rA, TSystemVectorType &rDx, TSystemVectorType &rb) override
 Function to perform the building and solving phase at the same time. More...
 
void BuildRHSAndSolve (typename TSchemeType::Pointer pScheme, ModelPart &rModelPart, TSystemMatrixType &rA, TSystemVectorType &rDx, TSystemVectorType &rb) override
 Corresponds to the previous, but the System's matrix is considered already built and only the RHS is built again. More...
 
void BuildRHS (typename TSchemeType::Pointer pScheme, ModelPart &rModelPart, TSystemVectorType &rb) override
 Function to perform the build of the RHS. More...
 
void SetUpDofSet (typename TSchemeType::Pointer pScheme, ModelPart &rModelPart) override
 Builds the list of the DofSets involved in the problem by "asking" to each element and condition its Dofs. More...
 
void ResizeAndInitializeVectors (typename TSchemeType::Pointer pScheme, TSystemMatrixPointerType &rpA, TSystemVectorPointerType &rpDx, TSystemVectorPointerType &rpb, ModelPart &rModelPart) override
 Resizes the system matrix and the vector according to the number of dos in the current rModelPart. This function also decides on the sparsity pattern and the graph of the Trilinos csr matrix. More...
 
void CalculateReactions (typename TSchemeType::Pointer pScheme, ModelPart &rModelPart, TSystemMatrixType &rA, TSystemVectorType &rDx, TSystemVectorType &rb) override
 It computes the reactions of the system. More...
 
void ApplyDirichletConditions (typename TSchemeType::Pointer pScheme, ModelPart &rModelPart, TSystemMatrixType &rA, TSystemVectorType &rDx, TSystemVectorType &rb) override
 Applies the dirichlet conditions. This operation may be very heavy or completely unexpensive depending on the implementation choosen and on how the System Matrix is built. More...
 
void ApplyRHSConstraints (typename TSchemeType::Pointer pScheme, ModelPart &rModelPart, TSystemVectorType &rb) override
 Applies the constraints with master-slave relation matrix (RHS only) More...
 
void ApplyConstraints (typename TSchemeType::Pointer pScheme, ModelPart &rModelPart, TSystemMatrixType &rA, TSystemVectorType &rb) override
 Applies the constraints with master-slave relation matrix. More...
 
void Clear () override
 This function is intended to be called at the end of the solution step to clean up memory storage not needed. More...
 
int Check (ModelPart &rModelPart) override
 This function is designed to be called once to perform all the checks needed on the input provided. Checks can be "expensive" as the function is designed to catch user's errors. More...
 
Parameters GetDefaultParameters () const override
 This method provides the defaults parameters to avoid conflicts between the different constructors. More...
 
- Public Member Functions inherited from Kratos::BuilderAndSolver< TSparseSpace, TDenseSpace, TLinearSolver >
 BuilderAndSolver ()
 Default constructor. More...
 
 BuilderAndSolver (typename TLinearSolver::Pointer pNewLinearSystemSolver, Parameters ThisParameters)
 Default constructor with Parameters. More...
 
 BuilderAndSolver (typename TLinearSolver::Pointer pNewLinearSystemSolver)
 Default constructor. More...
 
virtual ~BuilderAndSolver ()
 
virtual ClassType::Pointer Create (typename TLinearSolver::Pointer pNewLinearSystemSolver, Parameters ThisParameters) const
 Create method. More...
 
void SetEchoLevel (int Level)
 It sets the level of echo for the solving strategy. More...
 
int GetEchoLevel () const
 It returns the echo level. More...
 
 KRATOS_CLASS_POINTER_DEFINITION (BuilderAndSolver)
 Pointer definition of BuilderAndSolver. More...
 
bool GetCalculateReactionsFlag () const
 This method returns the flag mCalculateReactionsFlag. More...
 
void SetCalculateReactionsFlag (bool flag)
 This method sets the flag mCalculateReactionsFlag. More...
 
bool GetDofSetIsInitializedFlag () const
 This method returns the flag mDofSetIsInitialized. More...
 
void SetDofSetIsInitializedFlag (bool DofSetIsInitialized)
 This method sets the flag mDofSetIsInitialized. More...
 
bool GetReshapeMatrixFlag () const
 This method returns the flag mReshapeMatrixFlag. More...
 
void SetReshapeMatrixFlag (bool ReshapeMatrixFlag)
 This method sets the flag mReshapeMatrixFlag. More...
 
unsigned int GetEquationSystemSize () const
 This method returns the value mEquationSystemSize. More...
 
TLinearSolver::Pointer GetLinearSystemSolver () const
 This method return the linear solver used. More...
 
void SetLinearSystemSolver (typename TLinearSolver::Pointer pLinearSystemSolver)
 This method sets the linear solver to be used. More...
 
virtual void BuildLHS_Complete (typename TSchemeType::Pointer pScheme, ModelPart &rModelPart, TSystemMatrixType &rA)
 It builds a matrix of size N*N where "N" is the total number of degrees of freedom involved. More...
 
virtual void BuildAndSolveLinearizedOnPreviousIteration (typename TSchemeType::Pointer pScheme, ModelPart &rModelPart, TSystemMatrixType &rA, TSystemVectorType &rDx, TSystemVectorType &rb, const bool MoveMesh)
 Function to perform the building and solving phase at the same time Linearizing with the database at the old iteration. More...
 
virtual void ApplyDirichletConditions_LHS (typename TSchemeType::Pointer pScheme, ModelPart &rModelPart, TSystemMatrixType &rA, TSystemVectorType &rDx)
 The same of the precedent but affecting only the LHS. More...
 
virtual void ApplyDirichletConditions_RHS (typename TSchemeType::Pointer pScheme, ModelPart &rModelPart, TSystemVectorType &rDx, TSystemVectorType &rb)
 The same of the precedent but affecting only the RHS. More...
 
virtual DofsArrayTypeGetDofSet ()
 It allows to get the list of Dofs from the element. More...
 
virtual const DofsArrayTypeGetDofSet () const
 It allows to get the list of Dofs from the element. More...
 
virtual void InitializeSolutionStep (ModelPart &rModelPart, TSystemMatrixType &rA, TSystemVectorType &rDx, TSystemVectorType &rb)
 It applies certain operations at the system of equations at the beginning of the solution step. More...
 
virtual void FinalizeSolutionStep (ModelPart &rModelPart, TSystemMatrixType &rA, TSystemVectorType &rDx, TSystemVectorType &rb)
 It applies certain operations at the system of equations at the end of the solution step. More...
 

Type Definitions

typedef TrilinosBlockBuilderAndSolver< TSparseSpace, TDenseSpace, TLinearSolver > BaseType
 
typedef TSparseSpace SparseSpaceType
 
typedef BaseType::TSchemeType TSchemeType
 
typedef BaseType::TDataType TDataType
 
typedef BaseType::DofsArrayType DofsArrayType
 
typedef BaseType::TSystemMatrixType TSystemMatrixType
 
typedef BaseType::TSystemVectorType TSystemVectorType
 
typedef BaseType::LocalSystemVectorType LocalSystemVectorType
 
typedef BaseType::LocalSystemMatrixType LocalSystemMatrixType
 
typedef BaseType::TSystemMatrixPointerType TSystemMatrixPointerType
 
typedef BaseType::TSystemVectorPointerType TSystemVectorPointerType
 
typedef BaseType::NodesArrayType NodesArrayType
 
typedef BaseType::ElementsArrayType ElementsArrayType
 
typedef BaseType::ConditionsArrayType ConditionsArrayType
 
typedef BaseType::ElementsContainerType ElementsContainerType
 
 KRATOS_CLASS_POINTER_DEFINITION (TrilinosBlockBuilderAndSolverPeriodic)
 

Additional Inherited Members

- Public Types inherited from Kratos::TrilinosBlockBuilderAndSolver< TSparseSpace, TDenseSpace, TLinearSolver >
using BaseType = BuilderAndSolver< TSparseSpace, TDenseSpace, TLinearSolver >
 Definition of the base class. More...
 
using SizeType = std::size_t
 The size_t types. More...
 
using IndexType = std::size_t
 
using TSchemeType = typename BaseType::TSchemeType
 Definition of the classes from the base class. More...
 
using DofsArrayType = typename BaseType::DofsArrayType
 
using EpetraCommunicatorType = Epetra_MpiComm
 Epetra definitions. More...
 
using NodeType = Node
 DoF types definition. More...
 
using TSystemMatrixType = typename BaseType::TSystemMatrixType
 Defining the sparse matrices and vectors. More...
 
using TSystemVectorType = typename BaseType::TSystemVectorType
 
using LocalSystemMatrixType = typename BaseType::LocalSystemMatrixType
 Defining the local matrices and vectors. More...
 
using LocalSystemVectorType = typename BaseType::LocalSystemVectorType
 
using TSystemMatrixPointerType = typename BaseType::TSystemMatrixPointerType
 Definition of the pointer types. More...
 
using TSystemVectorPointerType = typename BaseType::TSystemVectorPointerType
 
- Public Types inherited from Kratos::BuilderAndSolver< TSparseSpace, TDenseSpace, TLinearSolver >
typedef BuilderAndSolver< TSparseSpace, TDenseSpace, TLinearSolver > ClassType
 The definition of the current class. More...
 
typedef std::size_t SizeType
 Definition of the size type. More...
 
typedef std::size_t IndexType
 Definition of the index type. More...
 
typedef TSparseSpace::DataType TDataType
 Definition of the data type. More...
 
typedef TSparseSpace::MatrixType TSystemMatrixType
 Definition of the sparse matrix. More...
 
typedef TSparseSpace::VectorType TSystemVectorType
 Definition of the vector size. More...
 
typedef TSparseSpace::MatrixPointerType TSystemMatrixPointerType
 Definition of the pointer to the sparse matrix. More...
 
typedef TSparseSpace::VectorPointerType TSystemVectorPointerType
 Definition of the pointer to the vector. More...
 
typedef TDenseSpace::MatrixType LocalSystemMatrixType
 The local matrix definition. More...
 
typedef TDenseSpace::VectorType LocalSystemVectorType
 The local vector definition. More...
 
typedef Scheme< TSparseSpace, TDenseSpace > TSchemeType
 Definition of the scheme type. More...
 
typedef ModelPart::DofType TDofType
 Definition of the DoF class. More...
 
typedef ModelPart::DofsArrayType DofsArrayType
 Definition of the DoF array type. More...
 
typedef ModelPart::NodesContainerType NodesArrayType
 The containers of the entities. More...
 
typedef ModelPart::ElementsContainerType ElementsArrayType
 
typedef ModelPart::ConditionsContainerType ConditionsArrayType
 
typedef PointerVectorSet< Element, IndexedObjectElementsContainerType
 The definition of the element container type. More...
 
- Static Public Member Functions inherited from Kratos::TrilinosBlockBuilderAndSolver< 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::BuilderAndSolver< TSparseSpace, TDenseSpace, TLinearSolver >
static std::string Name ()
 Returns the name of the class as used in the settings (snake_case format) More...
 
- Protected Member Functions inherited from Kratos::TrilinosBlockBuilderAndSolver< TSparseSpace, TDenseSpace, TLinearSolver >
virtual void ConstructMasterSlaveConstraintsStructure (ModelPart &rModelPart)
 Constructs the master-slave constraints structure for the given model part. More...
 
virtual void BuildMasterSlaveConstraints (ModelPart &rModelPart)
 Builds the master-slave constraints for the given model part. More...
 
virtual void ConstructMatrixStructure (typename TSchemeType::Pointer pScheme, TSystemMatrixPointerType &rpA, TSystemVectorPointerType &rpDx, TSystemVectorPointerType &rpb, ModelPart &rModelPart)
 Constructs the matrix structure for the given problem. More...
 
void AssignSettings (const Parameters ThisParameters) override
 This method assigns settings to member variables. More...
 
- Protected Member Functions inherited from Kratos::BuilderAndSolver< TSparseSpace, TDenseSpace, TLinearSolver >
virtual Parameters ValidateAndAssignParameters (Parameters ThisParameters, const Parameters DefaultParameters) const
 This method validate and assign default parameters. More...
 
- Protected Attributes inherited from Kratos::TrilinosBlockBuilderAndSolver< TSparseSpace, TDenseSpace, TLinearSolver >
EpetraCommunicatorTypemrComm
 
int mGuessRowSize
 The MPI communicator. More...
 
IndexType mLocalSystemSize
 The guess row size. More...
 
int mFirstMyId
 The local system size. More...
 
int mLastMyId
 Auxiliary Id (the first row of the local system) More...
 
Kratos::shared_ptr< Epetra_Map > mpMap = nullptr
 Auxiliary Id (the last row of the local system) // TODO: This can be removed as can be deduced from mLocalSystemSize. More...
 
std::vector< intmFirstMyIds
 The map considered for the different vectors and matrices. More...
 
TSystemMatrixPointerType mpT = nullptr
 The ids corresponding to each partition (only used with MPC) More...
 
TSystemVectorPointerType mpConstantVector = nullptr
 This is matrix containing the global relation for the constraints. More...
 
std::vector< IndexTypemSlaveIds
 This is vector containing the rigid movement of the constraint. More...
 
std::vector< IndexTypemMasterIds
 The equation ids of the slaves. More...
 
std::unordered_set< IndexTypemInactiveSlaveDofs
 The equation ids of the master. More...
 
double mScaleFactor = 1.0
 The set containing the inactive slave dofs. More...
 
SCALING_DIAGONAL mScalingDiagonal = SCALING_DIAGONAL::CONSIDER_MAX_DIAGONAL
 The manually set scale factor. More...
 
Flags mOptions
 We identify the scaling considered for the dirichlet dofs. More...
 
- Protected Attributes inherited from Kratos::BuilderAndSolver< TSparseSpace, TDenseSpace, TLinearSolver >
TLinearSolver::Pointer mpLinearSystemSolver = nullptr
 
DofsArrayType mDofSet
 Pointer to the linear solver. More...
 
bool mReshapeMatrixFlag = false
 The set containing the DoF of the system. More...
 
bool mDofSetIsInitialized = false
 If the matrix is reshaped each step. More...
 
bool mCalculateReactionsFlag = false
 Flag taking care if the dof set was initialized ot not. More...
 
unsigned int mEquationSystemSize
 Flag taking in account if it is needed or not to calculate the reactions. More...
 
int mEchoLevel = 0
 Number of degrees of freedom of the problem to be solve. More...
 
TSystemVectorPointerType mpReactionsVector
 

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