1#ifndef AMREX_NEIGHBORPARTICLESGPUIMPL_H_
2#define AMREX_NEIGHBORPARTICLESGPUIMPL_H_
3#include <AMReX_Config.H>
12 "Too many cells requested in getBoundaryBoxes");
15 "Box must be cell-centered");
18 for (
int i = 0; i < AMREX_SPACEDIM; ++i) {
22 face_boxes.
push_back(hi_face_box); bl.push_back(hi_face_box);
23 face_boxes.
push_back(lo_face_box); bl.push_back(lo_face_box);
24 for (
auto face_box : face_boxes) {
25 for (
int j = 0; j < AMREX_SPACEDIM; ++j) {
26 if (i == j) {
continue; }
30 edge_boxes.
push_back(hi_edge_box); bl.push_back(hi_edge_box);
31 edge_boxes.
push_back(lo_edge_box); bl.push_back(lo_edge_box);
32 for (
auto edge_box : edge_boxes) {
33 for (
int k = 0; k < AMREX_SPACEDIM; ++k) {
34 if ((j == k) || (i == k)) {
continue; }
37 bl.push_back(hi_corner_box);
38 bl.push_back(lo_corner_box);
50template <
int NStructReal,
int NStructInt,
int NArrayReal,
int NArrayInt>
55 BL_PROFILE(
"NeighborParticleContainer<NStructReal, NStructInt, NArrayReal, NArrayInt>::buildNeighborMask");
56 m_neighbor_mask_initialized =
true;
58 const Geometry& geom = this->Geom(lev);
59 const BoxArray& ba = this->ParticleBoxArray(lev);
64 if (m_neighbor_mask_ptr ==
nullptr ||
69 const std::vector<IntVect>& pshifts = periodicity.
shiftIntVect();
73 int grid = mfi.index();
75 std::set<NeighborTask> neighbor_grids;
76 for (
auto pshift : pshifts)
78 const Box box = ba[mfi] + pshift;
80 const bool first_only =
false;
81 auto isecs = ba.
intersections(box, first_only, m_num_neighbor_cells);
83 for (
auto& isec : isecs)
85 int nbor_grid = isec.first;
86 const Box isec_box = isec.second - pshift;
87 if ( (grid == nbor_grid) && (pshift == 0)) {
continue; }
88 neighbor_grids.insert(
NeighborTask(nbor_grid, isec_box, pshift));
89 const int global_rank = dmap[nbor_grid];
96 for (
auto nbor_grid : neighbor_grids)
99 code.
grid_id = nbor_grid.grid_id;
105 m_code_array[grid].resize(h_code_arr.
size());
107 m_code_array[grid].begin());
108 m_isec_boxes[grid].resize(h_isec_boxes.
size());
110 m_isec_boxes[grid].begin());
119template <
int NStructReal,
int NStructInt,
int NArrayReal,
int NArrayInt>
124 BL_PROFILE(
"NeighborParticleContainer<NStructReal, NStructInt, NArrayReal, NArrayInt>::buildNeighborCopyOp()");
129 const auto& geom = this->Geom(lev);
130 const auto dxi = this->Geom(lev).InvCellSizeArray();
131 const auto plo = this->Geom(lev).ProbLoArray();
132 const auto domain = this->Geom(lev).Domain();
133 auto& plev = this->GetParticles(lev);
134 auto& ba = this->ParticleBoxArray(lev);
136 if (ba.size() == 1 && (! geom.isAnyPeriodic()) ) {
return; }
138 for(
MFIter mfi = this->MakeMFIter(lev); mfi.
isValid(); ++mfi)
140 int gid = mfi.index();
141 int tid = mfi.LocalTileIndex();
142 auto index = std::make_pair(gid, tid);
144 auto& src_tile = plev[index];
145 auto& aos = src_tile.GetArrayOfStructs();
146 const size_t np_real = aos.numParticles();
149 if (use_boundary_neighbor) {
150 np = m_boundary_particle_ids[lev][index].size();
153 m_boundary_particle_ids.resize(1);
154 m_boundary_particle_ids[lev][index];
157 const auto* p_bndry_pid = m_boundary_particle_ids[lev][index].dataPtr();
161 auto p_counts = counts.
dataPtr();
162 auto p_offsets = offsets.
dataPtr();
165 auto p_code_array = m_code_array[gid].dataPtr();
166 auto p_isec_boxes = m_isec_boxes[gid].dataPtr();
167 const int nisec_box = m_isec_boxes[gid].size();
175 if (use_boundary_neighbor) {
176 pid = p_bndry_pid[i];
179 for (
int j=0; j<nisec_box; ++j) {
180 if (p_isec_boxes[j].contains(iv)) {
192 neighbor_copy_op.resize(gid, lev, num_copies);
194 auto p_boxes = neighbor_copy_op.m_boxes[lev][gid].dataPtr();
195 auto p_levs = neighbor_copy_op.m_levels[lev][gid].dataPtr();
196 auto p_src_indices = neighbor_copy_op.m_src_indices[lev][gid].dataPtr();
197 auto p_periodic_shift = neighbor_copy_op.m_periodic_shift[lev][gid].dataPtr();
203 if (use_boundary_neighbor) {
204 pid = p_bndry_pid[i];
207 int k = p_offsets[i];
208 for (
int j=0; j<nisec_box; ++j) {
209 if (p_isec_boxes[j].contains(iv)) {
210 p_boxes[k] = p_code_array[j].grid_id;
212 p_periodic_shift[k] = p_code_array[j].periodic_shift;
213 p_src_indices[k] = pid;
224template <
int NStructReal,
int NStructInt,
int NArrayReal,
int NArrayInt>
229 BL_PROFILE(
"NeighborParticleContainer::fillNeighbors");
234 this->defineBufferMap();
236 neighbor_copy_op.clear();
237 neighbor_copy_plan.clear();
238 buildNeighborCopyOp();
239 neighbor_copy_plan.build(*
this, neighbor_copy_op, ghost_int_comp,
240 ghost_real_comp,
true);
241 updateNeighborsGPU(
false);
244template <
int NStructReal,
int NStructInt,
int NArrayReal,
int NArrayInt>
249 BL_PROFILE(
"NeighborParticleContainer::updateNeighborsGPU");
251 if (boundary_neighbors_only) {
252 neighbor_copy_op.clear();
253 neighbor_copy_plan.clear();
254 buildNeighborCopyOp(
true);
255 neighbor_copy_plan.build(*
this, neighbor_copy_op, ghost_int_comp,
256 ghost_real_comp,
true);
261 if (this->use_comms_arena) {
266 packBuffer(*
this, neighbor_copy_op, neighbor_copy_plan, snd_buffer);
269 neighbor_copy_plan.buildMPIFinish(this->BufferMap());
278 if (snd_buffer.arena()->isPinned()) {
279 neighbor_copy_plan.buildMPIFinish(this->BufferMap());
283 pinned_snd_buffer.resize(snd_buffer.size());
285 neighbor_copy_plan.buildMPIFinish(this->BufferMap());
290 rcv_buffer.resize(pinned_rcv_buffer.size());
300template <
int NStructReal,
int NStructInt,
int NArrayReal,
int NArrayInt>
305 BL_PROFILE(
"NeighborParticleContainer::clearNeighborsGPU");
309 for (
int lev = 0; lev < this->numLevels(); ++lev)
311 for(
MFIter mfi = this->MakeMFIter(lev); mfi.
isValid(); ++mfi)
313 auto& ptile = this->DefineAndReturnParticleTile(lev, mfi);
314 ptile.setNumNeighbors(0);
#define BL_PROFILE(a)
Definition AMReX_BLProfiler.H:551
#define AMREX_ASSERT_WITH_MESSAGE(EX, MSG)
Definition AMReX_BLassert.H:37
#define AMREX_ASSERT(EX)
Definition AMReX_BLassert.H:38
#define AMREX_ALWAYS_ASSERT(EX)
Definition AMReX_BLassert.H:50
#define AMREX_FOR_1D(...)
Definition AMReX_GpuLaunchMacrosC.nolint.H:97
A collection of Boxes stored in an Array.
Definition AMReX_BoxArray.H:550
std::vector< std::pair< int, Box > > intersections(const Box &bx) const
Return intersections of Box and BoxArray.
static bool SameRefs(const BoxArray &lhs, const BoxArray &rhs)
whether two BoxArrays share the same data
Definition AMReX_BoxArray.H:820
Long size() const noexcept
Return the number of boxes in the BoxArray.
Definition AMReX_BoxArray.H:597
A class for managing a List of Boxes that share a common IndexType. This class implements operations ...
Definition AMReX_BoxList.H:52
void push_back(const Box &bn)
Append a Box to this BoxList.
Definition AMReX_BoxList.H:93
AMREX_GPU_HOST_DEVICE IndexTypeND< dim > ixType() const noexcept
Returns the indexing type.
Definition AMReX_Box.H:127
AMREX_GPU_HOST_DEVICE IntVectND< dim > size() const noexcept
Return the length of the BoxND.
Definition AMReX_Box.H:139
Calculates the distribution of FABs to MPI processes.
Definition AMReX_DistributionMapping.H:41
static bool SameRefs(const DistributionMapping &lhs, const DistributionMapping &rhs)
Definition AMReX_DistributionMapping.H:187
Rectangular problem domain geometry.
Definition AMReX_Geometry.H:73
bool isAnyPeriodic() const noexcept
Is domain periodic in any direction?
Definition AMReX_Geometry.H:333
Periodicity periodicity() const noexcept
Definition AMReX_Geometry.H:355
Definition AMReX_MFIter.H:57
bool isValid() const noexcept
Is the iterator valid i.e. is it associated with a FAB?
Definition AMReX_MFIter.H:141
void clearNeighborsGPU()
Definition AMReX_NeighborParticlesGPUImpl.H:303
typename ParticleContainerType::ParticleType ParticleType
Definition AMReX_NeighborParticles.H:38
void buildNeighborCopyOp(bool use_boundary_neighbor=false)
Definition AMReX_NeighborParticlesGPUImpl.H:122
void updateNeighborsGPU(bool boundary_neighbors_only=false)
Definition AMReX_NeighborParticlesGPUImpl.H:247
void buildNeighborMask()
Definition AMReX_NeighborParticlesGPUImpl.H:53
void fillNeighborsGPU()
Definition AMReX_NeighborParticlesGPUImpl.H:227
Definition AMReX_PODVector.H:262
size_type size() const noexcept
Definition AMReX_PODVector.H:591
iterator begin() noexcept
Definition AMReX_PODVector.H:617
iterator end() noexcept
Definition AMReX_PODVector.H:621
T * dataPtr() noexcept
Definition AMReX_PODVector.H:613
T * data() noexcept
Definition AMReX_PODVector.H:609
void push_back(const T &a_value)
Definition AMReX_PODVector.H:572
This provides length of period for periodic domains. 0 means it is not periodic in that direction....
Definition AMReX_Periodicity.H:17
std::vector< IntVect > shiftIntVect(IntVect const &nghost=IntVect(0)) const
Definition AMReX_Periodicity.cpp:8
This class is a thin wrapper around std::vector. Unlike vector, Vector::operator[] provides bound che...
Definition AMReX_Vector.H:27
void copyAsync(HostToDevice, InIter begin, InIter end, OutIter result) noexcept
A host-to-device copy routine. Note this is just a wrapper around memcpy, so it assumes contiguous st...
Definition AMReX_GpuContainers.H:233
OutIter exclusive_scan(InIter begin, InIter end, OutIter result)
Definition AMReX_Scan.H:1377
static constexpr HostToDevice hostToDevice
Definition AMReX_GpuContainers.H:98
void streamSynchronize() noexcept
Definition AMReX_GpuDevice.H:237
void dtoh_memcpy_async(void *p_h, const void *p_d, const std::size_t sz) noexcept
Definition AMReX_GpuDevice.H:265
void htod_memcpy_async(void *p_d, const void *p_h, const std::size_t sz) noexcept
Definition AMReX_GpuDevice.H:251
int global_to_local_rank(int rank) noexcept
Definition AMReX_ParallelContext.H:98
bool UseGpuAwareMpi()
Definition AMReX_ParallelDescriptor.H:111
Vector< Box > getBoundaryBoxes(const Box &box, int ncells)
Definition AMReX_NeighborParticlesGPUImpl.H:9
Definition AMReX_Amr.cpp:49
void communicateParticlesStart(const PC &pc, ParticleCopyPlan &plan, const SndBuffer &snd_buffer, RcvBuffer &rcv_buffer)
Definition AMReX_ParticleCommunication.H:500
AMREX_GPU_HOST_DEVICE AMREX_FORCE_INLINE IntVect getParticleCell(P const &p, amrex::GpuArray< amrex::Real, AMREX_SPACEDIM > const &plo, amrex::GpuArray< amrex::Real, AMREX_SPACEDIM > const &dxi) noexcept
Returns the cell index for a given particle using the provided lower bounds and cell sizes.
Definition AMReX_ParticleUtil.H:374
void unpackRemotes(PC &pc, const ParticleCopyPlan &plan, Buffer &rcv_buffer, UnpackPolicy const &policy)
Definition AMReX_ParticleCommunication.H:600
AMREX_GPU_HOST_DEVICE AMREX_FORCE_INLINE BoxND< dim > adjCellLo(const BoxND< dim > &b, int dir, int len=1) noexcept
Returns the cell centered BoxND of length len adjacent to b on the low end along the coordinate direc...
Definition AMReX_Box.H:1591
void communicateParticlesFinish(const ParticleCopyPlan &plan)
Definition AMReX_ParticleCommunication.cpp:384
Arena * The_Comms_Arena()
Definition AMReX_Arena.cpp:676
int numParticlesOutOfRange(Iterator const &pti, int nGrow)
Returns the number of particles that are more than nGrow cells from the box correspond to the input i...
Definition AMReX_ParticleUtil.H:34
AMREX_GPU_HOST_DEVICE AMREX_FORCE_INLINE BoxND< dim > adjCellHi(const BoxND< dim > &b, int dir, int len=1) noexcept
Similar to adjCellLo but builds an adjacent BoxND on the high end.
Definition AMReX_Box.H:1612
void RemoveDuplicates(Vector< T > &vec)
Definition AMReX_Vector.H:208
void unpackBuffer(PC &pc, const ParticleCopyPlan &plan, const Buffer &snd_buffer, UnpackPolicy const &policy)
Definition AMReX_ParticleCommunication.H:435
void packBuffer(const PC &pc, const ParticleCopyOp &op, const ParticleCopyPlan &plan, Buffer &snd_buffer)
Definition AMReX_ParticleCommunication.H:336
Definition AMReX_FabArrayCommI.H:896
Definition AMReX_NeighborParticles.H:16
IntVect periodic_shift
Definition AMReX_NeighborParticles.H:18
int grid_id
Definition AMReX_NeighborParticles.H:17
Definition AMReX_NeighborParticles.H:432
Definition AMReX_ParticleCommunication.H:19