MueLu
Version of the Day
|
#include <MueLu_UtilitiesBase_fwd.hpp>
Public Types | |
typedef Teuchos::ScalarTraits< Scalar >::magnitudeType | Magnitude |
Static Public Member Functions | |
static RCP< Matrix > | Crs2Op (RCP< CrsMatrix > Op) |
static Teuchos::ArrayRCP< Scalar > | GetMatrixDiagonal (const Matrix &A) |
Extract Matrix Diagonal. More... | |
static RCP< Vector > | GetMatrixDiagonalInverse (const Matrix &A, Magnitude tol=Teuchos::ScalarTraits< Scalar >::eps() *100) |
Extract Matrix Diagonal. More... | |
static Teuchos::ArrayRCP< Scalar > | GetLumpedMatrixDiagonal (const Matrix &A) |
Extract Matrix Diagonal of lumped matrix. More... | |
static Teuchos::RCP< Vector > | GetLumpedMatrixDiagonal (Teuchos::RCP< const Matrix > rcpA) |
Extract Matrix Diagonal of lumped matrix. More... | |
static Teuchos::RCP< Vector > | GetInverse (Teuchos::RCP< const Vector > v, Magnitude tol=Teuchos::ScalarTraits< Scalar >::eps() *100, Scalar tolReplacement=Teuchos::ScalarTraits< Scalar >::zero()) |
Return vector containing inverse of input vector. More... | |
static RCP< Vector > | GetMatrixOverlappedDiagonal (const Matrix &A) |
Extract Overlapped Matrix Diagonal. More... | |
static Teuchos::Array< Magnitude > | ResidualNorm (const Xpetra::Operator< Scalar, LocalOrdinal, GlobalOrdinal, Node > &Op, const MultiVector &X, const MultiVector &RHS) |
static RCP< MultiVector > | Residual (const Xpetra::Operator< Scalar, LocalOrdinal, GlobalOrdinal, Node > &Op, const MultiVector &X, const MultiVector &RHS) |
static void | PauseForDebugger () |
static Scalar | PowerMethod (const Matrix &A, bool scaleByDiag=true, LocalOrdinal niters=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< Scalar >::magnitudeType | Distance2 (const Xpetra::MultiVector< Scalar, LocalOrdinal, GlobalOrdinal, Node > &v, LocalOrdinal i0, LocalOrdinal i1) |
Squared distance between two rows in a multivector. More... | |
static Teuchos::ArrayRCP< const bool > | DetectDirichletRows (const Xpetra::Matrix< Scalar, LocalOrdinal, GlobalOrdinal, Node > &A, const Magnitude &tol=Teuchos::ScalarTraits< Scalar >::zero()) |
Detect Dirichlet rows. More... | |
static Scalar | Frobenius (const Xpetra::Matrix< Scalar, LocalOrdinal, GlobalOrdinal, Node > &A, const Xpetra::Matrix< Scalar, LocalOrdinal, GlobalOrdinal, Node > &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, 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 |
Definition at line 54 of file MueLu_UtilitiesBase_fwd.hpp.
|
private |
Definition at line 108 of file MueLu_UtilitiesBase_decl.hpp.
|
private |
Definition at line 109 of file MueLu_UtilitiesBase_decl.hpp.
|
private |
Definition at line 110 of file MueLu_UtilitiesBase_decl.hpp.
|
private |
Definition at line 111 of file MueLu_UtilitiesBase_decl.hpp.
|
private |
Definition at line 112 of file MueLu_UtilitiesBase_decl.hpp.
|
private |
Definition at line 113 of file MueLu_UtilitiesBase_decl.hpp.
typedef Teuchos::ScalarTraits<Scalar>::magnitudeType MueLu::UtilitiesBase< Scalar, LocalOrdinal, GlobalOrdinal, Node >::Magnitude |
Definition at line 115 of file MueLu_UtilitiesBase_decl.hpp.
|
inlinestatic |
Definition at line 118 of file MueLu_UtilitiesBase_decl.hpp.
|
inlinestatic |
Extract Matrix Diagonal.
Returns Matrix diagonal in ArrayRCP.
NOTE – it's assumed that A has been fillComplete'd.
Definition at line 130 of file MueLu_UtilitiesBase_decl.hpp.
|
inlinestatic |
Extract Matrix Diagonal.
Returns inverse of the Matrix diagonal in ArrayRCP.
NOTE – it's assumed that A has been fillComplete'd.
Definition at line 158 of file MueLu_UtilitiesBase_decl.hpp.
|
inlinestatic |
Extract Matrix Diagonal of lumped matrix.
Returns Matrix diagonal of lumped matrix in ArrayRCP.
NOTE – it's assumed that A has been fillComplete'd.
Definition at line 180 of file MueLu_UtilitiesBase_decl.hpp.
|
inlinestatic |
Extract Matrix Diagonal of lumped matrix.
Returns Matrix diagonal of lumped matrix in ArrayRCP.
NOTE – it's assumed that A has been fillComplete'd.
Definition at line 202 of file MueLu_UtilitiesBase_decl.hpp.
|
inlinestatic |
Return vector containing inverse of input vector.
[in] | v | input vector |
[in] | tol | tolerance. If entries of input vector are smaller than tolerance they are replaced by tolReplacement (see below). The default value for tol is 100*eps (machine precision) |
[in] | tolReplacement | Value put in for undefined entries in output vector (default: 0.0) : vector containing inverse values of input vector v |
Definition at line 254 of file MueLu_UtilitiesBase_decl.hpp.
|
inlinestatic |
Extract Overlapped Matrix Diagonal.
Returns overlapped Matrix diagonal in ArrayRCP.
The local overlapped diagonal has an entry for each index in A's column map. NOTE – it's assumed that A has been fillComplete'd.
Definition at line 275 of file MueLu_UtilitiesBase_decl.hpp.
|
inlinestatic |
Definition at line 311 of file MueLu_UtilitiesBase_decl.hpp.
|
inlinestatic |
Definition at line 320 of file MueLu_UtilitiesBase_decl.hpp.
|
inlinestatic |
Definition at line 332 of file MueLu_UtilitiesBase_decl.hpp.
|
inlinestatic |
Simple transpose for Tpetra::CrsMatrix types.
Note: This is very inefficient, as it inserts one entry at a time.
Power method.
A | matrix |
scaleByDiag | if true, estimate the largest eigenvalue of \( D^; A \). |
niters | maximum number of iterations |
tolerance | stopping tolerance if true, print iteration information |
(Shamelessly grabbed from tpetra/examples.)
Definition at line 374 of file MueLu_UtilitiesBase_decl.hpp.
|
inlinestatic |
Definition at line 432 of file MueLu_UtilitiesBase_decl.hpp.
|
inlinestatic |
Squared distance between two rows in a multivector.
Used for coordinate vectors.
Definition at line 441 of file MueLu_UtilitiesBase_decl.hpp.
|
inlinestatic |
Detect Dirichlet rows.
[in] | A | matrix |
[in] | tol | If a row entry's magnitude is less than or equal to this tolerance, the entry is treated as zero. |
Definition at line 459 of file MueLu_UtilitiesBase_decl.hpp.
|
inlinestatic |
Frobenius inner product of two matrices.
Used in energy minimization algorithms
Definition at line 482 of file MueLu_UtilitiesBase_decl.hpp.
|
inlinestatic |
Set seed for random number generator.
Distribute the seeds evenly in [1,INT_MAX-1]. This guarantees nothing about where random number streams on difference processes will intersect. This does avoid overflow situations in parallel when multiplying by a PID. It also avoids the pathological case of having the same random number stream on each process.
Definition at line 549 of file MueLu_UtilitiesBase_decl.hpp.