46 #ifndef MUELU_AGGREGATIONSTRUCTUREDALGORITHM_KOKKOS_DECL_HPP
47 #define MUELU_AGGREGATIONSTRUCTUREDALGORITHM_KOKKOS_DECL_HPP
56 #include "MueLu_LWGraph_kokkos.hpp"
77 public MueLu::AggregationAlgorithmBase_kokkos<LocalOrdinal,GlobalOrdinal,Node> {
78 #undef MUELU_AGGREGATIONSTRUCTUREDALGORITHM_KOKKOS_SHORT
85 using size_type =
typename local_graph_type::size_type;
88 using memory_space =
typename local_graph_type::device_type::memory_space;
90 using LOVectorView = decltype(std::declval<LOVector>().
template getLocalView<memory_space>());
112 const LWGraph_kokkos& graph,
113 Aggregates_kokkos& aggregates,
115 LO& numNonAggregatedNodes)
const;
121 const LO dofsPerNode,
125 std::string
description()
const {
return "Aggretation: structured algorithm"; }
141 KOKKOS_INLINE_FUNCTION
142 void operator() (
const LO nodeIdx, LO& lNumAggregatedNodes)
const;
159 const LO numGhostedNodes,
const LO dofsPerNode,
164 KOKKOS_INLINE_FUNCTION
180 const LO dofsPerNode,
181 const int numInterpolationPoints,
const LO numLocalRows,
185 KOKKOS_INLINE_FUNCTION
186 void operator() (
const LO rowIdx, GO& update,
const bool final)
const;
205 const int numDimensions,
206 const LO numGhostedNodes,
const LO dofsPerNode,
207 const int numInterpolationPoints,
213 KOKKOS_INLINE_FUNCTION
222 #define MUELU_AGGREGATIONSTRUCTUREDALGORITHM_KOKKOS_SHORT
typename local_graph_type::device_type::execution_space execution_space
non_const_row_map_type rowPtr_
const int numGhostedNodes_
IndexManager_kokkos geoData_
typename local_graph_type::row_map_type::non_const_type non_const_row_map_type
KOKKOS_INLINE_FUNCTION void operator()(const LO nodeIdx) const
MueLu::DefaultLocalOrdinal LocalOrdinal
IndexManager_kokkos geoData_
KokkosClassic::DefaultNode::DefaultNodeType DefaultNode
typename Kokkos::View< const int[3], memory_space > constIntTupleView
typename LWGraph_kokkos::local_graph_type local_graph_type
constIntTupleView coarseRate_
virtual ~AggregationStructuredAlgorithm_kokkos()
Destructor.
constLOTupleView lFineNodesPerDir_
constLOTupleView lFineNodesPerDir_
KOKKOS_INLINE_FUNCTION void operator()(const LO nodeIdx) const
IndexManager_kokkos geoData_
constLOTupleView ghostedNodesPerDir_
constIntTupleView endRate_
decltype(std::declval< LOVector >().template getLocalView< memory_space >()) LOVectorView
Kokkos::View< unsigned *, memory_space > aggStat_
computeGraphRowPtrFunctor(RCP< IndexManager_kokkos > geoData, const LO dofsPerNode, const int numInterpolationPoints, const LO numLocalRows, constIntTupleView coarseRate, constLOTupleView lFineNodesPerDir, non_const_row_map_type rowPtr)
non_const_row_map_type rowPtr_
LOVectorView vertex2AggID_
MueLu::DefaultGlobalOrdinal GlobalOrdinal
void BuildAggregates(const Teuchos::ParameterList ¶ms, const LWGraph_kokkos &graph, Aggregates_kokkos &aggregates, Kokkos::View< unsigned *, memory_space > &aggStat, LO &numNonAggregatedNodes) const
Build aggregates object.
const int numInterpolationPoints_
constIntTupleView coarseRate_
typename Kokkos::View< const LO[3], memory_space > constLOTupleView
const int numGhostedNodes_
non_const_row_map_type rowPtr_
KOKKOS_INLINE_FUNCTION void operator()(const LO rowIdx, GO &update, const bool final) const
computeGraphDataLinearFunctor(RCP< IndexManager_kokkos > geoData, const int numDimensions, const LO numGhostedNodes, const LO dofsPerNode, const int numInterpolationPoints, constIntTupleView coarseRate, constIntTupleView endRate, constLOTupleView lFineNodesPerDir, constLOTupleView ghostedNodesPerDir, non_const_row_map_type rowPtr, entries_type colIndex)
fillAggregatesFunctor(RCP< IndexManager_kokkos > geoData, const int myRank, Kokkos::View< unsigned *, memory_space > aggStat, LOVectorView vertex2AggID, LOVectorView procWinner)
const int numInterpolationPoints_
typename local_graph_type::size_type size_type
constIntTupleView endRate_
IndexManager_kokkos geoData_
std::string description() const
KOKKOS_INLINE_FUNCTION void operator()(const LO nodeIdx, LO &lNumAggregatedNodes) const
typename local_graph_type::device_type::memory_space memory_space
constLOTupleView lFineNodesPerDir_
computeGraphDataConstantFunctor(RCP< IndexManager_kokkos > geoData, const LO numGhostedNodes, const LO dofsPerNode, constIntTupleView coarseRate, constIntTupleView endRate, constLOTupleView lFineNodesPerDir, non_const_row_map_type rowPtr, entries_type colIndex)
constIntTupleView coarseRate_
AggregationStructuredAlgorithm_kokkos()
Constructor.
void BuildGraph(const LWGraph_kokkos &graph, RCP< IndexManager_kokkos > &geoData, const LO dofsPerNode, RCP< CrsGraph > &myGraph) const
Build a CrsGraph instead of aggregates.
typename local_graph_type::entries_type entries_type