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::TrilinosAssemblingUtilities Class Reference

The Trilinos assembling utilities. More...

#include <trilinos_assembling_utilities.h>

Collaboration diagram for Kratos::TrilinosAssemblingUtilities:

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...
 

Detailed Description

The Trilinos assembling utilities.

Author
Vicente Mataix Ferrandiz

Member Typedef Documentation

◆ IndexType

Definition of the index type.

◆ MatrixType

Definition of the matrix type.

◆ SizeType

Definition of the size type.

◆ TrilinosSparseSpaceType

Definition of Trilinos space.

◆ VectorType

Definition of the vector type.

Constructor & Destructor Documentation

◆ TrilinosAssemblingUtilities()

Kratos::TrilinosAssemblingUtilities::TrilinosAssemblingUtilities ( )
delete

Default constructor.

Member Function Documentation

◆ AssembleConstantVector()

static void Kratos::TrilinosAssemblingUtilities::AssembleConstantVector ( VectorType rC,
const Vector rConstantContribution,
const std::vector< std::size_t > &  rSlaveEquationId 
)
inlinestatic

Assembles the Constant vector of the system with MPC.

Parameters
rCThe constant vector
rConstantContributionThe RHS contribution
rEquationIdThe equation ids

◆ AssembleRelationMatrixT()

static void Kratos::TrilinosAssemblingUtilities::AssembleRelationMatrixT ( MatrixType rT,
const Matrix rTContribution,
const std::vector< std::size_t > &  rSlaveEquationId,
const std::vector< std::size_t > &  rMasterEquationId 
)
inlinestatic

Assembles the relation matrix T of the system with MPC.

Parameters
rTThe T relation matrix
rTContributionThe contribution to the T
rSlaveEquationIdThe slave equation ids
rMasterEquationIdThe master equation ids

◆ Info()

virtual std::string Kratos::TrilinosAssemblingUtilities::Info ( ) const
inlinevirtual

Turn back information as a string.

Returns
Info as a string.

◆ KRATOS_CLASS_POINTER_DEFINITION()

Kratos::TrilinosAssemblingUtilities::KRATOS_CLASS_POINTER_DEFINITION ( TrilinosAssemblingUtilities  )

Pointer definition of TrilinosAssemblingUtilities.

◆ PrintData()

virtual void Kratos::TrilinosAssemblingUtilities::PrintData ( std::ostream &  rOStream) const
inlinevirtual

Print object's data.

Parameters
rOStreamThe output stream to print on.

◆ PrintInfo()

virtual void Kratos::TrilinosAssemblingUtilities::PrintInfo ( std::ostream &  rOStream) const
inlinevirtual

Print information about this object.

Parameters
rOStreamThe output stream to print on.

◆ SetGlobalValue() [1/2]

static void Kratos::TrilinosAssemblingUtilities::SetGlobalValue ( MatrixType rA,
IndexType  i,
IndexType  j,
const double  Value 
)
inlinestatic

Sets a value in a matrix.

Parameters
rXThe vector considered
iThe first index of the value considered
jThe second index of the value considered
ValueThe value considered

◆ SetGlobalValue() [2/2]

static void Kratos::TrilinosAssemblingUtilities::SetGlobalValue ( VectorType rX,
IndexType  i,
const double  Value 
)
inlinestatic

Sets a value in a vector.

Parameters
rXThe vector considered
iThe index of the value considered
ValueThe value considered

◆ SetGlobalValueWithoutGlobalAssembly() [1/2]

static void Kratos::TrilinosAssemblingUtilities::SetGlobalValueWithoutGlobalAssembly ( MatrixType rA,
IndexType  i,
IndexType  j,
const double  Value 
)
inlinestatic

Sets a value in a matrix.

Parameters
rXThe vector considered
iThe first index of the value considered
jThe second index of the value considered
ValueThe value considered

◆ SetGlobalValueWithoutGlobalAssembly() [2/2]

static void Kratos::TrilinosAssemblingUtilities::SetGlobalValueWithoutGlobalAssembly ( VectorType rX,
IndexType  i,
const double  Value 
)
inlinestatic

Sets a value in a vector.

Parameters
rXThe vector considered
iThe index of the value considered
ValueThe value considered

◆ SetLocalValue() [1/2]

static void Kratos::TrilinosAssemblingUtilities::SetLocalValue ( MatrixType rA,
IndexType  i,
IndexType  j,
const double  Value 
)
inlinestatic

Sets a value in a matrix.

Parameters
rXThe vector considered
iThe first index of the value considered
jThe second index of the value considered
ValueThe value considered

◆ SetLocalValue() [2/2]

static void Kratos::TrilinosAssemblingUtilities::SetLocalValue ( VectorType rX,
IndexType  i,
const double  Value 
)
inlinestatic

Sets a value in a vector (local)

Parameters
rXThe vector considered
iThe index of the value considered
ValueThe value considered

◆ SetLocalValueWithoutGlobalAssembly() [1/2]

static void Kratos::TrilinosAssemblingUtilities::SetLocalValueWithoutGlobalAssembly ( MatrixType rA,
IndexType  i,
IndexType  j,
const double  Value 
)
inlinestatic

Sets a value in a matrix.

Parameters
rXThe vector considered
iThe first index of the value considered
jThe second index of the value considered
ValueThe value considered

◆ SetLocalValueWithoutGlobalAssembly() [2/2]

static void Kratos::TrilinosAssemblingUtilities::SetLocalValueWithoutGlobalAssembly ( VectorType rX,
IndexType  i,
const double  Value 
)
inlinestatic

Sets a value in a vector (local without global assembly)

Parameters
rXThe vector considered
iThe index of the value considered
ValueThe value considered

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