MueLu  Version of the Day
 All Classes Namespaces Files Functions Variables Typedefs Enumerations Enumerator Friends Macros Groups Pages
MueLu::VectorDroppingBase< Scalar, LocalOrdinal, GlobalOrdinal, Node > Class Template Reference

#include <MueLu_VectorDroppingBase.hpp>

Inheritance diagram for MueLu::VectorDroppingBase< Scalar, LocalOrdinal, GlobalOrdinal, Node >:
MueLu::VectorDroppingClassical< Scalar, LocalOrdinal, GlobalOrdinal, Node, SoC > MueLu::VectorDroppingDistanceLaplacian< Scalar, LocalOrdinal, GlobalOrdinal, Node, SoC >

Public Types

using matrix_type = Xpetra::Matrix< Scalar, LocalOrdinal, GlobalOrdinal, Node >
 
using crs_matrix_type = Xpetra::CrsMatrix< Scalar, LocalOrdinal, GlobalOrdinal, Node >
 
using GraphType = Xpetra::CrsGraph< LocalOrdinal, GlobalOrdinal, Node >
 
using local_matrix_type = typename crs_matrix_type::local_matrix_type
 
using local_graph_type = typename GraphType::local_graph_type
 
using rowptr_type = typename local_graph_type::row_map_type::non_const_type
 
using device_type = typename Node::device_type
 
using memory_space = typename device_type::memory_space
 
using execution_space = typename local_matrix_type::execution_space
 
using results_view = Kokkos::View< DecisionType *, memory_space >
 
using Level = MueLu::Level
 
using range_type = Kokkos::RangePolicy< LocalOrdinal, execution_space >
 
using LocalOrdinalVector = Xpetra::Vector< LocalOrdinal, LocalOrdinal, GlobalOrdinal, Node >
 
using nnz_count_type = Kokkos::pair< LocalOrdinal, LocalOrdinal >
 
using block_indices_view_type = typename Kokkos::View< LocalOrdinal *, typename Node::device_type >
 

Static Public Member Functions

template<class... Functors>
static void runDroppingFunctorsImpl (local_matrix_type &lclA, typename matrix_type::local_ordinal_type &blkPartSize, block_indices_view_type &colTranslation, results_view &results, rowptr_type &filtered_rowptr, rowptr_type &graph_rowptr, nnz_count_type &nnz, Functors &...functors)
 
template<class... Functors>
static void runDroppingFunctors (matrix_type &A, matrix_type &mergedA, typename matrix_type::local_ordinal_type &blkPartSize, block_indices_view_type &rowTranslation, block_indices_view_type &colTranslation, results_view &results, rowptr_type &filtered_rowptr, rowptr_type &graph_rowptr, nnz_count_type &nnz, const bool useBlocking, Level &level, const Factory &factory, Functors &...functors)
 

Detailed Description

template<class Scalar, class LocalOrdinal, class GlobalOrdinal, class Node>
class MueLu::VectorDroppingBase< Scalar, LocalOrdinal, GlobalOrdinal, Node >

Definition at line 22 of file MueLu_VectorDroppingBase.hpp.

Member Typedef Documentation

template<class Scalar, class LocalOrdinal, class GlobalOrdinal, class Node>
using MueLu::VectorDroppingBase< Scalar, LocalOrdinal, GlobalOrdinal, Node >::matrix_type = Xpetra::Matrix<Scalar, LocalOrdinal, GlobalOrdinal, Node>

Definition at line 24 of file MueLu_VectorDroppingBase.hpp.

template<class Scalar, class LocalOrdinal, class GlobalOrdinal, class Node>
using MueLu::VectorDroppingBase< Scalar, LocalOrdinal, GlobalOrdinal, Node >::crs_matrix_type = Xpetra::CrsMatrix<Scalar, LocalOrdinal, GlobalOrdinal, Node>

Definition at line 25 of file MueLu_VectorDroppingBase.hpp.

template<class Scalar, class LocalOrdinal, class GlobalOrdinal, class Node>
using MueLu::VectorDroppingBase< Scalar, LocalOrdinal, GlobalOrdinal, Node >::GraphType = Xpetra::CrsGraph<LocalOrdinal, GlobalOrdinal, Node>

Definition at line 26 of file MueLu_VectorDroppingBase.hpp.

template<class Scalar, class LocalOrdinal, class GlobalOrdinal, class Node>
using MueLu::VectorDroppingBase< Scalar, LocalOrdinal, GlobalOrdinal, Node >::local_matrix_type = typename crs_matrix_type::local_matrix_type

Definition at line 27 of file MueLu_VectorDroppingBase.hpp.

template<class Scalar, class LocalOrdinal, class GlobalOrdinal, class Node>
using MueLu::VectorDroppingBase< Scalar, LocalOrdinal, GlobalOrdinal, Node >::local_graph_type = typename GraphType::local_graph_type

Definition at line 28 of file MueLu_VectorDroppingBase.hpp.

template<class Scalar, class LocalOrdinal, class GlobalOrdinal, class Node>
using MueLu::VectorDroppingBase< Scalar, LocalOrdinal, GlobalOrdinal, Node >::rowptr_type = typename local_graph_type::row_map_type::non_const_type

Definition at line 29 of file MueLu_VectorDroppingBase.hpp.

template<class Scalar, class LocalOrdinal, class GlobalOrdinal, class Node>
using MueLu::VectorDroppingBase< Scalar, LocalOrdinal, GlobalOrdinal, Node >::device_type = typename Node::device_type

Definition at line 30 of file MueLu_VectorDroppingBase.hpp.

template<class Scalar, class LocalOrdinal, class GlobalOrdinal, class Node>
using MueLu::VectorDroppingBase< Scalar, LocalOrdinal, GlobalOrdinal, Node >::memory_space = typename device_type::memory_space

Definition at line 31 of file MueLu_VectorDroppingBase.hpp.

template<class Scalar, class LocalOrdinal, class GlobalOrdinal, class Node>
using MueLu::VectorDroppingBase< Scalar, LocalOrdinal, GlobalOrdinal, Node >::execution_space = typename local_matrix_type::execution_space

Definition at line 32 of file MueLu_VectorDroppingBase.hpp.

template<class Scalar, class LocalOrdinal, class GlobalOrdinal, class Node>
using MueLu::VectorDroppingBase< Scalar, LocalOrdinal, GlobalOrdinal, Node >::results_view = Kokkos::View<DecisionType*, memory_space>

Definition at line 33 of file MueLu_VectorDroppingBase.hpp.

template<class Scalar, class LocalOrdinal, class GlobalOrdinal, class Node>
using MueLu::VectorDroppingBase< Scalar, LocalOrdinal, GlobalOrdinal, Node >::Level = MueLu::Level

Definition at line 34 of file MueLu_VectorDroppingBase.hpp.

template<class Scalar, class LocalOrdinal, class GlobalOrdinal, class Node>
using MueLu::VectorDroppingBase< Scalar, LocalOrdinal, GlobalOrdinal, Node >::range_type = Kokkos::RangePolicy<LocalOrdinal, execution_space>

Definition at line 35 of file MueLu_VectorDroppingBase.hpp.

template<class Scalar, class LocalOrdinal, class GlobalOrdinal, class Node>
using MueLu::VectorDroppingBase< Scalar, LocalOrdinal, GlobalOrdinal, Node >::LocalOrdinalVector = Xpetra::Vector<LocalOrdinal, LocalOrdinal, GlobalOrdinal, Node>

Definition at line 36 of file MueLu_VectorDroppingBase.hpp.

template<class Scalar, class LocalOrdinal, class GlobalOrdinal, class Node>
using MueLu::VectorDroppingBase< Scalar, LocalOrdinal, GlobalOrdinal, Node >::nnz_count_type = Kokkos::pair<LocalOrdinal, LocalOrdinal>

Definition at line 37 of file MueLu_VectorDroppingBase.hpp.

template<class Scalar, class LocalOrdinal, class GlobalOrdinal, class Node>
using MueLu::VectorDroppingBase< Scalar, LocalOrdinal, GlobalOrdinal, Node >::block_indices_view_type = typename Kokkos::View<LocalOrdinal*, typename Node::device_type>

Definition at line 38 of file MueLu_VectorDroppingBase.hpp.

Member Function Documentation

template<class Scalar, class LocalOrdinal, class GlobalOrdinal, class Node>
template<class... Functors>
static void MueLu::VectorDroppingBase< Scalar, LocalOrdinal, GlobalOrdinal, Node >::runDroppingFunctorsImpl ( local_matrix_type lclA,
typename matrix_type::local_ordinal_type &  blkPartSize,
block_indices_view_type colTranslation,
results_view results,
rowptr_type filtered_rowptr,
rowptr_type graph_rowptr,
nnz_count_type nnz,
Functors &...  functors 
)
inlinestatic

Definition at line 41 of file MueLu_VectorDroppingBase.hpp.

template<class Scalar, class LocalOrdinal, class GlobalOrdinal, class Node>
template<class... Functors>
static void MueLu::VectorDroppingBase< Scalar, LocalOrdinal, GlobalOrdinal, Node >::runDroppingFunctors ( matrix_type A,
matrix_type mergedA,
typename matrix_type::local_ordinal_type &  blkPartSize,
block_indices_view_type rowTranslation,
block_indices_view_type colTranslation,
results_view results,
rowptr_type filtered_rowptr,
rowptr_type graph_rowptr,
nnz_count_type nnz,
const bool  useBlocking,
Level level,
const Factory factory,
Functors &...  functors 
)
inlinestatic

Definition at line 55 of file MueLu_VectorDroppingBase.hpp.


The documentation for this class was generated from the following file: