Block-Structured AMR Software Framework
 
Loading...
Searching...
No Matches
AMReX_Geometry.H
Go to the documentation of this file.
1#ifndef AMREX_GEOMETRY_H_
2#define AMREX_GEOMETRY_H_
3#include <AMReX_Config.H>
4
5#include <AMReX_Array.H>
6#include <AMReX_CoordSys.H>
8#include <AMReX_RealBox.H>
9#include <AMReX_Periodicity.H>
10
11#ifdef AMREX_USE_OMP
12#include <omp.h>
13#endif
14
15#include <iosfwd>
16#include <map>
17
18namespace amrex {
19
20class MultiFab;
21class DistributionMapping;
22class BoxArray;
23
25{
28 const Real* CellSize () const noexcept { return dx; }
29 //
31 Real CellSize (int dir) const noexcept { return dx[dir]; }
34 const Real* ProbLo () const noexcept { return prob_domain.lo(); }
35 //
37 Real ProbLo (int dir) const noexcept { return prob_domain.lo(dir); }
40 const Real* ProbHi () const noexcept { return prob_domain.hi(); }
41 //
43 Real ProbHi (int dir) const noexcept { return prob_domain.hi(dir); }
46 const Box& Domain () const noexcept { return domain; }
49 int isPeriodic (const int i) const noexcept { return is_periodic[i]; }
52 int Coord () const noexcept { return coord; }
53
54public:
57 Real dx[AMREX_SPACEDIM];
58 int is_periodic[AMREX_SPACEDIM];
59 int coord;
60};
61
72 :
73 public CoordSys
74{
75public:
80 Geometry () noexcept;
81
96 explicit Geometry (const Box& dom,
97 const RealBox* rb = nullptr,
98 int coord = -1,
99 int const* is_per = nullptr) noexcept;
114 Geometry (const Box& dom, const RealBox& rb, int coord,
115 Array<int,AMREX_SPACEDIM> const& is_per) noexcept;
116
117 ~Geometry () = default;
118 Geometry (const Geometry& rhs) = default;
119 Geometry (Geometry&& rhs) noexcept = default;
120 Geometry& operator= (const Geometry& rhs) = default;
121 Geometry& operator= (Geometry&& rhs) noexcept = default;
122
124 [[nodiscard]] GeometryData data() const noexcept {
125 return { prob_domain, domain, {AMREX_D_DECL(dx[0],dx[1],dx[2])},
127 static_cast<int>(c_sys) };
128 }
129
131 static void Setup (const RealBox* rb = nullptr, int coord = -1, int const* isper = nullptr) noexcept;
132 static void ResetDefaultProbDomain (const RealBox& rb) noexcept;
133 static void ResetDefaultPeriodicity (const Array<int,AMREX_SPACEDIM>& is_per) noexcept;
134 static void ResetDefaultCoord (int coord) noexcept;
135
151 void define (const Box& dom, const RealBox* rb = nullptr, int coord = -1, int const* is_per = nullptr) noexcept;
152
168 void define (const Box& dom, const RealBox& rb, int coord, Array<int,AMREX_SPACEDIM> const& is_per) noexcept;
169
171 [[nodiscard]] const RealBox& ProbDomain () const noexcept { return prob_domain; }
173 void ProbDomain (const RealBox& rb) noexcept
174 {
175 prob_domain = rb;
177 }
179 [[nodiscard]] const Real* ProbLo () const noexcept { return prob_domain.lo(); }
181 [[nodiscard]] const Real* ProbHi () const noexcept { return prob_domain.hi(); }
183 [[nodiscard]] Real ProbLo (int dir) const noexcept { return prob_domain.lo(dir); }
185 [[nodiscard]] Real ProbHi (int dir) const noexcept { return prob_domain.hi(dir); }
186
187 [[nodiscard]] GpuArray<Real,AMREX_SPACEDIM> ProbLoArray () const noexcept {
189 }
190
191 [[nodiscard]] GpuArray<Real,AMREX_SPACEDIM> ProbHiArray () const noexcept {
193 }
194
196 return roundoff_lo;
197 }
198
200 return roundoff_hi;
201 }
202
204 [[nodiscard]] Real ProbSize () const noexcept
205 {
207 }
209 [[nodiscard]] Real ProbLength (int dir) const noexcept { return prob_domain.length(dir); }
211 [[nodiscard]] const Box& Domain () const noexcept { return domain; }
213 void Domain (const Box& bx) noexcept
214 {
215 AMREX_ASSERT(bx.cellCentered());
216 domain = bx;
218 }
220 void GetVolume (MultiFab& vol,
221 const BoxArray& grds,
222 const DistributionMapping& dm,
223 int grow) const;
225 void GetVolume (MultiFab& vol) const;
226
227 void GetVolume (FArrayBox& vol,
228 const BoxArray& grds,
229 int idx,
230 int grow) const;
231
234 static Real Volume (const IntVect& point, const GeometryData& geomdata)
235 {
236 const auto *dx = geomdata.CellSize();
237
238 Real vol;
239
240#if AMREX_SPACEDIM == 1
241
242 auto coord = geomdata.Coord();
243
244 if (coord == CoordSys::cartesian) {
245 // Cartesian
246
247 vol = dx[0];
248 }
249 else {
250 // Spherical
251
252 Real rl = geomdata.ProbLo()[0] + static_cast<Real>(point[0]) * dx[0];
253 Real rr = rl + dx[0];
254
255 constexpr Real pi = Real(3.1415926535897932);
256 vol = (4.0_rt / 3.0_rt) * pi * dx[0] * (rl * rl + rl * rr + rr * rr);
257 }
258
259#elif AMREX_SPACEDIM == 2
260
261 auto coord = geomdata.Coord();
262
263 if (coord == CoordSys::cartesian) {
264 // Cartesian
265
266 vol = dx[0] * dx[1];
267 }
268 else if (coord == CoordSys::RZ) {
269 // Cylindrical
270
271 Real r_l = geomdata.ProbLo()[0] + static_cast<Real>(point[0]) * dx[0];
272 Real r_r = geomdata.ProbLo()[0] + static_cast<Real>(point[0]+1) * dx[0];
273
274 constexpr Real pi = Real(3.1415926535897932);
275 vol = pi * (r_l + r_r) * dx[0] * dx[1];
276 }
277 else {
278 // Spherical
279
280 Real r_l = geomdata.ProbLo()[0] + static_cast<Real>(point[0]) * dx[0];
281 Real r_r = geomdata.ProbLo()[0] + static_cast<Real>(point[0]+1) * dx[0];
282
283 Real theta_l = geomdata.ProbLo()[1] + static_cast<Real>(point[1]) * dx[1];
284 Real theta_r = geomdata.ProbLo()[1] + static_cast<Real>(point[1]+1) * dx[1];
285
286 constexpr Real twoThirdsPi = static_cast<Real>(2.0 * 3.1415926535897932 / 3.0);
287 vol = twoThirdsPi * (std::cos(theta_l) - std::cos(theta_r)) * dx[0] *
288 (r_r*r_r + r_r*r_l + r_l*r_l);
289 }
290
291#else
292
294
295 // Cartesian
296
297 vol = dx[0] * dx[1] * dx[2];
298
299#endif
300
301 return vol;
302 }
303
308 void GetDLogA (MultiFab& dloga,
309 const BoxArray& grds,
310 const DistributionMapping& dm,
311 int dir,
312 int grow) const;
317 void GetFaceArea (MultiFab& area,
318 const BoxArray& grds,
319 const DistributionMapping& dm,
320 int dir,
321 int grow) const;
323 void GetFaceArea (MultiFab& area,
324 int dir) const;
325
326 void GetFaceArea (FArrayBox& area,
327 const BoxArray& grds,
328 int idx,
329 int dir,
330 int grow) const;
332 [[nodiscard]] bool isPeriodic (int dir) const noexcept { return is_periodic[dir]; }
334 [[nodiscard]] bool isAnyPeriodic () const noexcept
335 {
336 return AMREX_D_TERM(isPeriodic(0),||isPeriodic(1),||isPeriodic(2));
337 }
339 [[nodiscard]] bool isAllPeriodic () const noexcept
340 {
341 return AMREX_D_TERM(isPeriodic(0),&&isPeriodic(1),&&isPeriodic(2));
342 }
343 [[nodiscard]] Array<int,AMREX_SPACEDIM> isPeriodic () const noexcept {
344 return {{AMREX_D_DECL(static_cast<int>(is_periodic[0]),
345 static_cast<int>(is_periodic[1]),
346 static_cast<int>(is_periodic[2]))}};
347 }
348 [[nodiscard]] GpuArray<int,AMREX_SPACEDIM> isPeriodicArray () const noexcept {
349 return {{AMREX_D_DECL(static_cast<int>(is_periodic[0]),
350 static_cast<int>(is_periodic[1]),
351 static_cast<int>(is_periodic[2]))}};
352 }
354 [[nodiscard]] int period (int dir) const noexcept { BL_ASSERT(is_periodic[dir]); return domain.length(dir); }
355
356 [[nodiscard]] Periodicity periodicity () const noexcept {
358 domain.length(1) * is_periodic[1],
359 domain.length(2) * is_periodic[2])));
360 }
361
362 [[nodiscard]] Periodicity periodicity (const Box& b) const noexcept {
363 AMREX_ASSERT(b.cellCentered());
364 return Periodicity(IntVect(AMREX_D_DECL(b.length(0) * is_periodic[0],
365 b.length(1) * is_periodic[1],
366 b.length(2) * is_periodic[2])));
367 }
368
377 void periodicShift (const Box& target,
378 const Box& src,
379 Vector<IntVect>& out) const noexcept;
380
382 [[nodiscard]] Box growNonPeriodicDomain (IntVect const& ngrow) const noexcept;
384 [[nodiscard]] Box growNonPeriodicDomain (int ngrow) const noexcept;
386 [[nodiscard]] Box growPeriodicDomain (IntVect const& ngrow) const noexcept;
388 [[nodiscard]] Box growPeriodicDomain (int ngrow) const noexcept;
389
396 is_periodic[1],
397 is_periodic[2])}};
399 is_periodic[1] = period[1];,
400 is_periodic[2] = period[2];);
401 return r;
402 }
403
404 void coarsen (IntVect const& rr) {
405 domain.coarsen(rr);
406 for (int i = 0; i < AMREX_SPACEDIM; ++i) {
407 dx[i] = (ProbHi(i) - ProbLo(i)) / static_cast<Real>(domain.length(i));
408 inv_dx[i] = Real(1.)/dx[i];
409 }
410 }
411
412 void refine (IntVect const& rr) {
413 domain.refine(rr);
414 for (int i = 0; i < AMREX_SPACEDIM; ++i) {
415 dx[i] = (ProbHi(i) - ProbLo(i)) / static_cast<Real>(domain.length(i));
416 inv_dx[i] = Real(1.)/dx[i];
417 }
418 }
419
427
435
440 void computeRoundoffDomain ();
441
443 [[nodiscard]] GpuArray<ParticleReal, AMREX_SPACEDIM> const&
444 RoundOffLo () const { return roundoff_lo; }
445
447 [[nodiscard]] GpuArray<ParticleReal, AMREX_SPACEDIM> const&
448 RoundOffHi () const { return roundoff_hi; }
449
450private:
451 void read_params ();
452
453 // is_periodic and RealBox used to be static
454 bool is_periodic[AMREX_SPACEDIM] = {AMREX_D_DECL(false,false,false)};
456
457 // Due to round-off errors, not all floating point numbers for which plo >= x < phi
458 // will map to a cell that is inside "domain". "roundoff_{lo,hi}" store
459 // positions that are very close to that in prob_domain, and for which all doubles and floats
460 // between them will map to a cell inside domain.
462
463 //
465
466 friend std::istream& operator>> (std::istream&, Geometry&);
467};
468
469
471std::ostream& operator<< (std::ostream&, const Geometry&);
473std::istream& operator>> (std::istream&, Geometry&);
474
475inline
477coarsen (Geometry const& fine, IntVect const& rr) {
478 Geometry r{fine};
479 r.coarsen(rr);
480 return r;
481}
482
483inline
484Geometry
485coarsen (Geometry const& fine, int rr) { return coarsen(fine, IntVect(rr)); }
486
487inline
488Geometry
489refine (Geometry const& crse, IntVect const& rr) {
490 Geometry r{crse};
491 r.refine(rr);
492 return r;
493}
494
495inline
496Geometry
497refine (Geometry const& crse, int rr) { return refine(crse, IntVect(rr)); }
498
499inline
500const Geometry&
502 return *(AMReX::top()->getDefaultGeometry());
503}
504
505}
506
507#endif /*_GEOMETRY_H_*/
#define BL_ASSERT(EX)
Definition AMReX_BLassert.H:39
#define AMREX_ASSERT(EX)
Definition AMReX_BLassert.H:38
#define AMREX_FORCE_INLINE
Definition AMReX_Extension.H:119
#define AMREX_INLINE
Definition AMReX_Extension.H:127
#define AMREX_GPU_HOST_DEVICE
Definition AMReX_GpuQualifiers.H:20
Array4< Real > fine
Definition AMReX_InterpFaceRegister.cpp:90
Array4< Real const > crse
Definition AMReX_InterpFaceRegister.cpp:92
#define AMREX_D_TERM(a, b, c)
Definition AMReX_SPACE.H:172
#define AMREX_D_DECL(a, b, c)
Definition AMReX_SPACE.H:171
Geometry * getDefaultGeometry() noexcept
Definition AMReX.H:321
static AMReX * top() noexcept
Definition AMReX.H:310
A collection of Boxes stored in an Array.
Definition AMReX_BoxArray.H:553
__host__ __device__ IntVectND< dim > length() const noexcept
Return the length of the BoxND.
Definition AMReX_Box.H:154
__host__ __device__ BoxND & coarsen(int ref_ratio) noexcept
Coarsen BoxND by given (positive) refinement ratio. NOTE: if type(dir) = CELL centered: lo <- lo/rati...
Definition AMReX_Box.H:722
__host__ __device__ BoxND & refine(int ref_ratio) noexcept
Refine BoxND by given (positive) refinement ratio. NOTE: if type(dir) = CELL centered: lo <- lo*ratio...
Definition AMReX_Box.H:698
Coordinate System.
Definition AMReX_CoordSys.H:24
Real inv_dx[3]
Definition AMReX_CoordSys.H:244
CoordType c_sys
Definition AMReX_CoordSys.H:239
Real dx[3]
Definition AMReX_CoordSys.H:242
@ RZ
Definition AMReX_CoordSys.H:27
@ cartesian
Definition AMReX_CoordSys.H:27
Calculates the distribution of FABs to MPI processes.
Definition AMReX_DistributionMapping.H:43
A Fortran Array of REALs.
Definition AMReX_FArrayBox.H:231
Rectangular problem domain geometry.
Definition AMReX_Geometry.H:74
Geometry(Geometry &&rhs) noexcept=default
Real ProbLo(int dir) const noexcept
Returns the lo end of the problem domain in specified direction.
Definition AMReX_Geometry.H:183
~Geometry()=default
GpuArray< ParticleReal, 3 > ProbLoArrayInParticleReal() const noexcept
Definition AMReX_Geometry.H:195
bool outsideRoundoffDomain(ParticleReal x, ParticleReal y, ParticleReal z) const
Returns true if a point is outside the roundoff domain. All particles with positions inside the round...
Definition AMReX_Geometry.cpp:688
void GetVolume(MultiFab &vol, const BoxArray &grds, const DistributionMapping &dm, int grow) const
Define a multifab of areas and volumes with given grow factor.
Definition AMReX_Geometry.cpp:207
void refine(IntVect const &rr)
Definition AMReX_Geometry.H:412
void coarsen(IntVect const &rr)
Definition AMReX_Geometry.H:404
GpuArray< ParticleReal, 3 > ProbHiArrayInParticleReal() const noexcept
Definition AMReX_Geometry.H:199
const Real * ProbHi() const noexcept
Returns the hi end of the problem domain in each dimension.
Definition AMReX_Geometry.H:181
GpuArray< ParticleReal, 3 > roundoff_hi
Definition AMReX_Geometry.H:461
__host__ static __device__ Real Volume(const IntVect &point, const GeometryData &geomdata)
Return the volume of the specified cell.
Definition AMReX_Geometry.H:234
bool is_periodic[3]
Definition AMReX_Geometry.H:454
bool isAnyPeriodic() const noexcept
Is domain periodic in any direction?
Definition AMReX_Geometry.H:334
GpuArray< ParticleReal, 3 > roundoff_lo
Definition AMReX_Geometry.H:461
Array< int, 3 > setPeriodicity(Array< int, 3 > const &period) noexcept
Definition AMReX_Geometry.H:394
friend std::istream & operator>>(std::istream &, Geometry &)
Nice ASCII input.
Definition AMReX_Geometry.cpp:25
static void ResetDefaultProbDomain(const RealBox &rb) noexcept
Definition AMReX_Geometry.cpp:183
Box domain
Definition AMReX_Geometry.H:464
void GetFaceArea(MultiFab &area, const BoxArray &grds, const DistributionMapping &dm, int dir, int grow) const
Compute area of cell faces in given region and stuff stuff the results into the passed MultiFab.
Definition AMReX_Geometry.cpp:298
Real ProbHi(int dir) const noexcept
Returns the hi end of the problem domain in specified direction.
Definition AMReX_Geometry.H:185
Geometry(const Geometry &rhs)=default
int period(int dir) const noexcept
What's period in specified direction?
Definition AMReX_Geometry.H:354
Geometry & operator=(const Geometry &rhs)=default
const Box & Domain() const noexcept
Returns our rectangular domain.
Definition AMReX_Geometry.H:211
GpuArray< int, 3 > isPeriodicArray() const noexcept
Definition AMReX_Geometry.H:348
const RealBox & ProbDomain() const noexcept
Returns the problem domain.
Definition AMReX_Geometry.H:171
void Domain(const Box &bx) noexcept
Sets our rectangular domain.
Definition AMReX_Geometry.H:213
Periodicity periodicity() const noexcept
Definition AMReX_Geometry.H:356
Array< int, 3 > isPeriodic() const noexcept
Definition AMReX_Geometry.H:343
void GetDLogA(MultiFab &dloga, const BoxArray &grds, const DistributionMapping &dm, int dir, int grow) const
Compute d(log(A))/dr at cell centers in given region and stuff the results into the passed MultiFab.
Box growNonPeriodicDomain(IntVect const &ngrow) const noexcept
Return domain box with non-periodic directions grown by ngrow.
Definition AMReX_Geometry.cpp:479
void periodicShift(const Box &target, const Box &src, Vector< IntVect > &out) const noexcept
Compute Array of shifts which will translate src so that it will intersect target with non-zero inter...
Definition AMReX_Geometry.cpp:369
static void Setup(const RealBox *rb=nullptr, int coord=-1, int const *isper=nullptr) noexcept
Read static values from ParmParse database.
Definition AMReX_Geometry.cpp:108
Real ProbLength(int dir) const noexcept
Returns length of problem domain in specified dimension.
Definition AMReX_Geometry.H:209
void computeRoundoffDomain()
Compute the roundoff domain. Public because it contains an extended host / device lambda.
Definition AMReX_Geometry.cpp:515
const Real * ProbLo() const noexcept
Returns the lo end of the problem domain in each dimension.
Definition AMReX_Geometry.H:179
GeometryData data() const noexcept
Returns non-static copy of geometry's stored data.
Definition AMReX_Geometry.H:124
Geometry() noexcept
The default constructor.
Definition AMReX_Geometry.cpp:45
void define(const Box &dom, const RealBox *rb=nullptr, int coord=-1, int const *is_per=nullptr) noexcept
Definition AMReX_Geometry.cpp:70
GpuArray< Real, 3 > ProbHiArray() const noexcept
Definition AMReX_Geometry.H:191
Box growPeriodicDomain(IntVect const &ngrow) const noexcept
Return domain box with periodic directions grown by ngrow.
Definition AMReX_Geometry.cpp:491
Real ProbSize() const noexcept
Returns the overall size of the domain by multiplying the ProbLength's together.
Definition AMReX_Geometry.H:204
bool insideRoundoffDomain(ParticleReal x, ParticleReal y, ParticleReal z) const
Returns true if a point is inside the roundoff domain. All particles with positions inside the roundo...
Definition AMReX_Geometry.cpp:700
void ProbDomain(const RealBox &rb) noexcept
Sets the problem domain.
Definition AMReX_Geometry.H:173
GpuArray< Real, 3 > ProbLoArray() const noexcept
Definition AMReX_Geometry.H:187
bool isAllPeriodic() const noexcept
Is domain periodic in all directions?
Definition AMReX_Geometry.H:339
bool isPeriodic(int dir) const noexcept
Is the domain periodic in the specified direction?
Definition AMReX_Geometry.H:332
static void ResetDefaultPeriodicity(const Array< int, 3 > &is_per) noexcept
Definition AMReX_Geometry.cpp:192
RealBox prob_domain
Definition AMReX_Geometry.H:455
GpuArray< ParticleReal, 3 > const & RoundOffLo() const
Returns roundoff domain's lower end.
Definition AMReX_Geometry.H:444
static void ResetDefaultCoord(int coord) noexcept
Definition AMReX_Geometry.cpp:199
GpuArray< ParticleReal, 3 > const & RoundOffHi() const
Returns roundoff domain's higher end.
Definition AMReX_Geometry.H:448
Periodicity periodicity(const Box &b) const noexcept
Definition AMReX_Geometry.H:362
A collection (stored as an array) of FArrayBox objects.
Definition AMReX_MultiFab.H:40
This provides length of period for periodic domains. 0 means it is not periodic in that direction....
Definition AMReX_Periodicity.H:17
A Box with real dimensions.
Definition AMReX_RealBox.H:26
__host__ __device__ const Real * lo() const &noexcept
Returns lo side.
Definition AMReX_RealBox.H:51
__host__ __device__ const Real * hi() const &noexcept
Returns hide side.
Definition AMReX_RealBox.H:56
__host__ __device__ Real length(int dir) const noexcept
Returns length in specified direction.
Definition AMReX_RealBox.H:67
This class is a thin wrapper around std::vector. Unlike vector, Vector::operator[] provides bound che...
Definition AMReX_Vector.H:28
amrex_real Real
Floating Point Type for Fields.
Definition AMReX_REAL.H:79
amrex_particle_real ParticleReal
Floating Point Type for Particles.
Definition AMReX_REAL.H:90
__host__ __device__ BoxND< dim > coarsen(const BoxND< dim > &b, int ref_ratio) noexcept
Coarsen BoxND by given (positive) coarsening ratio.
Definition AMReX_Box.H:1407
__host__ __device__ BoxND< dim > grow(const BoxND< dim > &b, int i) noexcept
Grow BoxND in all directions by given amount.
Definition AMReX_Box.H:1278
__host__ __device__ BoxND< dim > refine(const BoxND< dim > &b, int ref_ratio) noexcept
Definition AMReX_Box.H:1457
std::array< T, N > Array
Definition AMReX_Array.H:25
Definition AMReX_Amr.cpp:49
__host__ __device__ void ignore_unused(const Ts &...)
This shuts up the compiler about unused variables.
Definition AMReX.H:138
IntVectND< 3 > IntVect
IntVect is an alias for amrex::IntVectND instantiated with AMREX_SPACEDIM.
Definition AMReX_BaseFwd.H:30
const Geometry & DefaultGeometry()
Definition AMReX_Geometry.H:501
std::istream & operator>>(std::istream &is, BoxND< dim > &bx)
Read from istream.
Definition AMReX_Box.H:1821
std::ostream & operator<<(std::ostream &os, AmrMesh const &amr_mesh)
Definition AMReX_AmrMesh.cpp:1236
Definition AMReX_Geometry.H:25
Box domain
Definition AMReX_Geometry.H:56
__host__ __device__ Real ProbLo(int dir) const noexcept
Definition AMReX_Geometry.H:37
__host__ __device__ Real CellSize(int dir) const noexcept
Definition AMReX_Geometry.H:31
__host__ __device__ int Coord() const noexcept
Coordinates type.
Definition AMReX_Geometry.H:52
__host__ __device__ const Box & Domain() const noexcept
Returns our rectangular domain.
Definition AMReX_Geometry.H:46
Real dx[3]
Definition AMReX_Geometry.H:57
__host__ __device__ Real ProbHi(int dir) const noexcept
Definition AMReX_Geometry.H:43
__host__ __device__ const Real * CellSize() const noexcept
Returns the cellsize for each coordinate direction.
Definition AMReX_Geometry.H:28
int coord
Definition AMReX_Geometry.H:59
__host__ __device__ int isPeriodic(const int i) const noexcept
Returns whether the domain is periodic in the given direction.
Definition AMReX_Geometry.H:49
int is_periodic[3]
Definition AMReX_Geometry.H:58
__host__ __device__ const Real * ProbLo() const noexcept
Returns the lo end of the problem domain in each dimension.
Definition AMReX_Geometry.H:34
RealBox prob_domain
Definition AMReX_Geometry.H:55
__host__ __device__ const Real * ProbHi() const noexcept
Returns the hi end of the problem domain in each dimension.
Definition AMReX_Geometry.H:40
Fixed-size array that can be used on GPU.
Definition AMReX_Array.H:40