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;
89 using memory_space =
typename local_graph_type::device_type::memory_space;
91 using LOVectorView = decltype(std::declval<LOVector>().getDeviceLocalView(Xpetra::Access::ReadWrite));
113 const LWGraph_kokkos& graph,
114 Aggregates_kokkos& aggregates,
116 LO& numNonAggregatedNodes)
const;
121 RCP<IndexManager_kokkos>& geoData,
122 const LO dofsPerNode,
123 RCP<CrsGraph>& myGraph)
const;
126 std::string
description()
const {
return "Aggretation: structured algorithm"; }
142 KOKKOS_INLINE_FUNCTION
143 void operator() (
const LO nodeIdx, LO& lNumAggregatedNodes)
const;
160 const LO numGhostedNodes,
const LO dofsPerNode,
165 KOKKOS_INLINE_FUNCTION
181 const LO dofsPerNode,
182 const int numInterpolationPoints,
const LO numLocalRows,
186 KOKKOS_INLINE_FUNCTION
187 void operator() (
const LO rowIdx, GO& update,
const bool final)
const;
206 const int numDimensions,
207 const LO numGhostedNodes,
const LO dofsPerNode,
208 const int numInterpolationPoints,
214 KOKKOS_INLINE_FUNCTION
223 #define MUELU_AGGREGATIONSTRUCTUREDALGORITHM_KOKKOS_SHORT fillAggregatesFunctor(RCP< IndexManager_kokkos > geoData, const int myRank, Kokkos::View< unsigned *, device_type > aggStat, LOVectorView vertex2AggID, LOVectorView procWinner)
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::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
MueLu::DefaultLocalOrdinal LocalOrdinal
IndexManager_kokkos geoData_
KokkosClassic::DefaultNode::DefaultNodeType DefaultNode
typename LWGraph_kokkos::local_graph_type local_graph_type
decltype(std::declval< LOVector >().getDeviceLocalView(Xpetra::Access::ReadWrite)) LOVectorView
constIntTupleView coarseRate_
virtual ~AggregationStructuredAlgorithm_kokkos()
Destructor.
constLOTupleView lFineNodesPerDir_
constLOTupleView lFineNodesPerDir_
IndexManager_kokkos geoData_
constLOTupleView ghostedNodesPerDir_
constIntTupleView endRate_
Namespace for MueLu classes and methods.
KOKKOS_INLINE_FUNCTION void operator()(const LO nodeIdx) const
Kokkos::View< unsigned *, device_type > 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
const int numInterpolationPoints_
constIntTupleView coarseRate_
const int numGhostedNodes_
typename Kokkos::View< const LO[3], device_type > constLOTupleView
non_const_row_map_type rowPtr_
KOKKOS_INLINE_FUNCTION void operator()(const LO nodeIdx, LO &lNumAggregatedNodes) 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)
typename local_graph_type::device_type device_type
const int numInterpolationPoints_
typename local_graph_type::size_type size_type
constIntTupleView endRate_
IndexManager_kokkos geoData_
void BuildAggregates(const Teuchos::ParameterList ¶ms, const LWGraph_kokkos &graph, Aggregates_kokkos &aggregates, Kokkos::View< unsigned *, device_type > &aggStat, LO &numNonAggregatedNodes) const
Build aggregates object.
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)
KOKKOS_INLINE_FUNCTION void operator()(const LO nodeIdx) const
typename Kokkos::View< const int[3], device_type > constIntTupleView
constIntTupleView coarseRate_
std::string description() const
AggregationStructuredAlgorithm_kokkos()
Constructor.
KOKKOS_INLINE_FUNCTION void operator()(const LO rowIdx, GO &update, const bool final) const
typename local_graph_type::entries_type entries_type