10 #ifndef _ZOLTAN2_PDISTANCE2_HPP_
11 #define _ZOLTAN2_PDISTANCE2_HPP_
14 #include <unordered_map>
31 #include "Tpetra_Core.hpp"
32 #include "Teuchos_RCP.hpp"
33 #include "Tpetra_Import.hpp"
34 #include "Tpetra_FEMultiVector.hpp"
36 #include "Kokkos_Core.hpp"
37 #include "KokkosSparse_CrsMatrix.hpp"
38 #include "KokkosKernels_Handle.hpp"
39 #include "KokkosKernels_IOUtils.hpp"
40 #include "KokkosGraph_Distance2Color.hpp"
41 #include "KokkosGraph_Distance2ColorHandle.hpp"
50 template <
typename Adapter>
60 using map_t = Tpetra::Map<lno_t,gno_t>;
62 using femv_t = Tpetra::FEMultiVector<femv_scalar_t, lno_t, gno_t>;
66 using host_exec =
typename femv_t::host_view_type::device_type::execution_space;
67 using host_mem =
typename femv_t::host_view_type::device_type::memory_space;
71 template<
class ExecutionSpace,
typename MemorySpace>
72 void localColoring(
const size_t nVtx,
73 Kokkos::View<
lno_t*, Kokkos::Device<ExecutionSpace, MemorySpace>> adjs_view,
74 Kokkos::View<
offset_t*, Kokkos::Device<ExecutionSpace, MemorySpace>> offset_view,
75 Teuchos::RCP<femv_t> femv,
76 Kokkos::View<
lno_t*, Kokkos::Device<ExecutionSpace, MemorySpace>> vertex_list,
77 size_t vertex_list_size = 0,
78 bool use_vertex_based_coloring =
false){
79 using KernelHandle = KokkosKernels::Experimental::KokkosKernelsHandle
86 kh.create_distance2_graph_coloring_handle(KokkosGraph::COLORING_D2_NB_BIT);
90 if(vertex_list_size != 0){
91 kh.get_distance2_graph_coloring_handle()->set_vertex_list(vertex_list, vertex_list_size);
95 kh.get_distance2_graph_coloring_handle()->set_verbose(this->
verbose);
98 auto femvColors = femv->template getLocalView<Kokkos::Device<ExecutionSpace,MemorySpace> >(Tpetra::Access::ReadWrite);
99 auto sv = subview(femvColors,Kokkos::ALL, 0);
100 kh.get_distance2_graph_coloring_handle()->set_vertex_colors(sv);
103 KokkosGraph::Experimental::bipartite_color_rows(&kh, nVtx, nVtx, offset_view, adjs_view,
true);
108 std::cout<<
"\nKokkosKernels Coloring: "
109 <<kh.get_distance2_graph_coloring_handle()->get_overall_coloring_time()
115 virtual void colorInterior(
const size_t nVtx,
116 Kokkos::View<lno_t*, device_type> adjs_view,
117 Kokkos::View<offset_t*, device_type> offset_view,
118 Teuchos::RCP<femv_t> femv,
119 Kokkos::View<lno_t*, device_type> vertex_list,
120 size_t vertex_list_size=0,
122 this->localColoring<execution_space, memory_space>(nVtx,
131 virtual void colorInterior_serial(
const size_t nVtx,
132 typename Kokkos::View<lno_t*, device_type >::HostMirror adjs_view,
133 typename Kokkos::View<offset_t*,device_type >::HostMirror offset_view,
134 Teuchos::RCP<femv_t> femv,
135 typename Kokkos::View<lno_t*, device_type>::HostMirror vertex_list,
136 size_t vertex_list_size = 0,
137 bool recolor=
false) {
138 this->localColoring<host_exec, host_mem>(nVtx,
149 template <
class ExecutionSpace,
typename MemorySpace>
151 Kokkos::View<
offset_t*, Kokkos::Device<ExecutionSpace, MemorySpace>> dist_offsets,
152 Kokkos::View<
lno_t*, Kokkos::Device<ExecutionSpace, MemorySpace>> dist_adjs,
153 Kokkos::View<
int*, Kokkos::Device<ExecutionSpace, MemorySpace>> femv_colors,
154 Kokkos::View<
lno_t*, Kokkos::Device<ExecutionSpace, MemorySpace>> boundary_verts_view,
156 Kokkos::Device<ExecutionSpace, MemorySpace> > verts_to_recolor_view,
158 Kokkos::Device<ExecutionSpace, MemorySpace>,
159 Kokkos::MemoryTraits<Kokkos::Atomic> > verts_to_recolor_size_atomic,
161 Kokkos::Device<ExecutionSpace, MemorySpace> > verts_to_send_view,
162 Kokkos::View<
size_t*,
163 Kokkos::Device<ExecutionSpace, MemorySpace>,
164 Kokkos::MemoryTraits<Kokkos::Atomic> > verts_to_send_size_atomic,
165 Kokkos::View<
size_t*, Kokkos::Device<ExecutionSpace, MemorySpace>> recoloringSize,
166 Kokkos::View<
int*, Kokkos::Device<ExecutionSpace, MemorySpace>> rand,
167 Kokkos::View<
gno_t*, Kokkos::Device<ExecutionSpace, MemorySpace>> gid,
168 Kokkos::View<
gno_t*, Kokkos::Device<ExecutionSpace, MemorySpace>> ghost_degrees,
169 bool recolor_degrees){
171 Kokkos::RangePolicy<ExecutionSpace> policy(0,boundary_verts_view.extent(0));
172 size_t local_recoloring_size;
173 Kokkos::parallel_reduce(
"PD2 conflict detection",policy, KOKKOS_LAMBDA(
const uint64_t& i,
size_t& recoloring_size){
175 const size_t curr_lid = boundary_verts_view(i);
176 const int curr_color = femv_colors(curr_lid);
177 const size_t vid_d1_adj_begin = dist_offsets(curr_lid);
178 const size_t vid_d1_adj_end = dist_offsets(curr_lid+1);
179 const size_t curr_degree = vid_d1_adj_end - vid_d1_adj_begin;
180 for(
size_t vid_d1_adj = vid_d1_adj_begin; vid_d1_adj < vid_d1_adj_end; vid_d1_adj++){
182 size_t vid_d1 = dist_adjs(vid_d1_adj);
183 size_t d2_adj_begin = dist_offsets(vid_d1);
184 size_t d2_adj_end = dist_offsets(vid_d1+1);
190 for(
size_t vid_d2_adj = d2_adj_begin; vid_d2_adj < d2_adj_end; vid_d2_adj++){
191 const size_t vid_d2 = dist_adjs(vid_d2_adj);
192 size_t vid_d2_degree = 0;
195 if(vid_d2 < n_local){
196 vid_d2_degree = dist_offsets(vid_d2+1) - dist_offsets(vid_d2);
198 vid_d2_degree = ghost_degrees(vid_d2-n_local);
201 if(curr_lid != vid_d2 && femv_colors(vid_d2) == curr_color){
202 if(curr_degree < vid_d2_degree && recolor_degrees){
204 femv_colors(curr_lid) = 0;
207 }
else if(vid_d2_degree < curr_degree && recolor_degrees){
208 femv_colors(vid_d2) = 0;
210 }
else if(rand(curr_lid) < rand(vid_d2)){
212 femv_colors(curr_lid) = 0;
215 }
else if(rand(vid_d2) < rand(curr_lid)){
216 femv_colors(vid_d2) = 0;
219 if(gid(curr_lid) >= gid(vid_d2)){
221 femv_colors(curr_lid) = 0;
225 femv_colors(vid_d2) = 0;
233 },local_recoloring_size);
234 Kokkos::deep_copy(recoloringSize, local_recoloring_size);
237 Kokkos::parallel_for(
"rebuild verts_to_send and verts_to_recolor",
238 Kokkos::RangePolicy<ExecutionSpace>(0,femv_colors.size()),
239 KOKKOS_LAMBDA(
const uint64_t& i){
240 if(femv_colors(i) == 0){
243 verts_to_send_view(verts_to_send_size_atomic(0)++) = i;
246 verts_to_recolor_view(verts_to_recolor_size_atomic(0)++) = i;
254 Kokkos::View<offset_t*, device_type > dist_offsets_dev,
255 Kokkos::View<lno_t*, device_type > dist_adjs_dev,
256 Kokkos::View<int*,device_type > femv_colors,
257 Kokkos::View<lno_t*, device_type > boundary_verts_view,
262 Kokkos::MemoryTraits<Kokkos::Atomic>> verts_to_recolor_size_atomic,
265 Kokkos::View<
size_t*,
267 Kokkos::MemoryTraits<Kokkos::Atomic>> verts_to_send_size_atomic,
268 Kokkos::View<size_t*, device_type> recoloringSize,
275 bool recolor_degrees){
277 this->detectPD2Conflicts<execution_space, memory_space>(n_local,
282 verts_to_recolor_view,
283 verts_to_recolor_size_atomic,
285 verts_to_send_size_atomic,
294 typename Kokkos::View<offset_t*, device_type >::HostMirror dist_offsets_host,
295 typename Kokkos::View<lno_t*, device_type >::HostMirror dist_adjs_host,
296 typename Kokkos::View<int*,device_type >::HostMirror femv_colors,
297 typename Kokkos::View<lno_t*, device_type >::HostMirror boundary_verts_view,
298 typename Kokkos::View<lno_t*,device_type>::HostMirror verts_to_recolor,
299 typename Kokkos::View<int*,device_type>::HostMirror verts_to_recolor_size,
300 typename Kokkos::View<lno_t*,device_type>::HostMirror verts_to_send,
301 typename Kokkos::View<size_t*,device_type>::HostMirror verts_to_send_size,
302 typename Kokkos::View<size_t*, device_type>::HostMirror recoloringSize,
303 typename Kokkos::View<int*, device_type>::HostMirror rand,
304 typename Kokkos::View<gno_t*,device_type>::HostMirror gid,
305 typename Kokkos::View<gno_t*,device_type>::HostMirror ghost_degrees,
306 bool recolor_degrees) {
308 this->detectPD2Conflicts<host_exec, host_mem>(n_local,
314 verts_to_recolor_size,
325 Kokkos::View<offset_t*, device_type> dist_offsets_dev,
326 Kokkos::View<lno_t*, device_type> dist_adjs_dev,
327 typename Kokkos::View<offset_t*, device_type>::HostMirror dist_offsets_host,
328 typename Kokkos::View<lno_t*, device_type>::HostMirror dist_adjs_host,
329 Kokkos::View<lno_t*, device_type>& boundary_verts,
332 Kokkos::View<
size_t*,
334 Kokkos::MemoryTraits<Kokkos::Atomic>> verts_to_send_size_atomic){
337 gno_t boundary_size_temp = 0;
338 for(
size_t i = 0; i < n_local; i++){
339 for(
offset_t j = dist_offsets_host(i); j < dist_offsets_host(i+1); j++){
340 if((
size_t)dist_adjs_host(j) >= n_local){
341 boundary_size_temp++;
345 for(
offset_t k = dist_offsets_host(dist_adjs_host(j)); k < dist_offsets_host(dist_adjs_host(j)+1); k++){
346 if((
size_t)dist_adjs_host(k) >= n_local){
347 boundary_size_temp++;
357 boundary_verts = Kokkos::View<lno_t*, device_type>(
"boundary verts",boundary_size_temp);
358 typename Kokkos::View<lno_t*, device_type>::HostMirror boundary_verts_host = Kokkos::create_mirror_view(boundary_verts);
361 boundary_size_temp = 0;
363 for(
size_t i = 0; i < n_local; i++){
364 for(
offset_t j = dist_offsets_host(i); j < dist_offsets_host(i+1); j++){
365 if((
size_t)dist_adjs_host(j) >= n_local){
366 boundary_verts_host(boundary_size_temp++) = i;
370 for(
offset_t k = dist_offsets_host(dist_adjs_host(j)); k < dist_offsets_host(dist_adjs_host(j)+1); k++){
371 if((
size_t)dist_adjs_host(k) >= n_local){
372 boundary_verts_host(boundary_size_temp++) = i;
381 Kokkos::deep_copy(boundary_verts, boundary_verts_host);
384 Kokkos::parallel_for(
"init verts to send",
385 Kokkos::RangePolicy<execution_space, int>(0,n_local),
386 KOKKOS_LAMBDA(
const int& i){
387 for(
offset_t j = dist_offsets_dev(i); j < dist_offsets_dev(i+1); j++){
388 if((
size_t)dist_adjs_dev(j) >= n_local){
389 verts_to_send_view(verts_to_send_size_atomic(0)++) = i;
393 for(
offset_t k = dist_offsets_dev(dist_adjs_dev(j)); k < dist_offsets_dev(dist_adjs_dev(j)+1); k++){
394 if((
size_t)dist_adjs_dev(k) >= n_local){
395 verts_to_send_view(verts_to_send_size_atomic(0)++) = i;
410 const RCP<const base_adapter_t> &adapter_,
411 const RCP<Teuchos::ParameterList> &pl_,
412 const RCP<Environment> &env_,
413 const RCP<
const Teuchos::Comm<int> > &comm_)
Zoltan2::BaseAdapter< userTypes_t > base_adapter_t
Tpetra::FEMultiVector< femv_scalar_t, lno_t, gno_t > femv_t
typename Adapter::gno_t gno_t
typename Adapter::lno_t lno_t
virtual void detectConflicts(const size_t n_local, Kokkos::View< offset_t *, device_type > dist_offsets_dev, Kokkos::View< lno_t *, device_type > dist_adjs_dev, Kokkos::View< int *, device_type > femv_colors, Kokkos::View< lno_t *, device_type > boundary_verts_view, Kokkos::View< lno_t *, device_type > verts_to_recolor_view, Kokkos::View< int *, device_type, Kokkos::MemoryTraits< Kokkos::Atomic >> verts_to_recolor_size_atomic, Kokkos::View< lno_t *, device_type > verts_to_send_view, Kokkos::View< size_t *, device_type, Kokkos::MemoryTraits< Kokkos::Atomic >> verts_to_send_size_atomic, Kokkos::View< size_t *, device_type > recoloringSize, Kokkos::View< int *, device_type > rand, Kokkos::View< gno_t *, device_type > gid, Kokkos::View< gno_t *, device_type > ghost_degrees, bool recolor_degrees)
typename Adapter::lno_t lno_t
AlgPartialDistance2(const RCP< const base_adapter_t > &adapter_, const RCP< Teuchos::ParameterList > &pl_, const RCP< Environment > &env_, const RCP< const Teuchos::Comm< int > > &comm_)
map_t::global_ordinal_type gno_t
typename Adapter::offset_t offset_t
typename femv_t::host_view_type::device_type::memory_space host_mem
virtual void detectConflicts_serial(const size_t n_local, typename Kokkos::View< offset_t *, device_type >::HostMirror dist_offsets_host, typename Kokkos::View< lno_t *, device_type >::HostMirror dist_adjs_host, typename Kokkos::View< int *, device_type >::HostMirror femv_colors, typename Kokkos::View< lno_t *, device_type >::HostMirror boundary_verts_view, typename Kokkos::View< lno_t *, device_type >::HostMirror verts_to_recolor, typename Kokkos::View< int *, device_type >::HostMirror verts_to_recolor_size, typename Kokkos::View< lno_t *, device_type >::HostMirror verts_to_send, typename Kokkos::View< size_t *, device_type >::HostMirror verts_to_send_size, typename Kokkos::View< size_t *, device_type >::HostMirror recoloringSize, typename Kokkos::View< int *, device_type >::HostMirror rand, typename Kokkos::View< gno_t *, device_type >::HostMirror gid, typename Kokkos::View< gno_t *, device_type >::HostMirror ghost_degrees, bool recolor_degrees)
map_t::local_ordinal_type lno_t
typename femv_t::device_type device_type
Traits class to handle conversions between gno_t/lno_t and TPL data types (e.g., ParMETIS's idx_t...
typename femv_t::host_view_type::device_type::execution_space host_exec
virtual void constructBoundary(const size_t n_local, Kokkos::View< offset_t *, device_type > dist_offsets_dev, Kokkos::View< lno_t *, device_type > dist_adjs_dev, typename Kokkos::View< offset_t *, device_type >::HostMirror dist_offsets_host, typename Kokkos::View< lno_t *, device_type >::HostMirror dist_adjs_host, Kokkos::View< lno_t *, device_type > &boundary_verts, Kokkos::View< lno_t *, device_type > verts_to_send_view, Kokkos::View< size_t *, device_type, Kokkos::MemoryTraits< Kokkos::Atomic >> verts_to_send_size_atomic)
Defines the ColoringSolution class.
Defines the GraphModel interface.
void detectPD2Conflicts(const size_t n_local, Kokkos::View< offset_t *, Kokkos::Device< ExecutionSpace, MemorySpace >> dist_offsets, Kokkos::View< lno_t *, Kokkos::Device< ExecutionSpace, MemorySpace >> dist_adjs, Kokkos::View< int *, Kokkos::Device< ExecutionSpace, MemorySpace >> femv_colors, Kokkos::View< lno_t *, Kokkos::Device< ExecutionSpace, MemorySpace >> boundary_verts_view, Kokkos::View< lno_t *, Kokkos::Device< ExecutionSpace, MemorySpace > > verts_to_recolor_view, Kokkos::View< int *, Kokkos::Device< ExecutionSpace, MemorySpace >, Kokkos::MemoryTraits< Kokkos::Atomic > > verts_to_recolor_size_atomic, Kokkos::View< lno_t *, Kokkos::Device< ExecutionSpace, MemorySpace > > verts_to_send_view, Kokkos::View< size_t *, Kokkos::Device< ExecutionSpace, MemorySpace >, Kokkos::MemoryTraits< Kokkos::Atomic > > verts_to_send_size_atomic, Kokkos::View< size_t *, Kokkos::Device< ExecutionSpace, MemorySpace >> recoloringSize, Kokkos::View< int *, Kokkos::Device< ExecutionSpace, MemorySpace >> rand, Kokkos::View< gno_t *, Kokkos::Device< ExecutionSpace, MemorySpace >> gid, Kokkos::View< gno_t *, Kokkos::Device< ExecutionSpace, MemorySpace >> ghost_degrees, bool recolor_degrees)
A gathering of useful namespace methods.
typename Adapter::base_adapter_t base_adapter_t
typename device_type::execution_space execution_space
Tpetra::Map< lno_t, gno_t > map_t
typename Adapter::scalar_t scalar_t
typename device_type::memory_space memory_space
AlltoAll communication methods.
typename Adapter::offset_t offset_t