MueLu
Version of the Day
|
#include <MueLu_DistanceLaplacianDropping.hpp>
Public Types | |
using | matrix_type = Xpetra::Matrix< Scalar, LocalOrdinal, GlobalOrdinal, Node > |
using | local_matrix_type = typename matrix_type::local_matrix_type |
using | scalar_type = typename local_matrix_type::value_type |
using | local_ordinal_type = typename local_matrix_type::ordinal_type |
using | memory_space = typename local_matrix_type::memory_space |
using | block_indices_view_type = Kokkos::View< local_ordinal_type *, memory_space > |
using | diag_vec_type = Xpetra::MultiVector< Scalar, LocalOrdinal, GlobalOrdinal, Node > |
using | diag_view_type = typename Kokkos::DualView< const scalar_type *, Kokkos::LayoutStride, typename Node::device_type, Kokkos::MemoryUnmanaged >::t_dev |
using | results_view = Kokkos::View< DecisionType *, memory_space > |
using | ATS = Kokkos::ArithTraits< scalar_type > |
using | magnitudeType = typename ATS::magnitudeType |
using | boundary_nodes_view = Kokkos::View< const bool *, memory_space > |
using | mATS = Kokkos::ArithTraits< magnitudeType > |
Public Member Functions | |
VectorDropFunctor (matrix_type &A_, matrix_type &mergedA_, magnitudeType threshold, DistanceFunctorType &dist2_, results_view &results_, block_indices_view_type point_to_block_, block_indices_view_type ghosted_point_to_block_) | |
KOKKOS_FORCEINLINE_FUNCTION void | operator() (local_ordinal_type rlid) const |
Private Attributes | |
local_matrix_type | A |
magnitudeType | eps |
Teuchos::RCP< diag_vec_type > | diagVec |
diag_view_type | diag |
DistanceFunctorType | dist2 |
results_view | results |
block_indices_view_type | point_to_block |
block_indices_view_type | ghosted_point_to_block |
const scalar_type | one = ATS::one() |
Definition at line 616 of file MueLu_DistanceLaplacianDropping.hpp.
using MueLu::DistanceLaplacian::VectorDropFunctor< Scalar, LocalOrdinal, GlobalOrdinal, Node, DistanceFunctorType, measure >::matrix_type = Xpetra::Matrix<Scalar, LocalOrdinal, GlobalOrdinal, Node> |
Definition at line 618 of file MueLu_DistanceLaplacianDropping.hpp.
using MueLu::DistanceLaplacian::VectorDropFunctor< Scalar, LocalOrdinal, GlobalOrdinal, Node, DistanceFunctorType, measure >::local_matrix_type = typename matrix_type::local_matrix_type |
Definition at line 619 of file MueLu_DistanceLaplacianDropping.hpp.
using MueLu::DistanceLaplacian::VectorDropFunctor< Scalar, LocalOrdinal, GlobalOrdinal, Node, DistanceFunctorType, measure >::scalar_type = typename local_matrix_type::value_type |
Definition at line 620 of file MueLu_DistanceLaplacianDropping.hpp.
using MueLu::DistanceLaplacian::VectorDropFunctor< Scalar, LocalOrdinal, GlobalOrdinal, Node, DistanceFunctorType, measure >::local_ordinal_type = typename local_matrix_type::ordinal_type |
Definition at line 621 of file MueLu_DistanceLaplacianDropping.hpp.
using MueLu::DistanceLaplacian::VectorDropFunctor< Scalar, LocalOrdinal, GlobalOrdinal, Node, DistanceFunctorType, measure >::memory_space = typename local_matrix_type::memory_space |
Definition at line 622 of file MueLu_DistanceLaplacianDropping.hpp.
using MueLu::DistanceLaplacian::VectorDropFunctor< Scalar, LocalOrdinal, GlobalOrdinal, Node, DistanceFunctorType, measure >::block_indices_view_type = Kokkos::View<local_ordinal_type*, memory_space> |
Definition at line 623 of file MueLu_DistanceLaplacianDropping.hpp.
using MueLu::DistanceLaplacian::VectorDropFunctor< Scalar, LocalOrdinal, GlobalOrdinal, Node, DistanceFunctorType, measure >::diag_vec_type = Xpetra::MultiVector<Scalar, LocalOrdinal, GlobalOrdinal, Node> |
Definition at line 624 of file MueLu_DistanceLaplacianDropping.hpp.
using MueLu::DistanceLaplacian::VectorDropFunctor< Scalar, LocalOrdinal, GlobalOrdinal, Node, DistanceFunctorType, measure >::diag_view_type = typename Kokkos::DualView<const scalar_type*, Kokkos::LayoutStride, typename Node::device_type, Kokkos::MemoryUnmanaged>::t_dev |
Definition at line 625 of file MueLu_DistanceLaplacianDropping.hpp.
using MueLu::DistanceLaplacian::VectorDropFunctor< Scalar, LocalOrdinal, GlobalOrdinal, Node, DistanceFunctorType, measure >::results_view = Kokkos::View<DecisionType*, memory_space> |
Definition at line 627 of file MueLu_DistanceLaplacianDropping.hpp.
using MueLu::DistanceLaplacian::VectorDropFunctor< Scalar, LocalOrdinal, GlobalOrdinal, Node, DistanceFunctorType, measure >::ATS = Kokkos::ArithTraits<scalar_type> |
Definition at line 629 of file MueLu_DistanceLaplacianDropping.hpp.
using MueLu::DistanceLaplacian::VectorDropFunctor< Scalar, LocalOrdinal, GlobalOrdinal, Node, DistanceFunctorType, measure >::magnitudeType = typename ATS::magnitudeType |
Definition at line 630 of file MueLu_DistanceLaplacianDropping.hpp.
using MueLu::DistanceLaplacian::VectorDropFunctor< Scalar, LocalOrdinal, GlobalOrdinal, Node, DistanceFunctorType, measure >::boundary_nodes_view = Kokkos::View<const bool*, memory_space> |
Definition at line 631 of file MueLu_DistanceLaplacianDropping.hpp.
using MueLu::DistanceLaplacian::VectorDropFunctor< Scalar, LocalOrdinal, GlobalOrdinal, Node, DistanceFunctorType, measure >::mATS = Kokkos::ArithTraits<magnitudeType> |
Definition at line 632 of file MueLu_DistanceLaplacianDropping.hpp.
|
inline |
Definition at line 646 of file MueLu_DistanceLaplacianDropping.hpp.
|
inline |
Definition at line 665 of file MueLu_DistanceLaplacianDropping.hpp.
|
private |
Definition at line 635 of file MueLu_DistanceLaplacianDropping.hpp.
|
private |
Definition at line 636 of file MueLu_DistanceLaplacianDropping.hpp.
|
private |
Definition at line 637 of file MueLu_DistanceLaplacianDropping.hpp.
|
private |
Definition at line 638 of file MueLu_DistanceLaplacianDropping.hpp.
|
private |
Definition at line 639 of file MueLu_DistanceLaplacianDropping.hpp.
|
private |
Definition at line 640 of file MueLu_DistanceLaplacianDropping.hpp.
|
private |
Definition at line 641 of file MueLu_DistanceLaplacianDropping.hpp.
|
private |
Definition at line 642 of file MueLu_DistanceLaplacianDropping.hpp.
|
private |
Definition at line 643 of file MueLu_DistanceLaplacianDropping.hpp.