MueLu
Version of the Day
|
#include <algorithm>
#include <Teuchos_DefaultComm.hpp>
#include <Teuchos_ParameterList.hpp>
#include "MueLu_ConfigDefs.hpp"
#include "Epetra_MpiComm.h"
#include <Kokkos_Core.hpp>
#include <KokkosSparse_CrsMatrix.hpp>
#include <KokkosSparse_getDiagCopy.hpp>
#include <EpetraExt_MatrixMatrix.h>
#include <EpetraExt_RowMatrixOut.h>
#include <EpetraExt_MultiVectorOut.h>
#include <EpetraExt_CrsMatrixIn.h>
#include <EpetraExt_MultiVectorIn.h>
#include <EpetraExt_BlockMapIn.h>
#include <Xpetra_EpetraUtils.hpp>
#include <Xpetra_EpetraMultiVector.hpp>
#include <EpetraExt_BlockMapOut.h>
#include <MatrixMarket_Tpetra.hpp>
#include <Tpetra_RowMatrixTransposer.hpp>
#include <TpetraExt_MatrixMatrix.hpp>
#include <Xpetra_TpetraMultiVector.hpp>
#include <Xpetra_TpetraCrsMatrix.hpp>
#include <Xpetra_TpetraBlockCrsMatrix.hpp>
#include <Xpetra_EpetraMap.hpp>
#include <Xpetra_BlockedCrsMatrix.hpp>
#include <Xpetra_DefaultPlatform.hpp>
#include <Xpetra_Import.hpp>
#include <Xpetra_ImportFactory.hpp>
#include <Xpetra_Map.hpp>
#include <Xpetra_MapFactory.hpp>
#include <Xpetra_Matrix.hpp>
#include <Xpetra_MatrixMatrix.hpp>
#include <Xpetra_MatrixFactory.hpp>
#include <Xpetra_MultiVector.hpp>
#include <Xpetra_MultiVectorFactory.hpp>
#include <Xpetra_Operator.hpp>
#include <Xpetra_Vector.hpp>
#include <Xpetra_VectorFactory.hpp>
#include <MueLu_Utilities_kokkos_decl.hpp>
#include <KokkosKernels_Handle.hpp>
#include <KokkosSparse_partitioning_impl.hpp>
Go to the source code of this file.
Namespaces | |
MueLu | |
Namespace for MueLu classes and methods. | |
Macros | |
#define | MUELU_UTILITIES_KOKKOS_SHORT |
Functions | |
template<class SC , class LO , class GO , class NO > | |
Kokkos::View< bool *, typename NO::device_type > | MueLu::DetectDirichletRows (const Xpetra::Matrix< SC, LO, GO, NO > &A, const typename Teuchos::ScalarTraits< SC >::magnitudeType &tol, const bool count_twos_as_dirichlet) |
template<class SC , class LO , class GO , class NO > | |
Kokkos::View< bool *, typename NO::device_type > | MueLu::DetectDirichletCols (const Xpetra::Matrix< SC, LO, GO, NO > &A, const Kokkos::View< const bool *, typename NO::device_type > &dirichletRows) |
template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node > | |
void | MueLu::ZeroDirichletRows (RCP< Xpetra::Matrix< Scalar, LocalOrdinal, GlobalOrdinal, Node > > &A, const Kokkos::View< const bool *, typename Node::device_type > &dirichletRows, Scalar replaceWith) |
template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node > | |
void | MueLu::ZeroDirichletRows (RCP< Xpetra::MultiVector< Scalar, LocalOrdinal, GlobalOrdinal, Node > > &X, const Kokkos::View< const bool *, typename Node::device_type > &dirichletRows, Scalar replaceWith) |
template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node > | |
void | MueLu::ZeroDirichletCols (RCP< Xpetra::Matrix< Scalar, LocalOrdinal, GlobalOrdinal, Node > > &A, const Kokkos::View< const bool *, typename Node::device_type > &dirichletCols, Scalar replaceWith) |
template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node > | |
Teuchos::RCP< Xpetra::Vector < LocalOrdinal, LocalOrdinal, GlobalOrdinal, Node > > | MueLu::ReverseCuthillMcKee (const Xpetra::Matrix< Scalar, LocalOrdinal, GlobalOrdinal, Node > &Op) |
template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node > | |
Teuchos::RCP< Xpetra::Vector < LocalOrdinal, LocalOrdinal, GlobalOrdinal, Node > > | MueLu::CuthillMcKee (const Xpetra::Matrix< Scalar, LocalOrdinal, GlobalOrdinal, Node > &Op) |
template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node > | |
void | MueLu::ApplyOAZToMatrixRows (Teuchos::RCP< Xpetra::Matrix< Scalar, LocalOrdinal, GlobalOrdinal, Node > > &A, const Kokkos::View< const bool *, typename Node::device_type > &dirichletRows) |
#define MUELU_UTILITIES_KOKKOS_SHORT |
Definition at line 792 of file MueLu_Utilities_kokkos_def.hpp.