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.
|
The Trilinos assembling utilities. More...
#include <trilinos_assembling_utilities.h>
Public Member Functions | |
Life Cycle | |
TrilinosAssemblingUtilities ()=delete | |
Default constructor. More... | |
Input and output | |
virtual std::string | Info () const |
Turn back information as a string. More... | |
virtual void | PrintInfo (std::ostream &rOStream) const |
Print information about this object. More... | |
virtual void | PrintData (std::ostream &rOStream) const |
Print object's data. More... | |
Static Public Member Functions | |
Operations | |
static void | AssembleRelationMatrixT (MatrixType &rT, const Matrix &rTContribution, const std::vector< std::size_t > &rSlaveEquationId, const std::vector< std::size_t > &rMasterEquationId) |
Assembles the relation matrix T of the system with MPC. More... | |
static void | AssembleConstantVector (VectorType &rC, const Vector &rConstantContribution, const std::vector< std::size_t > &rSlaveEquationId) |
Assembles the Constant vector of the system with MPC. More... | |
static void | SetGlobalValue (VectorType &rX, IndexType i, const double Value) |
Sets a value in a vector. More... | |
static void | SetGlobalValueWithoutGlobalAssembly (VectorType &rX, IndexType i, const double Value) |
Sets a value in a vector. More... | |
static void | SetLocalValue (VectorType &rX, IndexType i, const double Value) |
Sets a value in a vector (local) More... | |
static void | SetLocalValueWithoutGlobalAssembly (VectorType &rX, IndexType i, const double Value) |
Sets a value in a vector (local without global assembly) More... | |
static void | SetGlobalValue (MatrixType &rA, IndexType i, IndexType j, const double Value) |
Sets a value in a matrix. More... | |
static void | SetGlobalValueWithoutGlobalAssembly (MatrixType &rA, IndexType i, IndexType j, const double Value) |
Sets a value in a matrix. More... | |
static void | SetLocalValue (MatrixType &rA, IndexType i, IndexType j, const double Value) |
Sets a value in a matrix. More... | |
static void | SetLocalValueWithoutGlobalAssembly (MatrixType &rA, IndexType i, IndexType j, const double Value) |
Sets a value in a matrix. More... | |
Type Definitions | |
using | TrilinosSparseSpaceType = TrilinosSpace< Epetra_FECrsMatrix, Epetra_FEVector > |
Definition of Trilinos space. More... | |
using | MatrixType = TrilinosSparseSpaceType::MatrixType |
Definition of the matrix type. More... | |
using | VectorType = TrilinosSparseSpaceType::VectorType |
Definition of the vector type. More... | |
using | IndexType = std::size_t |
Definition of the index type. More... | |
using | SizeType = std::size_t |
Definition of the size type. More... | |
KRATOS_CLASS_POINTER_DEFINITION (TrilinosAssemblingUtilities) | |
Pointer definition of TrilinosAssemblingUtilities. More... | |
The Trilinos assembling utilities.
using Kratos::TrilinosAssemblingUtilities::IndexType = std::size_t |
Definition of the index type.
Definition of the matrix type.
using Kratos::TrilinosAssemblingUtilities::SizeType = std::size_t |
Definition of the size type.
using Kratos::TrilinosAssemblingUtilities::TrilinosSparseSpaceType = TrilinosSpace<Epetra_FECrsMatrix, Epetra_FEVector> |
Definition of Trilinos space.
Definition of the vector type.
|
delete |
Default constructor.
|
inlinestatic |
Assembles the Constant vector of the system with MPC.
rC | The constant vector |
rConstantContribution | The RHS contribution |
rEquationId | The equation ids |
|
inlinestatic |
Assembles the relation matrix T of the system with MPC.
rT | The T relation matrix |
rTContribution | The contribution to the T |
rSlaveEquationId | The slave equation ids |
rMasterEquationId | The master equation ids |
|
inlinevirtual |
Turn back information as a string.
Kratos::TrilinosAssemblingUtilities::KRATOS_CLASS_POINTER_DEFINITION | ( | TrilinosAssemblingUtilities | ) |
Pointer definition of TrilinosAssemblingUtilities.
|
inlinevirtual |
Print object's data.
rOStream | The output stream to print on. |
|
inlinevirtual |
Print information about this object.
rOStream | The output stream to print on. |
|
inlinestatic |
Sets a value in a matrix.
rX | The vector considered |
i | The first index of the value considered |
j | The second index of the value considered |
Value | The value considered |
|
inlinestatic |
Sets a value in a vector.
rX | The vector considered |
i | The index of the value considered |
Value | The value considered |
|
inlinestatic |
Sets a value in a matrix.
rX | The vector considered |
i | The first index of the value considered |
j | The second index of the value considered |
Value | The value considered |
|
inlinestatic |
Sets a value in a vector.
rX | The vector considered |
i | The index of the value considered |
Value | The value considered |
|
inlinestatic |
Sets a value in a matrix.
rX | The vector considered |
i | The first index of the value considered |
j | The second index of the value considered |
Value | The value considered |
|
inlinestatic |
Sets a value in a vector (local)
rX | The vector considered |
i | The index of the value considered |
Value | The value considered |
|
inlinestatic |
Sets a value in a matrix.
rX | The vector considered |
i | The first index of the value considered |
j | The second index of the value considered |
Value | The value considered |
|
inlinestatic |
Sets a value in a vector (local without global assembly)
rX | The vector considered |
i | The index of the value considered |
Value | The value considered |