|
static RCP< const Tpetra::MultiVector< Scalar, LocalOrdinal, GlobalOrdinal, Node > > | MV2TpetraMV (RCP< MultiVector > const vec) |
| Helper utility to pull out the underlying Tpetra objects from an Xpetra object. More...
|
|
static RCP< Tpetra::MultiVector< Scalar, LocalOrdinal, GlobalOrdinal, Node > > | MV2NonConstTpetraMV (RCP< MultiVector > vec) |
|
static RCP< Tpetra::MultiVector< Scalar, LocalOrdinal, GlobalOrdinal, Node > > | MV2NonConstTpetraMV2 (MultiVector &vec) |
|
static const Tpetra::MultiVector< Scalar, LocalOrdinal, GlobalOrdinal, Node > & | MV2TpetraMV (const MultiVector &vec) |
|
static Tpetra::MultiVector< Scalar, LocalOrdinal, GlobalOrdinal, Node > & | MV2NonConstTpetraMV (MultiVector &vec) |
|
static RCP< const Tpetra::CrsMatrix< Scalar, LocalOrdinal, GlobalOrdinal, Node > > | Op2TpetraCrs (RCP< const Matrix > Op) |
|
static RCP< Tpetra::CrsMatrix< Scalar, LocalOrdinal, GlobalOrdinal, Node > > | Op2NonConstTpetraCrs (RCP< Matrix > Op) |
|
static const Tpetra::CrsMatrix< Scalar, LocalOrdinal, GlobalOrdinal, Node > & | Op2TpetraCrs (const Matrix &Op) |
|
static Tpetra::CrsMatrix< Scalar, LocalOrdinal, GlobalOrdinal, Node > & | Op2NonConstTpetraCrs (Matrix &Op) |
|
static RCP< const Tpetra::RowMatrix< Scalar, LocalOrdinal, GlobalOrdinal, Node > > | Op2TpetraRow (RCP< const Matrix > Op) |
|
static RCP< Tpetra::RowMatrix< Scalar, LocalOrdinal, GlobalOrdinal, Node > > | Op2NonConstTpetraRow (RCP< Matrix > Op) |
|
static const RCP< const Tpetra::Map< LocalOrdinal, GlobalOrdinal, Node > > | Map2TpetraMap (const Map &map) |
|
static RCP< Matrix > | Crs2Op (RCP< CrsMatrix > Op) |
|
static Teuchos::ArrayRCP< Scalar > | GetMatrixDiagonal (const Matrix &A) |
|
static RCP< Vector > | GetMatrixDiagonalInverse (const Matrix &A, Magnitude tol=Teuchos::ScalarTraits< Scalar >::eps()*100) |
|
static Teuchos::ArrayRCP< Scalar > | GetLumpedMatrixDiagonal (const Matrix &A) |
|
static RCP< Vector > | GetMatrixOverlappedDiagonal (const Matrix &A) |
|
static Teuchos::Array< Magnitude > | ResidualNorm (const Xpetra::Operator< Scalar, LocalOrdinal, GlobalOrdinal, Node > &Op, const Xpetra::MultiVector< Scalar, LocalOrdinal, GlobalOrdinal, Node > &X, const Xpetra::MultiVector< Scalar, LocalOrdinal, GlobalOrdinal, Node > &RHS) |
|
static RCP< MultiVector > | Residual (const Xpetra::Operator< Scalar, LocalOrdinal, GlobalOrdinal, Node > &Op, const Xpetra::MultiVector< Scalar, LocalOrdinal, GlobalOrdinal, Node > &X, const Xpetra::MultiVector< Scalar, LocalOrdinal, GlobalOrdinal, Node > &RHS) |
|
static void | PauseForDebugger () |
|
static RCP< Teuchos::FancyOStream > | MakeFancy (std::ostream &os) |
|
static Teuchos::ScalarTraits< Scalar >::magnitudeType | Distance2 (const MultiVector &v, LocalOrdinal i0, LocalOrdinal i1) |
|
static Teuchos::ArrayRCP< const bool > | DetectDirichletRows (const Matrix &A, const Magnitude &tol=Teuchos::ScalarTraits< Scalar >::zero()) |
|
static void | SetRandomSeed (const Teuchos::Comm< int > &comm) |
|
static Scalar | PowerMethod (const Matrix &A, bool scaleByDiag=true, LocalOrdinal niters=10, Magnitude tolerance=1e-2, bool verbose=false, unsigned int seed=123) |
|
static Scalar | Frobenius (const Xpetra::Matrix< Scalar, LocalOrdinal, GlobalOrdinal, Node > &A, const Xpetra::Matrix< Scalar, LocalOrdinal, GlobalOrdinal, Node > &B) |
|
static void | MyOldScaleMatrix (Matrix &Op, const Teuchos::ArrayRCP< const Scalar > &scalingVector, bool doInverse=true, bool doFillComplete=true, bool doOptimizeStorage=true) |
|
static void | MyOldScaleMatrix_Tpetra (Matrix &Op, const Teuchos::ArrayRCP< Scalar > &scalingVector, bool doFillComplete, bool doOptimizeStorage) |
|
static void | MyOldScaleMatrix_Epetra (Matrix &Op, const Teuchos::ArrayRCP< Scalar > &scalingVector, bool doFillComplete, bool doOptimizeStorage) |
|
static RCP< Matrix > | Transpose (Matrix &Op, bool optimizeTranspose=false, const std::string &label=std::string()) |
| Transpose a Xpetra::Matrix. More...
|
|
static RCP< Matrix > | Crs2Op (RCP< CrsMatrix > Op) |
|
static Teuchos::ArrayRCP< double > | GetMatrixDiagonal (const Matrix &A) |
| Extract Matrix Diagonal. More...
|
|
static RCP< Vector > | GetMatrixDiagonalInverse (const Matrix &A, Magnitude tol=Teuchos::ScalarTraits< double >::eps()*100) |
| Extract Matrix Diagonal. More...
|
|
static Teuchos::ArrayRCP< double > | GetLumpedMatrixDiagonal (const Matrix &A) |
| Extract Matrix Diagonal of lumped matrix. More...
|
|
static RCP< Vector > | GetMatrixOverlappedDiagonal (const Matrix &A) |
| Extract Overlapped Matrix Diagonal. More...
|
|
static Teuchos::Array< Magnitude > | ResidualNorm (const Xpetra::Operator< double, int, int, Xpetra::EpetraNode > &Op, const MultiVector &X, const MultiVector &RHS) |
|
static RCP< MultiVector > | Residual (const Xpetra::Operator< double, int, int, Xpetra::EpetraNode > &Op, const MultiVector &X, const MultiVector &RHS) |
|
static void | PauseForDebugger () |
|
static double | PowerMethod (const Matrix &A, bool scaleByDiag=true, intniters=10, Magnitude tolerance=1e-2, bool verbose=false, unsigned int seed=123) |
| Simple transpose for Tpetra::CrsMatrix types. More...
|
|
static RCP< Teuchos::FancyOStream > | MakeFancy (std::ostream &os) |
|
static Teuchos::ScalarTraits< double >::magnitudeType | Distance2 (const Xpetra::MultiVector< double, int, int, Xpetra::EpetraNode > &v, inti0, inti1) |
| Squared distance between two rows in a multivector. More...
|
|
static Teuchos::ArrayRCP< const bool > | DetectDirichletRows (const Xpetra::Matrix< double, int, int, Xpetra::EpetraNode > &A, const Magnitude &tol=Teuchos::ScalarTraits< double >::zero()) |
| Detect Dirichlet rows. More...
|
|
static double | Frobenius (const Xpetra::Matrix< double, int, int, Xpetra::EpetraNode > &A, const Xpetra::Matrix< double, int, int, Xpetra::EpetraNode > &B) |
| Frobenius inner product of two matrices. More...
|
|
static void | SetRandomSeed (const Teuchos::Comm< int > &comm) |
| Set seed for random number generator. More...
|
|
|
typedef Xpetra::CrsMatrixWrap< Scalar, LocalOrdinal, GlobalOrdinal, Node > | CrsMatrixWrap |
|
typedef Xpetra::CrsMatrix< Scalar, LocalOrdinal, GlobalOrdinal, Node > | CrsMatrix |
|
typedef Xpetra::Matrix< Scalar, LocalOrdinal, GlobalOrdinal, Node > | Matrix |
|
typedef Xpetra::Vector< Scalar, LocalOrdinal, GlobalOrdinal, Node > | Vector |
|
typedef Xpetra::MultiVector< Scalar, LocalOrdinal, GlobalOrdinal, Node > | MultiVector |
|
typedef Xpetra::Map< LocalOrdinal, GlobalOrdinal, Node > | Map |
|
typedef Xpetra::EpetraMapT< GlobalOrdinal, Node > | EpetraMap |
|
typedef Xpetra::EpetraMultiVectorT< GlobalOrdinal, Node > | EpetraMultiVector |
|
typedef Xpetra::EpetraCrsMatrixT< GlobalOrdinal, Node > | EpetraCrsMatrix |
|
static RCP< const Epetra_MultiVector > | MV2EpetraMV (RCP< MultiVector > const vec) |
| Helper utility to pull out the underlying Epetra objects from an Xpetra object. More...
|
|
static RCP< Epetra_MultiVector > | MV2NonConstEpetraMV (RCP< MultiVector > vec) |
|
static const Epetra_MultiVector & | MV2EpetraMV (const MultiVector &vec) |
|
static Epetra_MultiVector & | MV2NonConstEpetraMV (MultiVector &vec) |
|
static RCP< const Epetra_CrsMatrix > | Op2EpetraCrs (RCP< const Matrix > Op) |
|
static RCP< Epetra_CrsMatrix > | Op2NonConstEpetraCrs (RCP< Matrix > Op) |
|
static const Epetra_CrsMatrix & | Op2EpetraCrs (const Matrix &Op) |
|
static Epetra_CrsMatrix & | Op2NonConstEpetraCrs (Matrix &Op) |
|
static const Epetra_Map & | Map2EpetraMap (const Map &map) |
|
template<>
class MueLu::Utilities< double, int, int, Xpetra::EpetraNode >
Definition at line 243 of file MueLu_Utilities_decl.hpp.