|
static RCP< const Epetra_MultiVector > | MV2EpetraMV (RCP< MultiVector > const vec) |
| Helper utility to pull out the underlying Epetra objects from an Xpetra object.
|
|
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) |
|
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.
|
|
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::BlockCrsMatrix< Scalar, LocalOrdinal, GlobalOrdinal, Node > > | Op2TpetraBlockCrs (RCP< const Matrix > Op) |
|
static RCP< Tpetra::BlockCrsMatrix< Scalar, LocalOrdinal, GlobalOrdinal, Node > > | Op2NonConstTpetraBlockCrs (RCP< Matrix > Op) |
|
static const Tpetra::BlockCrsMatrix< Scalar, LocalOrdinal, GlobalOrdinal, Node > & | Op2TpetraBlockCrs (const Matrix &Op) |
|
static Tpetra::BlockCrsMatrix< Scalar, LocalOrdinal, GlobalOrdinal, Node > & | Op2NonConstTpetraBlockCrs (Matrix &Op) |
|
static RCP< const Tpetra::RowMatrix< Scalar, LocalOrdinal, GlobalOrdinal, Node > > | Op2TpetraRow (RCP< const Operator > Op) |
|
static RCP< Tpetra::RowMatrix< Scalar, LocalOrdinal, GlobalOrdinal, Node > > | Op2NonConstTpetraRow (RCP< Operator > Op) |
|
static const RCP< const Tpetra::Map< LocalOrdinal, GlobalOrdinal, Node > > | Map2TpetraMap (const Map &map) |
|
static RCP< Matrix > | Crs2Op (RCP< CrsMatrix > Op) |
|
static RCP< CrsMatrixWrap > | GetThresholdedMatrix (const RCP< Xpetra::Matrix< Scalar, LocalOrdinal, GlobalOrdinal, Node > > &A, const Scalar threshold, const bool keepDiagonal, const GlobalOrdinal expectedNNZperRow) |
|
static RCP< CrsGraph > | GetThresholdedGraph (const RCP< Xpetra::Matrix< Scalar, LocalOrdinal, GlobalOrdinal, Node > > &A, const Magnitude threshold, const GlobalOrdinal expectedNNZperRow) |
|
static Teuchos::ArrayRCP< Scalar > | GetMatrixDiagonal (const Matrix &A) |
|
static RCP< Vector > | GetMatrixDiagonalInverse (const Matrix &A, Magnitude tol=Teuchos::ScalarTraits< Scalar >::eps() *100, Scalar valReplacement=Teuchos::ScalarTraits< Scalar >::zero()) |
|
static Teuchos::RCP< Xpetra::Vector< Scalar, LocalOrdinal, GlobalOrdinal, Node > > | GetLumpedMatrixDiagonal (Xpetra::Matrix< Scalar, LocalOrdinal, GlobalOrdinal, Node > const &A, const bool doReciprocal=false, Magnitude tol=Teuchos::ScalarTraits< Scalar >::eps() *100, Scalar tolReplacement=Teuchos::ScalarTraits< Scalar >::zero(), const bool replaceSingleEntryRowWithZero=false, const bool useAverageAbsDiagVal=false) |
|
static RCP< Vector > | GetMatrixOverlappedDiagonal (const Matrix &A) |
|
static Teuchos::ArrayRCP< Magnitude > | GetMatrixMaxMinusOffDiagonal (const Xpetra::Matrix< Scalar, LocalOrdinal, GlobalOrdinal, Node > &A) |
|
static Teuchos::ArrayRCP< Magnitude > | GetMatrixMaxMinusOffDiagonal (const Xpetra::Matrix< Scalar, LocalOrdinal, GlobalOrdinal, Node > &A, const Xpetra::Vector< LocalOrdinal, LocalOrdinal, GlobalOrdinal, Node > &BlockNumber) |
|
static RCP< Vector > | GetInverse (Teuchos::RCP< const Vector > v, Magnitude tol=Teuchos::ScalarTraits< Scalar >::eps() *100, Scalar tolReplacement=Teuchos::ScalarTraits< Scalar >::zero()) |
|
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 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, Xpetra::MultiVector< Scalar, LocalOrdinal, GlobalOrdinal, Node > &Resid) |
|
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 | 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, Xpetra::MultiVector< Scalar, LocalOrdinal, GlobalOrdinal, Node > &Resid) |
|
static RCP< Teuchos::FancyOStream > | MakeFancy (std::ostream &os) |
|
static Teuchos::ScalarTraits< Scalar >::magnitudeType | Distance2 (const Teuchos::Array< Teuchos::ArrayRCP< const Scalar > > &v, LocalOrdinal i0, LocalOrdinal i1) |
|
static Teuchos::ScalarTraits< Scalar >::magnitudeType | Distance2 (const Teuchos::ArrayView< double > &weight, const Teuchos::Array< Teuchos::ArrayRCP< const Scalar > > &v, LocalOrdinal i0, LocalOrdinal i1) |
|
static Teuchos::ArrayRCP< const bool > | DetectDirichletRows (const Matrix &A, const Magnitude &tol=Teuchos::ScalarTraits< Scalar >::zero(), const bool count_twos_as_dirichlet=false) |
|
static Teuchos::ArrayRCP< const bool > | DetectDirichletRowsExt (const Matrix &A, bool &bHasZeroDiagonal, const Magnitude &tol=Teuchos::ScalarTraits< Scalar >::zero()) |
|
static void | FindNonZeros (const Teuchos::ArrayRCP< const Scalar > vals, Teuchos::ArrayRCP< bool > nonzeros) |
|
static void | DetectDirichletColsAndDomains (const Xpetra::Matrix< Scalar, LocalOrdinal, GlobalOrdinal, Node > &A, const Teuchos::ArrayRCP< bool > &dirichletRows, Teuchos::ArrayRCP< bool > dirichletCols, Teuchos::ArrayRCP< bool > dirichletDomains) |
|
static void | ApplyRowSumCriterion (const Xpetra::Matrix< Scalar, LocalOrdinal, GlobalOrdinal, Node > &A, const Magnitude rowSumTol, Teuchos::ArrayRCP< bool > &dirichletRows) |
|
static void | ApplyRowSumCriterion (const Xpetra::Matrix< Scalar, LocalOrdinal, GlobalOrdinal, Node > &A, const Xpetra::Vector< LocalOrdinal, LocalOrdinal, GlobalOrdinal, Node > &BlockNumber, const Magnitude rowSumTol, Teuchos::ArrayRCP< bool > &dirichletRows) |
|
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 | PowerMethod (const Matrix &A, const RCP< Vector > &invDiag, 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, bool) |
|
static RCP< Matrix > | Transpose (Matrix &Op, bool=false, const std::string &label=std::string(), const Teuchos::RCP< Teuchos::ParameterList > ¶ms=Teuchos::null) |
| Transpose a Xpetra::Matrix.
|
|
static RCP< Xpetra::MultiVector< typename Teuchos::ScalarTraits< Scalar >::magnitudeType, LocalOrdinal, GlobalOrdinal, Node > > | RealValuedToScalarMultiVector (RCP< Xpetra::MultiVector< typename Teuchos::ScalarTraits< Scalar >::coordinateType, LocalOrdinal, GlobalOrdinal, Node > > X) |
|
static RCP< Xpetra::MultiVector< typename Teuchos::ScalarTraits< Scalar >::magnitudeType, LocalOrdinal, GlobalOrdinal, Node > > | ExtractCoordinatesFromParameterList (ParameterList ¶mList) |
| Extract coordinates from parameter list and return them in a Xpetra::MultiVector.
|
|
static RCP< Matrix > | Crs2Op (RCP< CrsMatrix > Op) |
|
static RCP< CrsMatrixWrap > | GetThresholdedMatrix (const RCP< Matrix > &Ain, const double threshold, const bool keepDiagonal=true, const int expectedNNZperRow=-1) |
| Threshold a matrix.
|
|
static RCP< Xpetra::CrsGraph< int, int, Xpetra::EpetraNode > > | GetThresholdedGraph (const RCP< Matrix > &A, const Magnitude threshold, const int expectedNNZperRow=-1) |
| Threshold a graph.
|
|
static Teuchos::ArrayRCP< double > | GetMatrixDiagonal (const Matrix &A) |
| Extract Matrix Diagonal.
|
|
static RCP< Vector > | GetMatrixDiagonalInverse (const Matrix &A, Magnitude tol=Teuchos::ScalarTraits< double >::eps() *100, double valReplacement=Teuchos::ScalarTraits< double >::zero()) |
| Extract Matrix Diagonal.
|
|
static Teuchos::RCP< Vector > | GetLumpedMatrixDiagonal (Matrix const &A, const bool doReciprocal=false, Magnitude tol=Teuchos::ScalarTraits< double >::magnitude(Teuchos::ScalarTraits< double >::zero()), double valReplacement=Teuchos::ScalarTraits< double >::zero(), const bool replaceSingleEntryRowWithZero=false, const bool useAverageAbsDiagVal=false) |
| Extract Matrix Diagonal of lumped matrix.
|
|
static Teuchos::ArrayRCP< Magnitude > | GetMatrixMaxMinusOffDiagonal (const Xpetra::Matrix< double, int, int, Xpetra::EpetraNode > &A) |
| Return vector containing: max_{i\not=k}(-a_ik), for each for i in the matrix.
|
|
static Teuchos::ArrayRCP< Magnitude > | GetMatrixMaxMinusOffDiagonal (const Xpetra::Matrix< double, int, int, Xpetra::EpetraNode > &A, const Xpetra::Vector< int, int, int, Xpetra::EpetraNode > &BlockNumber) |
|
static Teuchos::RCP< Vector > | GetInverse (Teuchos::RCP< const Vector > v, Magnitude tol=Teuchos::ScalarTraits< double >::eps() *100, double valReplacement=Teuchos::ScalarTraits< double >::zero()) |
| Return vector containing inverse of input vector.
|
|
static RCP< Vector > | GetMatrixOverlappedDiagonal (const Matrix &A) |
| Extract Overlapped Matrix Diagonal.
|
|
static RCP< Vector > | GetMatrixOverlappedDeletedRowsum (const Matrix &A) |
| Extract Overlapped Matrix Deleted Rowsum.
|
|
static RCP< Xpetra::Vector< Magnitude, int, int, Xpetra::EpetraNode > > | GetMatrixOverlappedAbsDeletedRowsum (const Matrix &A) |
|
static Teuchos::Array< Magnitude > | ResidualNorm (const Xpetra::Operator< double, int, int, Xpetra::EpetraNode > &Op, const MultiVector &X, const MultiVector &RHS) |
|
static Teuchos::Array< Magnitude > | ResidualNorm (const Xpetra::Operator< double, int, int, Xpetra::EpetraNode > &Op, const MultiVector &X, const MultiVector &RHS, MultiVector &Resid) |
|
static RCP< MultiVector > | Residual (const Xpetra::Operator< double, int, int, Xpetra::EpetraNode > &Op, const MultiVector &X, const MultiVector &RHS) |
|
static void | Residual (const Xpetra::Operator< double, int, int, Xpetra::EpetraNode > &Op, const MultiVector &X, const MultiVector &RHS, MultiVector &Resid) |
|
static double | PowerMethod (const Matrix &A, bool scaleByDiag=true, int niters=10, Magnitude tolerance=1e-2, bool verbose=false, unsigned int seed=123) |
| Power method.
|
|
static double | PowerMethod (const Matrix &A, const RCP< Vector > &diagInvVec, int niters=10, Magnitude tolerance=1e-2, bool verbose=false, unsigned int seed=123) |
| Power method.
|
|
static RCP< Teuchos::FancyOStream > | MakeFancy (std::ostream &os) |
|
static Teuchos::ScalarTraits< double >::magnitudeType | Distance2 (const Teuchos::Array< Teuchos::ArrayRCP< const double > > &v, int i0, int i1) |
| Squared distance between two rows in a multivector.
|
|
static Teuchos::ScalarTraits< double >::magnitudeType | Distance2 (const Teuchos::ArrayView< double > &weight, const Teuchos::Array< Teuchos::ArrayRCP< const double > > &v, int i0, int i1) |
| Weighted squared distance between two rows in a multivector.
|
|
static Teuchos::ArrayRCP< const bool > | DetectDirichletRows (const Xpetra::Matrix< double, int, int, Xpetra::EpetraNode > &A, const Magnitude &tol=Teuchos::ScalarTraits< double >::zero(), bool count_twos_as_dirichlet=false) |
| Detect Dirichlet rows.
|
|
static Teuchos::ArrayRCP< const bool > | DetectDirichletRowsExt (const Xpetra::Matrix< double, int, int, Xpetra::EpetraNode > &A, bool &bHasZeroDiagonal, const Magnitude &tol=Teuchos::ScalarTraits< double >::zero()) |
| Detect Dirichlet rows (extended version)
|
|
static void | FindNonZeros (const Teuchos::ArrayRCP< const double > vals, Teuchos::ArrayRCP< bool > nonzeros) |
| Find non-zero values in an ArrayRCP Compares the value to 2 * machine epsilon.
|
|
static void | DetectDirichletColsAndDomains (const Xpetra::Matrix< double, int, int, Xpetra::EpetraNode > &A, const Teuchos::ArrayRCP< bool > &dirichletRows, Teuchos::ArrayRCP< bool > dirichletCols, Teuchos::ArrayRCP< bool > dirichletDomain) |
| Detects Dirichlet columns & domains from a list of Dirichlet rows.
|
|
static void | ApplyRowSumCriterion (const Xpetra::Matrix< double, int, int, Xpetra::EpetraNode > &A, const Magnitude rowSumTol, Teuchos::ArrayRCP< bool > &dirichletRows) |
| Apply Rowsum Criterion.
|
|
static void | ApplyRowSumCriterion (const Xpetra::Matrix< double, int, int, Xpetra::EpetraNode > &A, const Xpetra::Vector< int, int, int, Xpetra::EpetraNode > &BlockNumber, const Magnitude rowSumTol, Teuchos::ArrayRCP< bool > &dirichletRows) |
|
static Teuchos::ArrayRCP< const bool > | DetectDirichletCols (const Xpetra::Matrix< double, int, int, Xpetra::EpetraNode > &A, const Teuchos::ArrayRCP< const bool > &dirichletRows) |
| Detect Dirichlet columns based on Dirichlet rows.
|
|
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.
|
|
static void | SetRandomSeed (const Teuchos::Comm< int > &comm) |
| Set seed for random number generator.
|
|
static void | FindDirichletRows (Teuchos::RCP< Xpetra::Matrix< double, int, int, Xpetra::EpetraNode > > &A, std::vector< int > &dirichletRows, bool count_twos_as_dirichlet=false) |
|
static void | ApplyOAZToMatrixRows (Teuchos::RCP< Xpetra::Matrix< double, int, int, Xpetra::EpetraNode > > &A, const std::vector< int > &dirichletRows) |
|
static void | ApplyOAZToMatrixRows (Teuchos::RCP< Xpetra::Matrix< double, int, int, Xpetra::EpetraNode > > &A, const Teuchos::ArrayRCP< const bool > &dirichletRows) |
|
static void | ZeroDirichletRows (Teuchos::RCP< Xpetra::Matrix< double, int, int, Xpetra::EpetraNode > > &A, const std::vector< int > &dirichletRows, double replaceWith=Teuchos::ScalarTraits< double >::zero()) |
|
static void | ZeroDirichletRows (Teuchos::RCP< Xpetra::Matrix< double, int, int, Xpetra::EpetraNode > > &A, const Teuchos::ArrayRCP< const bool > &dirichletRows, double replaceWith=Teuchos::ScalarTraits< double >::zero()) |
|
static void | ZeroDirichletRows (Teuchos::RCP< Xpetra::MultiVector< double, int, int, Xpetra::EpetraNode > > &X, const Teuchos::ArrayRCP< const bool > &dirichletRows, double replaceWith=Teuchos::ScalarTraits< double >::zero()) |
|
static void | ZeroDirichletCols (Teuchos::RCP< Matrix > &A, const Teuchos::ArrayRCP< const bool > &dirichletCols, double replaceWith=Teuchos::ScalarTraits< double >::zero()) |
|
static void | FindDirichletRowsAndPropagateToCols (Teuchos::RCP< Xpetra::Matrix< double, int, int, Xpetra::EpetraNode > > &A, Teuchos::RCP< Xpetra::Vector< int, int, int, Xpetra::EpetraNode > > &isDirichletRow, Teuchos::RCP< Xpetra::Vector< int, int, int, Xpetra::EpetraNode > > &isDirichletCol) |
|
static RCP< const Xpetra::BlockedMap< int, int, Xpetra::EpetraNode > > | GeneratedBlockedTargetMap (const Xpetra::BlockedMap< int, int, Xpetra::EpetraNode > &sourceBlockedMap, const Xpetra::Import< int, int, Xpetra::EpetraNode > &Importer) |
|
static bool | MapsAreNested (const Xpetra::Map< int, int, Xpetra::EpetraNode > &rowMap, const Xpetra::Map< int, int, Xpetra::EpetraNode > &colMap) |
|