MueLu  Version of the Day
MueLu::Utilities< double, int, int, Xpetra::EpetraNode > Class Template Reference

#include <MueLu_Utilities_decl.hpp>

Inheritance diagram for MueLu::Utilities< double, int, int, Xpetra::EpetraNode >:
MueLu::UtilitiesBase< double, int, int, Xpetra::EpetraNode >

Public Types

typedef double Scalar
 
typedef int LocalOrdinal
 
typedef int GlobalOrdinal
 
typedef Xpetra::EpetraNode Node
 
typedef Teuchos::ScalarTraits< Scalar >::magnitudeType Magnitude
 
- Public Types inherited from MueLu::UtilitiesBase< double, int, int, Xpetra::EpetraNode >
typedef Teuchos::ScalarTraits< double >::magnitudeType Magnitude
 

Static Public Member Functions

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< MatrixCrs2Op (RCP< CrsMatrix > Op)
 
static Teuchos::ArrayRCP< ScalarGetMatrixDiagonal (const Matrix &A)
 
static RCP< VectorGetMatrixDiagonalInverse (const Matrix &A, Magnitude tol=Teuchos::ScalarTraits< Scalar >::eps()*100)
 
static Teuchos::ArrayRCP< ScalarGetLumpedMatrixDiagonal (const Matrix &A)
 
static RCP< VectorGetMatrixOverlappedDiagonal (const Matrix &A)
 
static Teuchos::Array< MagnitudeResidualNorm (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< MultiVectorResidual (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< MatrixTranspose (Matrix &Op, bool optimizeTranspose=false, const std::string &label=std::string())
 Transpose a Xpetra::Matrix. More...
 
- Static Public Member Functions inherited from MueLu::UtilitiesBase< double, int, int, Xpetra::EpetraNode >
static RCP< MatrixCrs2Op (RCP< CrsMatrix > Op)
 
static Teuchos::ArrayRCP< double > GetMatrixDiagonal (const Matrix &A)
 Extract Matrix Diagonal. More...
 
static RCP< VectorGetMatrixDiagonalInverse (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< VectorGetMatrixOverlappedDiagonal (const Matrix &A)
 Extract Overlapped Matrix Diagonal. More...
 
static Teuchos::Array< MagnitudeResidualNorm (const Xpetra::Operator< double, int, int, Xpetra::EpetraNode > &Op, const MultiVector &X, const MultiVector &RHS)
 
static RCP< MultiVectorResidual (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...
 

Private Types

typedef Xpetra::CrsMatrixWrap< Scalar, LocalOrdinal, GlobalOrdinal, NodeCrsMatrixWrap
 
typedef Xpetra::CrsMatrix< Scalar, LocalOrdinal, GlobalOrdinal, NodeCrsMatrix
 
typedef Xpetra::Matrix< Scalar, LocalOrdinal, GlobalOrdinal, NodeMatrix
 
typedef Xpetra::Vector< Scalar, LocalOrdinal, GlobalOrdinal, NodeVector
 
typedef Xpetra::MultiVector< Scalar, LocalOrdinal, GlobalOrdinal, NodeMultiVector
 
typedef Xpetra::Map< LocalOrdinal, GlobalOrdinal, NodeMap
 
typedef Xpetra::EpetraMapT< GlobalOrdinal, NodeEpetraMap
 
typedef Xpetra::EpetraMultiVectorT< GlobalOrdinal, NodeEpetraMultiVector
 
typedef Xpetra::EpetraCrsMatrixT< GlobalOrdinal, NodeEpetraCrsMatrix
 
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)
 

Detailed Description

template<>
class MueLu::Utilities< double, int, int, Xpetra::EpetraNode >

Definition at line 243 of file MueLu_Utilities_decl.hpp.

Member Typedef Documentation

typedef double MueLu::Utilities< double, int, int, Xpetra::EpetraNode >::Scalar

Definition at line 245 of file MueLu_Utilities_decl.hpp.

typedef int MueLu::Utilities< double, int, int, Xpetra::EpetraNode >::LocalOrdinal

Definition at line 246 of file MueLu_Utilities_decl.hpp.

typedef int MueLu::Utilities< double, int, int, Xpetra::EpetraNode >::GlobalOrdinal

Definition at line 247 of file MueLu_Utilities_decl.hpp.

Definition at line 248 of file MueLu_Utilities_decl.hpp.

typedef Teuchos::ScalarTraits<Scalar>::magnitudeType MueLu::Utilities< double, int, int, Xpetra::EpetraNode >::Magnitude

Definition at line 249 of file MueLu_Utilities_decl.hpp.

typedef Xpetra::CrsMatrixWrap<Scalar,LocalOrdinal,GlobalOrdinal,Node> MueLu::Utilities< double, int, int, Xpetra::EpetraNode >::CrsMatrixWrap
private

Definition at line 252 of file MueLu_Utilities_decl.hpp.

typedef Xpetra::CrsMatrix<Scalar,LocalOrdinal,GlobalOrdinal,Node> MueLu::Utilities< double, int, int, Xpetra::EpetraNode >::CrsMatrix
private

Definition at line 253 of file MueLu_Utilities_decl.hpp.

typedef Xpetra::Matrix<Scalar,LocalOrdinal,GlobalOrdinal,Node> MueLu::Utilities< double, int, int, Xpetra::EpetraNode >::Matrix
private

Definition at line 254 of file MueLu_Utilities_decl.hpp.

typedef Xpetra::Vector<Scalar,LocalOrdinal,GlobalOrdinal,Node> MueLu::Utilities< double, int, int, Xpetra::EpetraNode >::Vector
private

Definition at line 255 of file MueLu_Utilities_decl.hpp.

typedef Xpetra::MultiVector<Scalar,LocalOrdinal,GlobalOrdinal,Node> MueLu::Utilities< double, int, int, Xpetra::EpetraNode >::MultiVector
private

Definition at line 256 of file MueLu_Utilities_decl.hpp.

typedef Xpetra::Map<LocalOrdinal,GlobalOrdinal,Node> MueLu::Utilities< double, int, int, Xpetra::EpetraNode >::Map
private

Definition at line 257 of file MueLu_Utilities_decl.hpp.

typedef Xpetra::EpetraMapT<GlobalOrdinal,Node> MueLu::Utilities< double, int, int, Xpetra::EpetraNode >::EpetraMap
private

Definition at line 259 of file MueLu_Utilities_decl.hpp.

typedef Xpetra::EpetraMultiVectorT<GlobalOrdinal,Node> MueLu::Utilities< double, int, int, Xpetra::EpetraNode >::EpetraMultiVector
private

Definition at line 260 of file MueLu_Utilities_decl.hpp.

typedef Xpetra::EpetraCrsMatrixT<GlobalOrdinal,Node> MueLu::Utilities< double, int, int, Xpetra::EpetraNode >::EpetraCrsMatrix
private

Definition at line 261 of file MueLu_Utilities_decl.hpp.

Member Function Documentation

static RCP<const Epetra_MultiVector> MueLu::Utilities< double, int, int, Xpetra::EpetraNode >::MV2EpetraMV ( RCP< MultiVector > const  vec)
inlinestatic

Helper utility to pull out the underlying Epetra objects from an Xpetra object.

Definition at line 268 of file MueLu_Utilities_decl.hpp.

static RCP< Epetra_MultiVector> MueLu::Utilities< double, int, int, Xpetra::EpetraNode >::MV2NonConstEpetraMV ( RCP< MultiVector vec)
inlinestatic

Definition at line 274 of file MueLu_Utilities_decl.hpp.

static const Epetra_MultiVector& MueLu::Utilities< double, int, int, Xpetra::EpetraNode >::MV2EpetraMV ( const MultiVector vec)
inlinestatic

Definition at line 281 of file MueLu_Utilities_decl.hpp.

static Epetra_MultiVector& MueLu::Utilities< double, int, int, Xpetra::EpetraNode >::MV2NonConstEpetraMV ( MultiVector vec)
inlinestatic

Definition at line 285 of file MueLu_Utilities_decl.hpp.

static RCP<const Epetra_CrsMatrix> MueLu::Utilities< double, int, int, Xpetra::EpetraNode >::Op2EpetraCrs ( RCP< const Matrix Op)
inlinestatic

Definition at line 290 of file MueLu_Utilities_decl.hpp.

static RCP< Epetra_CrsMatrix> MueLu::Utilities< double, int, int, Xpetra::EpetraNode >::Op2NonConstEpetraCrs ( RCP< Matrix Op)
inlinestatic

Definition at line 299 of file MueLu_Utilities_decl.hpp.

static const Epetra_CrsMatrix& MueLu::Utilities< double, int, int, Xpetra::EpetraNode >::Op2EpetraCrs ( const Matrix Op)
inlinestatic

Definition at line 309 of file MueLu_Utilities_decl.hpp.

static Epetra_CrsMatrix& MueLu::Utilities< double, int, int, Xpetra::EpetraNode >::Op2NonConstEpetraCrs ( Matrix Op)
inlinestatic

Definition at line 322 of file MueLu_Utilities_decl.hpp.

static const Epetra_Map& MueLu::Utilities< double, int, int, Xpetra::EpetraNode >::Map2EpetraMap ( const Map map)
inlinestatic

Definition at line 336 of file MueLu_Utilities_decl.hpp.

static RCP<const Tpetra::MultiVector<Scalar,LocalOrdinal,GlobalOrdinal,Node> > MueLu::Utilities< double, int, int, Xpetra::EpetraNode >::MV2TpetraMV ( RCP< MultiVector > const  vec)
inlinestatic

Helper utility to pull out the underlying Tpetra objects from an Xpetra object.

Definition at line 347 of file MueLu_Utilities_decl.hpp.

static RCP< Tpetra::MultiVector<Scalar,LocalOrdinal,GlobalOrdinal,Node> > MueLu::Utilities< double, int, int, Xpetra::EpetraNode >::MV2NonConstTpetraMV ( RCP< MultiVector vec)
inlinestatic

Definition at line 358 of file MueLu_Utilities_decl.hpp.

static RCP< Tpetra::MultiVector<Scalar,LocalOrdinal,GlobalOrdinal,Node> > MueLu::Utilities< double, int, int, Xpetra::EpetraNode >::MV2NonConstTpetraMV2 ( MultiVector vec)
inlinestatic

Definition at line 370 of file MueLu_Utilities_decl.hpp.

static const Tpetra::MultiVector<Scalar,LocalOrdinal,GlobalOrdinal,Node>& MueLu::Utilities< double, int, int, Xpetra::EpetraNode >::MV2TpetraMV ( const MultiVector vec)
inlinestatic

Definition at line 380 of file MueLu_Utilities_decl.hpp.

static Tpetra::MultiVector<Scalar,LocalOrdinal,GlobalOrdinal,Node>& MueLu::Utilities< double, int, int, Xpetra::EpetraNode >::MV2NonConstTpetraMV ( MultiVector vec)
inlinestatic

Definition at line 389 of file MueLu_Utilities_decl.hpp.

static RCP<const Tpetra::CrsMatrix<Scalar,LocalOrdinal,GlobalOrdinal,Node> > MueLu::Utilities< double, int, int, Xpetra::EpetraNode >::Op2TpetraCrs ( RCP< const Matrix Op)
inlinestatic

Definition at line 399 of file MueLu_Utilities_decl.hpp.

static RCP< Tpetra::CrsMatrix<Scalar,LocalOrdinal,GlobalOrdinal,Node> > MueLu::Utilities< double, int, int, Xpetra::EpetraNode >::Op2NonConstTpetraCrs ( RCP< Matrix Op)
inlinestatic

Definition at line 414 of file MueLu_Utilities_decl.hpp.

static const Tpetra::CrsMatrix<Scalar,LocalOrdinal,GlobalOrdinal,Node>& MueLu::Utilities< double, int, int, Xpetra::EpetraNode >::Op2TpetraCrs ( const Matrix Op)
inlinestatic

Definition at line 429 of file MueLu_Utilities_decl.hpp.

static Tpetra::CrsMatrix<Scalar,LocalOrdinal,GlobalOrdinal,Node>& MueLu::Utilities< double, int, int, Xpetra::EpetraNode >::Op2NonConstTpetraCrs ( Matrix Op)
inlinestatic

Definition at line 447 of file MueLu_Utilities_decl.hpp.

static RCP<const Tpetra::RowMatrix<Scalar,LocalOrdinal,GlobalOrdinal,Node> > MueLu::Utilities< double, int, int, Xpetra::EpetraNode >::Op2TpetraRow ( RCP< const Matrix Op)
inlinestatic

Definition at line 466 of file MueLu_Utilities_decl.hpp.

static RCP< Tpetra::RowMatrix<Scalar,LocalOrdinal,GlobalOrdinal,Node> > MueLu::Utilities< double, int, int, Xpetra::EpetraNode >::Op2NonConstTpetraRow ( RCP< Matrix Op)
inlinestatic

Definition at line 489 of file MueLu_Utilities_decl.hpp.

static const RCP<const Tpetra::Map<LocalOrdinal,GlobalOrdinal,Node> > MueLu::Utilities< double, int, int, Xpetra::EpetraNode >::Map2TpetraMap ( const Map map)
inlinestatic

Definition at line 514 of file MueLu_Utilities_decl.hpp.

static RCP<Matrix> MueLu::Utilities< double, int, int, Xpetra::EpetraNode >::Crs2Op ( RCP< CrsMatrix Op)
inlinestatic

Definition at line 527 of file MueLu_Utilities_decl.hpp.

static Teuchos::ArrayRCP<Scalar> MueLu::Utilities< double, int, int, Xpetra::EpetraNode >::GetMatrixDiagonal ( const Matrix A)
inlinestatic

Definition at line 528 of file MueLu_Utilities_decl.hpp.

static RCP<Vector> MueLu::Utilities< double, int, int, Xpetra::EpetraNode >::GetMatrixDiagonalInverse ( const Matrix A,
Magnitude  tol = Teuchos::ScalarTraits<Scalar>::eps()*100 
)
inlinestatic

Definition at line 529 of file MueLu_Utilities_decl.hpp.

static Teuchos::ArrayRCP<Scalar> MueLu::Utilities< double, int, int, Xpetra::EpetraNode >::GetLumpedMatrixDiagonal ( const Matrix A)
inlinestatic

Definition at line 530 of file MueLu_Utilities_decl.hpp.

static RCP<Vector> MueLu::Utilities< double, int, int, Xpetra::EpetraNode >::GetMatrixOverlappedDiagonal ( const Matrix A)
inlinestatic

Definition at line 531 of file MueLu_Utilities_decl.hpp.

static Teuchos::Array<Magnitude> MueLu::Utilities< double, int, int, Xpetra::EpetraNode >::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 
)
inlinestatic

Definition at line 532 of file MueLu_Utilities_decl.hpp.

static RCP<MultiVector> MueLu::Utilities< double, int, int, Xpetra::EpetraNode >::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 
)
inlinestatic

Definition at line 533 of file MueLu_Utilities_decl.hpp.

static void MueLu::Utilities< double, int, int, Xpetra::EpetraNode >::PauseForDebugger ( )
inlinestatic

Definition at line 534 of file MueLu_Utilities_decl.hpp.

static RCP<Teuchos::FancyOStream> MueLu::Utilities< double, int, int, Xpetra::EpetraNode >::MakeFancy ( std::ostream &  os)
inlinestatic

Definition at line 535 of file MueLu_Utilities_decl.hpp.

static Teuchos::ScalarTraits<Scalar>::magnitudeType MueLu::Utilities< double, int, int, Xpetra::EpetraNode >::Distance2 ( const MultiVector v,
LocalOrdinal  i0,
LocalOrdinal  i1 
)
inlinestatic

Definition at line 536 of file MueLu_Utilities_decl.hpp.

static Teuchos::ArrayRCP<const bool> MueLu::Utilities< double, int, int, Xpetra::EpetraNode >::DetectDirichletRows ( const Matrix A,
const Magnitude tol = Teuchos::ScalarTraits<Scalar>::zero() 
)
inlinestatic

Definition at line 537 of file MueLu_Utilities_decl.hpp.

static void MueLu::Utilities< double, int, int, Xpetra::EpetraNode >::SetRandomSeed ( const Teuchos::Comm< int > &  comm)
inlinestatic

Definition at line 538 of file MueLu_Utilities_decl.hpp.

static Scalar MueLu::Utilities< double, int, int, Xpetra::EpetraNode >::PowerMethod ( const Matrix A,
bool  scaleByDiag = true,
LocalOrdinal  niters = 10,
Magnitude  tolerance = 1e-2,
bool  verbose = false,
unsigned int  seed = 123 
)
inlinestatic

Definition at line 540 of file MueLu_Utilities_decl.hpp.

static Scalar MueLu::Utilities< double, int, int, Xpetra::EpetraNode >::Frobenius ( const Xpetra::Matrix< Scalar, LocalOrdinal, GlobalOrdinal, Node > &  A,
const Xpetra::Matrix< Scalar, LocalOrdinal, GlobalOrdinal, Node > &  B 
)
inlinestatic

Definition at line 545 of file MueLu_Utilities_decl.hpp.

static void MueLu::Utilities< double, int, int, Xpetra::EpetraNode >::MyOldScaleMatrix ( Matrix Op,
const Teuchos::ArrayRCP< const Scalar > &  scalingVector,
bool  doInverse = true,
bool  doFillComplete = true,
bool  doOptimizeStorage = true 
)
inlinestatic

Definition at line 549 of file MueLu_Utilities_decl.hpp.

static void MueLu::Utilities< double, int, int, Xpetra::EpetraNode >::MyOldScaleMatrix_Tpetra ( Matrix Op,
const Teuchos::ArrayRCP< Scalar > &  scalingVector,
bool  doFillComplete,
bool  doOptimizeStorage 
)
inlinestatic

Definition at line 577 of file MueLu_Utilities_decl.hpp.

static void MueLu::Utilities< double, int, int, Xpetra::EpetraNode >::MyOldScaleMatrix_Epetra ( Matrix Op,
const Teuchos::ArrayRCP< Scalar > &  scalingVector,
bool  doFillComplete,
bool  doOptimizeStorage 
)
inlinestatic

Definition at line 660 of file MueLu_Utilities_decl.hpp.

static RCP<Matrix> MueLu::Utilities< double, int, int, Xpetra::EpetraNode >::Transpose ( Matrix Op,
bool  optimizeTranspose = false,
const std::string &  label = std::string() 
)
inlinestatic

Transpose a Xpetra::Matrix.

Note: Currently, an error is thrown if the matrix isn't a Tpetra::CrsMatrix or Epetra_CrsMatrix. In principle, however, we could allow any Epetra_RowMatrix because the Epetra transposer does.

Definition at line 690 of file MueLu_Utilities_decl.hpp.


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