MueLu  Version of the Day
 All Classes Namespaces Files Functions Variables Typedefs Enumerations Enumerator Friends Macros Groups Pages
MueLu::Utilities< double, int, int, Xpetra::EpetraNode > Member List

This is the complete list of members for MueLu::Utilities< double, int, int, Xpetra::EpetraNode >, including all inherited members.

ApplyOAZToMatrixRows(Teuchos::RCP< Xpetra::Matrix< double, int, int, Xpetra::EpetraNode >> &A, const std::vector< int > &dirichletRows)MueLu::UtilitiesBase< double, int, int, Xpetra::EpetraNode >static
ApplyOAZToMatrixRows(Teuchos::RCP< Xpetra::Matrix< double, int, int, Xpetra::EpetraNode >> &A, const Teuchos::ArrayRCP< const bool > &dirichletRows)MueLu::UtilitiesBase< double, int, int, Xpetra::EpetraNode >static
ApplyOAZToMatrixRows(RCP< Matrix > &A, const Kokkos::View< const bool *, typename Xpetra::EpetraNode::device_type > &dirichletRows)MueLu::UtilitiesBase< double, int, int, Xpetra::EpetraNode >static
ApplyRowSumCriterion(const Xpetra::Matrix< double, int, int, Xpetra::EpetraNode > &A, const Magnitude rowSumTol, Teuchos::ArrayRCP< bool > &dirichletRows)MueLu::UtilitiesBase< double, int, int, Xpetra::EpetraNode >static
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)MueLu::UtilitiesBase< double, int, int, Xpetra::EpetraNode >static
ApplyRowSumCriterion(const Matrix &A, const typename Teuchos::ScalarTraits< double >::magnitudeType rowSumTol, Kokkos::View< bool *, typename NO::device_type::memory_space > &dirichletRows)MueLu::UtilitiesBase< double, int, int, Xpetra::EpetraNode >static
ApplyRowSumCriterion(const Matrix &A, const Xpetra::Vector< int, int, int, Xpetra::EpetraNode > &BlockNumber, const typename Teuchos::ScalarTraits< double >::magnitudeType rowSumTol, Kokkos::View< bool *, typename NO::device_type::memory_space > &dirichletRows)MueLu::UtilitiesBase< double, int, int, Xpetra::EpetraNode >static
ApplyRowSumCriterionHost(const Matrix &A, const typename Teuchos::ScalarTraits< double >::magnitudeType rowSumTol, Kokkos::View< bool *, Kokkos::HostSpace > &dirichletRows)MueLu::UtilitiesBase< double, int, int, Xpetra::EpetraNode >static
ApplyRowSumCriterionHost(const Matrix &A, const Xpetra::Vector< int, int, int, Xpetra::EpetraNode > &BlockNumber, const typename Teuchos::ScalarTraits< double >::magnitudeType rowSumTol, Kokkos::View< bool *, Kokkos::HostSpace > &dirichletRows)MueLu::UtilitiesBase< double, int, int, Xpetra::EpetraNode >static
Crs2Op(RCP< CrsMatrix > Op)MueLu::UtilitiesBase< double, int, int, Xpetra::EpetraNode >static
CuthillMcKee(const Matrix &Op)MueLu::UtilitiesBase< double, int, int, Xpetra::EpetraNode >static
DetectDirichletCols(const Xpetra::Matrix< double, int, int, Xpetra::EpetraNode > &A, const Teuchos::ArrayRCP< const bool > &dirichletRows)MueLu::UtilitiesBase< double, int, int, Xpetra::EpetraNode >static
DetectDirichletCols(const Matrix &A, const Kokkos::View< const bool *, typename NO::device_type > &dirichletRows)MueLu::UtilitiesBase< double, int, int, Xpetra::EpetraNode >static
DetectDirichletColsAndDomains(const Xpetra::Matrix< double, int, int, Xpetra::EpetraNode > &A, const Teuchos::ArrayRCP< bool > &dirichletRows, Teuchos::ArrayRCP< bool > dirichletCols, Teuchos::ArrayRCP< bool > dirichletDomain)MueLu::UtilitiesBase< double, int, int, Xpetra::EpetraNode >static
DetectDirichletColsAndDomains(const Xpetra::Matrix< double, int, int, Xpetra::EpetraNode > &A, const Kokkos::View< bool *, typename Xpetra::EpetraNode::device_type > &dirichletRows, Kokkos::View< bool *, typename Xpetra::EpetraNode::device_type > dirichletCols, Kokkos::View< bool *, typename Xpetra::EpetraNode::device_type > dirichletDomain)MueLu::UtilitiesBase< double, int, int, Xpetra::EpetraNode >static
DetectDirichletRows(const Xpetra::Matrix< double, int, int, Xpetra::EpetraNode > &A, const Magnitude &tol=Teuchos::ScalarTraits< Magnitude >::zero(), bool count_twos_as_dirichlet=false)MueLu::UtilitiesBase< double, int, int, Xpetra::EpetraNode >static
DetectDirichletRows_kokkos(const Matrix &A, const Magnitude &tol=Teuchos::ScalarTraits< typename Teuchos::ScalarTraits< SC >::magnitudeType >::zero(), const bool count_twos_as_dirichlet=false)MueLu::UtilitiesBase< double, int, int, Xpetra::EpetraNode >static
DetectDirichletRows_kokkos_host(const Matrix &A, const Magnitude &tol=Teuchos::ScalarTraits< typename Teuchos::ScalarTraits< SC >::magnitudeType >::zero(), const bool count_twos_as_dirichlet=false)MueLu::UtilitiesBase< double, int, int, Xpetra::EpetraNode >static
DetectDirichletRowsExt(const Xpetra::Matrix< double, int, int, Xpetra::EpetraNode > &A, bool &bHasZeroDiagonal, const Magnitude &tol=Teuchos::ScalarTraits< double >::zero())MueLu::UtilitiesBase< double, int, int, Xpetra::EpetraNode >static
Distance2(const Teuchos::Array< Teuchos::ArrayRCP< const double >> &v, inti0, inti1)MueLu::UtilitiesBase< double, int, int, Xpetra::EpetraNode >static
Distance2(const Teuchos::ArrayView< double > &weight, const Teuchos::Array< Teuchos::ArrayRCP< const double >> &v, inti0, inti1)MueLu::UtilitiesBase< double, int, int, Xpetra::EpetraNode >static
EpetraMap typedefMueLu::Utilities< double, int, int, Xpetra::EpetraNode >private
EpetraMultiVector typedefMueLu::Utilities< double, int, int, Xpetra::EpetraNode >private
ExtractCoordinatesFromParameterList(ParameterList &paramList)MueLu::Utilities< double, int, int, Xpetra::EpetraNode >inlinestatic
FindDirichletRows(Teuchos::RCP< Xpetra::Matrix< double, int, int, Xpetra::EpetraNode >> &A, std::vector< int > &dirichletRows, bool count_twos_as_dirichlet=false)MueLu::UtilitiesBase< double, int, int, Xpetra::EpetraNode >static
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)MueLu::UtilitiesBase< double, int, int, Xpetra::EpetraNode >static
FindNonZeros(const Teuchos::ArrayRCP< const double > vals, Teuchos::ArrayRCP< bool > nonzeros)MueLu::UtilitiesBase< double, int, int, Xpetra::EpetraNode >static
FindNonZeros(const typename Xpetra::MultiVector< double, int, int, Xpetra::EpetraNode >::dual_view_type::t_dev_const_um vals, Kokkos::View< bool *, typename Xpetra::EpetraNode::device_type > nonzeros)MueLu::UtilitiesBase< double, int, int, Xpetra::EpetraNode >static
Frobenius(const Xpetra::Matrix< double, int, int, Xpetra::EpetraNode > &A, const Xpetra::Matrix< double, int, int, Xpetra::EpetraNode > &B)MueLu::UtilitiesBase< double, int, int, Xpetra::EpetraNode >static
GeneratedBlockedTargetMap(const Xpetra::BlockedMap< int, int, Xpetra::EpetraNode > &sourceBlockedMap, const Xpetra::Import< int, int, Xpetra::EpetraNode > &Importer)MueLu::UtilitiesBase< double, int, int, Xpetra::EpetraNode >static
GetInverse(Teuchos::RCP< const Vector > v, Magnitude tol=Teuchos::ScalarTraits< double >::eps()*100, doublevalReplacement=Teuchos::ScalarTraits< double >::zero())MueLu::UtilitiesBase< double, int, int, Xpetra::EpetraNode >static
GetLumpedMatrixDiagonal(Matrix const &A, const bool doReciprocal=false, Magnitude tol=Teuchos::ScalarTraits< double >::magnitude(Teuchos::ScalarTraits< double >::zero()), doublevalReplacement=Teuchos::ScalarTraits< double >::zero(), const bool replaceSingleEntryRowWithZero=false, const bool useAverageAbsDiagVal=false)MueLu::UtilitiesBase< double, int, int, Xpetra::EpetraNode >static
GetMatrixDiagonal(const Matrix &A)MueLu::UtilitiesBase< double, int, int, Xpetra::EpetraNode >static
GetMatrixDiagonal_arcp(const Matrix &A)MueLu::UtilitiesBase< double, int, int, Xpetra::EpetraNode >static
GetMatrixDiagonalInverse(const Matrix &A, Magnitude tol=Teuchos::ScalarTraits< double >::eps()*100, doublevalReplacement=Teuchos::ScalarTraits< double >::zero(), const bool doLumped=false)MueLu::UtilitiesBase< double, int, int, Xpetra::EpetraNode >static
GetMatrixMaxMinusOffDiagonal(const Xpetra::Matrix< double, int, int, Xpetra::EpetraNode > &A)MueLu::UtilitiesBase< double, int, int, Xpetra::EpetraNode >static
GetMatrixMaxMinusOffDiagonal(const Xpetra::Matrix< double, int, int, Xpetra::EpetraNode > &A, const Xpetra::Vector< int, int, int, Xpetra::EpetraNode > &BlockNumber)MueLu::UtilitiesBase< double, int, int, Xpetra::EpetraNode >static
GetMatrixOverlappedAbsDeletedRowsum(const Matrix &A)MueLu::UtilitiesBase< double, int, int, Xpetra::EpetraNode >static
GetMatrixOverlappedDeletedRowsum(const Matrix &A)MueLu::UtilitiesBase< double, int, int, Xpetra::EpetraNode >static
GetMatrixOverlappedDiagonal(const Matrix &A)MueLu::UtilitiesBase< double, int, int, Xpetra::EpetraNode >static
GetThresholdedGraph(const RCP< Matrix > &A, const Magnitude threshold, const intexpectedNNZperRow=-1)MueLu::UtilitiesBase< double, int, int, Xpetra::EpetraNode >static
GetThresholdedMatrix(const RCP< Matrix > &Ain, const doublethreshold, const bool keepDiagonal=true, const intexpectedNNZperRow=-1)MueLu::UtilitiesBase< double, int, int, Xpetra::EpetraNode >static
GlobalOrdinal typedefMueLu::Utilities< double, int, int, Xpetra::EpetraNode >
LocalOrdinal typedefMueLu::Utilities< double, int, int, Xpetra::EpetraNode >
Magnitude typedefMueLu::Utilities< double, int, int, Xpetra::EpetraNode >
MakeFancy(std::ostream &os)MueLu::UtilitiesBase< double, int, int, Xpetra::EpetraNode >static
Map2EpetraMap(const Map &map)MueLu::Utilities< double, int, int, Xpetra::EpetraNode >inlinestatic
Map2TpetraMap(const Map &map)MueLu::Utilities< double, int, int, Xpetra::EpetraNode >inlinestatic
MapsAreNested(const Xpetra::Map< int, int, Xpetra::EpetraNode > &rowMap, const Xpetra::Map< int, int, Xpetra::EpetraNode > &colMap)MueLu::UtilitiesBase< double, int, int, Xpetra::EpetraNode >static
MV2EpetraMV(RCP< MultiVector > const vec)MueLu::Utilities< double, int, int, Xpetra::EpetraNode >inlinestatic
MV2EpetraMV(const MultiVector &vec)MueLu::Utilities< double, int, int, Xpetra::EpetraNode >inlinestatic
MV2NonConstEpetraMV(RCP< MultiVector > vec)MueLu::Utilities< double, int, int, Xpetra::EpetraNode >inlinestatic
MV2NonConstEpetraMV(MultiVector &vec)MueLu::Utilities< double, int, int, Xpetra::EpetraNode >inlinestatic
MV2NonConstTpetraMV(RCP< MultiVector > vec)MueLu::Utilities< double, int, int, Xpetra::EpetraNode >inlinestatic
MV2NonConstTpetraMV(MultiVector &vec)MueLu::Utilities< double, int, int, Xpetra::EpetraNode >inlinestatic
MV2NonConstTpetraMV2(MultiVector &vec)MueLu::Utilities< double, int, int, Xpetra::EpetraNode >inlinestatic
MV2TpetraMV(RCP< MultiVector > const vec)MueLu::Utilities< double, int, int, Xpetra::EpetraNode >inlinestatic
MV2TpetraMV(const MultiVector &vec)MueLu::Utilities< double, int, int, Xpetra::EpetraNode >inlinestatic
MyOldScaleMatrix(Matrix &Op, const Teuchos::ArrayRCP< const Scalar > &scalingVector, bool doInverse=true, bool doFillComplete=true, bool doOptimizeStorage=true)MueLu::Utilities< double, int, int, Xpetra::EpetraNode >inlinestatic
MyOldScaleMatrix_Epetra(Matrix &Op, const Teuchos::ArrayRCP< Scalar > &scalingVector, bool, bool)MueLu::Utilities< double, int, int, Xpetra::EpetraNode >inlinestatic
MyOldScaleMatrix_Tpetra(Matrix &Op, const Teuchos::ArrayRCP< Scalar > &scalingVector, bool doFillComplete, bool doOptimizeStorage)MueLu::Utilities< double, int, int, Xpetra::EpetraNode >inlinestatic
Node typedefMueLu::Utilities< double, int, int, Xpetra::EpetraNode >
Op2EpetraCrs(RCP< const Matrix > Op)MueLu::Utilities< double, int, int, Xpetra::EpetraNode >inlinestatic
Op2EpetraCrs(const Matrix &Op)MueLu::Utilities< double, int, int, Xpetra::EpetraNode >inlinestatic
Op2NonConstEpetraCrs(RCP< Matrix > Op)MueLu::Utilities< double, int, int, Xpetra::EpetraNode >inlinestatic
Op2NonConstEpetraCrs(Matrix &Op)MueLu::Utilities< double, int, int, Xpetra::EpetraNode >inlinestatic
Op2NonConstTpetraBlockCrs(RCP< Matrix > Op)MueLu::Utilities< double, int, int, Xpetra::EpetraNode >inlinestatic
Op2NonConstTpetraBlockCrs(Matrix &Op)MueLu::Utilities< double, int, int, Xpetra::EpetraNode >inlinestatic
Op2NonConstTpetraCrs(RCP< Matrix > Op)MueLu::Utilities< double, int, int, Xpetra::EpetraNode >inlinestatic
Op2NonConstTpetraCrs(Matrix &Op)MueLu::Utilities< double, int, int, Xpetra::EpetraNode >inlinestatic
Op2NonConstTpetraRow(RCP< Operator > Op)MueLu::Utilities< double, int, int, Xpetra::EpetraNode >inlinestatic
Op2TpetraBlockCrs(RCP< const Matrix > Op)MueLu::Utilities< double, int, int, Xpetra::EpetraNode >inlinestatic
Op2TpetraBlockCrs(const Matrix &Op)MueLu::Utilities< double, int, int, Xpetra::EpetraNode >inlinestatic
Op2TpetraCrs(RCP< const Matrix > Op)MueLu::Utilities< double, int, int, Xpetra::EpetraNode >inlinestatic
Op2TpetraCrs(const Matrix &Op)MueLu::Utilities< double, int, int, Xpetra::EpetraNode >inlinestatic
Op2TpetraRow(RCP< const Operator > Op)MueLu::Utilities< double, int, int, Xpetra::EpetraNode >inlinestatic
PowerMethod(const Matrix &A, bool scaleByDiag=true, intniters=10, Magnitude tolerance=1e-2, bool verbose=false, unsigned int seed=123)MueLu::UtilitiesBase< double, int, int, Xpetra::EpetraNode >static
PowerMethod(const Matrix &A, const RCP< Vector > &diagInvVec, intniters=10, Magnitude tolerance=1e-2, bool verbose=false, unsigned int seed=123)MueLu::UtilitiesBase< double, int, int, Xpetra::EpetraNode >static
RealValuedToScalarMultiVector(RCP< Xpetra::MultiVector< typename Teuchos::ScalarTraits< Scalar >::coordinateType, LocalOrdinal, GlobalOrdinal, Node >> X)MueLu::Utilities< double, int, int, Xpetra::EpetraNode >inlinestatic
ReplaceNonZerosWithOnes(const RCP< Matrix > &original)MueLu::UtilitiesBase< double, int, int, Xpetra::EpetraNode >static
Residual(const Xpetra::Operator< double, int, int, Xpetra::EpetraNode > &Op, const MultiVector &X, const MultiVector &RHS)MueLu::UtilitiesBase< double, int, int, Xpetra::EpetraNode >static
Residual(const Xpetra::Operator< double, int, int, Xpetra::EpetraNode > &Op, const MultiVector &X, const MultiVector &RHS, MultiVector &Resid)MueLu::UtilitiesBase< double, int, int, Xpetra::EpetraNode >static
ResidualNorm(const Xpetra::Operator< double, int, int, Xpetra::EpetraNode > &Op, const MultiVector &X, const MultiVector &RHS)MueLu::UtilitiesBase< double, int, int, Xpetra::EpetraNode >static
ResidualNorm(const Xpetra::Operator< double, int, int, Xpetra::EpetraNode > &Op, const MultiVector &X, const MultiVector &RHS, MultiVector &Resid)MueLu::UtilitiesBase< double, int, int, Xpetra::EpetraNode >static
ReverseCuthillMcKee(const Matrix &Op)MueLu::UtilitiesBase< double, int, int, Xpetra::EpetraNode >static
Scalar typedefMueLu::Utilities< double, int, int, Xpetra::EpetraNode >
SetRandomSeed(const Teuchos::Comm< int > &comm)MueLu::UtilitiesBase< double, int, int, Xpetra::EpetraNode >static
Transpose(Matrix &Op, bool=false, const std::string &label=std::string(), const Teuchos::RCP< Teuchos::ParameterList > &params=Teuchos::null)MueLu::Utilities< double, int, int, Xpetra::EpetraNode >inlinestatic
ZeroDirichletCols(Teuchos::RCP< Matrix > &A, const Teuchos::ArrayRCP< const bool > &dirichletCols, doublereplaceWith=Teuchos::ScalarTraits< double >::zero())MueLu::UtilitiesBase< double, int, int, Xpetra::EpetraNode >static
ZeroDirichletCols(RCP< Matrix > &A, const Kokkos::View< const bool *, typename NO::device_type > &dirichletCols, SC replaceWith=Teuchos::ScalarTraits< SC >::zero())MueLu::UtilitiesBase< double, int, int, Xpetra::EpetraNode >static
ZeroDirichletRows(Teuchos::RCP< Xpetra::Matrix< double, int, int, Xpetra::EpetraNode >> &A, const std::vector< int > &dirichletRows, doublereplaceWith=Teuchos::ScalarTraits< double >::zero())MueLu::UtilitiesBase< double, int, int, Xpetra::EpetraNode >static
ZeroDirichletRows(Teuchos::RCP< Xpetra::Matrix< double, int, int, Xpetra::EpetraNode >> &A, const Teuchos::ArrayRCP< const bool > &dirichletRows, doublereplaceWith=Teuchos::ScalarTraits< double >::zero())MueLu::UtilitiesBase< double, int, int, Xpetra::EpetraNode >static
ZeroDirichletRows(Teuchos::RCP< Xpetra::MultiVector< double, int, int, Xpetra::EpetraNode >> &X, const Teuchos::ArrayRCP< const bool > &dirichletRows, doublereplaceWith=Teuchos::ScalarTraits< double >::zero())MueLu::UtilitiesBase< double, int, int, Xpetra::EpetraNode >static
ZeroDirichletRows(RCP< Matrix > &A, const Kokkos::View< const bool *, typename NO::device_type > &dirichletRows, SC replaceWith=Teuchos::ScalarTraits< SC >::zero())MueLu::UtilitiesBase< double, int, int, Xpetra::EpetraNode >static
ZeroDirichletRows(RCP< MultiVector > &X, const Kokkos::View< const bool *, typename NO::device_type > &dirichletRows, SC replaceWith=Teuchos::ScalarTraits< SC >::zero())MueLu::UtilitiesBase< double, int, int, Xpetra::EpetraNode >static