AssembleLHS(MatrixType &rA, const Matrix &rLHSContribution, const std::vector< std::size_t > &rEquationId) | Kratos::TrilinosSpace< TMatrixType, TVectorType > | inlinestatic |
AssembleRHS(VectorType &rb, const Vector &rRHSContribution, const std::vector< std::size_t > &rEquationId) | Kratos::TrilinosSpace< TMatrixType, TVectorType > | inlinestatic |
Assign(VectorType &rX, const double A, const VectorType &rY) | Kratos::TrilinosSpace< TMatrixType, TVectorType > | inlinestatic |
BDBtProductOperation(MatrixType &rA, const MatrixType &rD, const MatrixType &rB, const bool CallFillCompleteOnResult=true, const bool KeepAllHardZeros=false, const bool EnforceInitialGraph=false) | Kratos::TrilinosSpace< TMatrixType, TVectorType > | inlinestatic |
BtDBProductOperation(MatrixType &rA, const MatrixType &rD, const MatrixType &rB, const bool CallFillCompleteOnResult=true, const bool KeepAllHardZeros=false, const bool EnforceInitialGraph=false) | Kratos::TrilinosSpace< TMatrixType, TVectorType > | inlinestatic |
CheckAndCorrectZeroDiagonalValues(const ProcessInfo &rProcessInfo, MatrixType &rA, VectorType &rb, const SCALING_DIAGONAL ScalingDiagonal=SCALING_DIAGONAL::NO_SCALING) | Kratos::TrilinosSpace< TMatrixType, TVectorType > | inlinestatic |
Clear(MatrixPointerType &pA) | Kratos::TrilinosSpace< TMatrixType, TVectorType > | inlinestatic |
Clear(VectorPointerType &pX) | Kratos::TrilinosSpace< TMatrixType, TVectorType > | inlinestatic |
CombineMatricesGraphs(const MatrixType &rA, const MatrixType &rB) | Kratos::TrilinosSpace< TMatrixType, TVectorType > | inlinestatic |
Copy(const MatrixType &rX, MatrixType &rY) | Kratos::TrilinosSpace< TMatrixType, TVectorType > | inlinestatic |
Copy(const VectorType &rX, VectorType &rY) | Kratos::TrilinosSpace< TMatrixType, TVectorType > | inlinestatic |
CopyMatrixValues(MatrixType &rA, const MatrixType &rB) | Kratos::TrilinosSpace< TMatrixType, TVectorType > | inlinestatic |
CreateDofUpdater() | Kratos::TrilinosSpace< TMatrixType, TVectorType > | inlinestatic |
CreateEmptyMatrixPointer() | Kratos::TrilinosSpace< TMatrixType, TVectorType > | inlinestatic |
CreateEmptyMatrixPointer(Epetra_MpiComm &rComm) | Kratos::TrilinosSpace< TMatrixType, TVectorType > | inlinestatic |
CreateEmptyVectorPointer() | Kratos::TrilinosSpace< TMatrixType, TVectorType > | inlinestatic |
CreateEmptyVectorPointer(Epetra_MpiComm &rComm) | Kratos::TrilinosSpace< TMatrixType, TVectorType > | inlinestatic |
DataType typedef | Kratos::TrilinosSpace< TMatrixType, TVectorType > | |
DofUpdaterPointerType typedef | Kratos::TrilinosSpace< TMatrixType, TVectorType > | |
DofUpdaterType typedef | Kratos::TrilinosSpace< TMatrixType, TVectorType > | |
Dot(const VectorType &rX, const VectorType &rY) | Kratos::TrilinosSpace< TMatrixType, TVectorType > | inlinestatic |
GatherValues(const VectorType &rX, const std::vector< int > &IndexArray, double *pValues) | Kratos::TrilinosSpace< TMatrixType, TVectorType > | inlinestatic |
GetAveragevalueDiagonal(const MatrixType &rA) | Kratos::TrilinosSpace< TMatrixType, TVectorType > | inlinestatic |
GetColumn(const unsigned int j, const MatrixType &rM, VectorType &rX) | Kratos::TrilinosSpace< TMatrixType, TVectorType > | inlinestatic |
GetDiagonalNorm(const MatrixType &rA) | Kratos::TrilinosSpace< TMatrixType, TVectorType > | inlinestatic |
GetMaxDiagonal(const MatrixType &rA) | Kratos::TrilinosSpace< TMatrixType, TVectorType > | inlinestatic |
GetMinDiagonal(const MatrixType &rA) | Kratos::TrilinosSpace< TMatrixType, TVectorType > | inlinestatic |
GetScaleNorm(const ProcessInfo &rProcessInfo, const MatrixType &rA, const SCALING_DIAGONAL ScalingDiagonal=SCALING_DIAGONAL::NO_SCALING) | Kratos::TrilinosSpace< TMatrixType, TVectorType > | inlinestatic |
GetValue(const VectorType &rX, const std::size_t I) | Kratos::TrilinosSpace< TMatrixType, TVectorType > | inlinestatic |
IndexType typedef | Kratos::TrilinosSpace< TMatrixType, TVectorType > | |
Info() const | Kratos::TrilinosSpace< TMatrixType, TVectorType > | inlinevirtual |
InplaceMult(VectorType &rX, const double A) | Kratos::TrilinosSpace< TMatrixType, TVectorType > | inlinestatic |
IsDistributed() | Kratos::TrilinosSpace< TMatrixType, TVectorType > | inlinestatic |
IsDistributedSpace() | Kratos::TrilinosSpace< TMatrixType, TVectorType > | inlinestatic |
KRATOS_CLASS_POINTER_DEFINITION(TrilinosSpace) | Kratos::TrilinosSpace< TMatrixType, TVectorType > | |
MatrixPointerType typedef | Kratos::TrilinosSpace< TMatrixType, TVectorType > | |
MatrixType typedef | Kratos::TrilinosSpace< TMatrixType, TVectorType > | |
Max(const VectorType &rX) | Kratos::TrilinosSpace< TMatrixType, TVectorType > | inlinestatic |
Min(const VectorType &rX) | Kratos::TrilinosSpace< TMatrixType, TVectorType > | inlinestatic |
Mult(const MatrixType &rA, const VectorType &rX, VectorType &rY) | Kratos::TrilinosSpace< TMatrixType, TVectorType > | inlinestatic |
Mult(const MatrixType &rA, const MatrixType &rB, MatrixType &rC, const bool CallFillCompleteOnResult=true, const bool KeepAllHardZeros=false) | Kratos::TrilinosSpace< TMatrixType, TVectorType > | inlinestatic |
PrintData(std::ostream &rOStream) const | Kratos::TrilinosSpace< TMatrixType, TVectorType > | inlinevirtual |
PrintInfo(std::ostream &rOStream) const | Kratos::TrilinosSpace< TMatrixType, TVectorType > | inlinevirtual |
ReadMatrixMarket(const std::string FileName, Epetra_MpiComm &rComm) | Kratos::TrilinosSpace< TMatrixType, TVectorType > | inline |
ReadMatrixMarketVector(const std::string &rFileName, Epetra_MpiComm &rComm, const int N) | Kratos::TrilinosSpace< TMatrixType, TVectorType > | inline |
Resize(MatrixType &rA, const SizeType m, const SizeType n) | Kratos::TrilinosSpace< TMatrixType, TVectorType > | inlinestatic |
Resize(VectorType &rX, const SizeType n) | Kratos::TrilinosSpace< TMatrixType, TVectorType > | inlinestatic |
Resize(VectorPointerType &pX, const SizeType n) | Kratos::TrilinosSpace< TMatrixType, TVectorType > | inlinestatic |
ScaleAndAdd(const double A, const VectorType &rX, const double B, const VectorType &rY, VectorType &rZ) | Kratos::TrilinosSpace< TMatrixType, TVectorType > | inlinestatic |
ScaleAndAdd(const double A, const VectorType &rX, const double B, VectorType &rY) | Kratos::TrilinosSpace< TMatrixType, TVectorType > | inlinestatic |
Set(VectorType &rX, const DataType A) | Kratos::TrilinosSpace< TMatrixType, TVectorType > | inlinestatic |
SetToZero(MatrixType &rA) | Kratos::TrilinosSpace< TMatrixType, TVectorType > | inlinestatic |
SetToZero(VectorType &rX) | Kratos::TrilinosSpace< TMatrixType, TVectorType > | inlinestatic |
SetValue(VectorType &rX, IndexType i, const double value) | Kratos::TrilinosSpace< TMatrixType, TVectorType > | inlinestatic |
Size(const VectorType &rV) | Kratos::TrilinosSpace< TMatrixType, TVectorType > | inlinestatic |
Size1(MatrixType const &rM) | Kratos::TrilinosSpace< TMatrixType, TVectorType > | inlinestatic |
Size2(MatrixType const &rM) | Kratos::TrilinosSpace< TMatrixType, TVectorType > | inlinestatic |
SizeType typedef | Kratos::TrilinosSpace< TMatrixType, TVectorType > | |
TransposeMult(const MatrixType &rA, const VectorType &rX, VectorType &rY) | Kratos::TrilinosSpace< TMatrixType, TVectorType > | inlinestatic |
TransposeMult(const MatrixType &rA, const MatrixType &rB, MatrixType &rC, const std::pair< bool, bool > TransposeFlag={false, false}, const bool CallFillCompleteOnResult=true, const bool KeepAllHardZeros=false) | Kratos::TrilinosSpace< TMatrixType, TVectorType > | inlinestatic |
TrilinosSpace() | Kratos::TrilinosSpace< TMatrixType, TVectorType > | inline |
TwoNorm(const VectorType &rX) | Kratos::TrilinosSpace< TMatrixType, TVectorType > | inlinestatic |
TwoNorm(const MatrixType &rA) | Kratos::TrilinosSpace< TMatrixType, TVectorType > | inlinestatic |
UnaliasedAdd(VectorType &rX, const double A, const VectorType &rY) | Kratos::TrilinosSpace< TMatrixType, TVectorType > | inlinestatic |
VectorPointerType typedef | Kratos::TrilinosSpace< TMatrixType, TVectorType > | |
VectorType typedef | Kratos::TrilinosSpace< TMatrixType, TVectorType > | |
WriteMatrixMarketMatrix(const char *pFileName, const TOtherMatrixType &rM, const bool Symmetric) | Kratos::TrilinosSpace< TMatrixType, TVectorType > | inlinestatic |
WriteMatrixMarketVector(const char *pFileName, const VectorType &rV) | Kratos::TrilinosSpace< TMatrixType, TVectorType > | inlinestatic |
~TrilinosSpace() | Kratos::TrilinosSpace< TMatrixType, TVectorType > | inlinevirtual |