33 Real small_volfrac = 1.e-14;
35 pp.queryAdd(
"small_volfrac", small_volfrac);
36 const Real small_value = 1.e-15;
38 const IntVect vdim(IntVect::TheDimensionVector(a_idim));
40 const BoxArray& my_grids = amrex::convert(a_grids, vdim);
42 m_cellflags =
new FabArray<EBCellFlagFab>(my_grids, a_dmap, 1, a_ngrow[0], MFInfo(),
43 DefaultFabFactory<EBCellFlagFab>());
47 for (MFIter mfi(*
m_cellflags,
false); mfi.isValid(); ++mfi) {
48 auto& fab = (*m_cellflags)[mfi];
49 fab.setType(FabType::singlevalued);
52 m_volfrac =
new MultiFab(my_grids, a_dmap, 1, a_ngrow[1], MFInfo(), FArrayBoxFactory());
53 m_volcent =
new MultiFab(my_grids, a_dmap, AMREX_SPACEDIM, a_ngrow[2], MFInfo(), FArrayBoxFactory());
55 for (
int idim = 0; idim < AMREX_SPACEDIM; ++idim) {
56 m_areafrac[idim] =
new MultiFab(a_grids, a_dmap, 1, a_ngrow[1]+1, MFInfo(), FArrayBoxFactory());
57 m_facecent[idim] =
new MultiFab(a_grids, a_dmap, AMREX_SPACEDIM-1, a_ngrow[2], MFInfo(), FArrayBoxFactory());
60 m_bndryarea =
new MultiFab(my_grids, a_dmap, 1, a_ngrow[2], MFInfo(), FArrayBoxFactory());
61 m_bndrycent =
new MultiFab(my_grids, a_dmap, AMREX_SPACEDIM, a_ngrow[2], MFInfo(), FArrayBoxFactory());
62 m_bndrynorm =
new MultiFab(my_grids, a_dmap, AMREX_SPACEDIM, a_ngrow[2], MFInfo(), FArrayBoxFactory());
68 for (
int idim = 0; idim < AMREX_SPACEDIM; ++idim) {
77 const auto& FlagFab = a_factory->getMultiEBCellFlagFab();
79 for (MFIter mfi(*
m_cellflags,
false); mfi.isValid(); ++mfi) {
81 const Box& bx = mfi.validbox();
82 const Box& bx_grown = mfi.growntilebox();
83 const Box tbx = mfi.nodaltilebox(a_idim);
84 const Box domain = surroundingNodes(a_geom.Domain(), a_idim);
86 GpuArray<Real, AMREX_SPACEDIM> dx = a_geom.CellSizeArray();
87 bool l_periodic = a_geom.isPeriodic(a_idim);
89 Array4<EBCellFlag>
const& aux_flag =
m_cellflags->array(mfi);
90 Array4<Real>
const& aux_vfrac =
m_volfrac->array(mfi);
91 Array4<Real>
const& aux_afrac_x =
m_areafrac[0]->array(mfi);
92 Array4<Real>
const& aux_afrac_y =
m_areafrac[1]->array(mfi);
93 Array4<Real>
const& aux_afrac_z =
m_areafrac[2]->array(mfi);
95 if (FlagFab[mfi].getType(bx) == FabType::covered ) {
97 ParallelFor(tbx, [=] AMREX_GPU_DEVICE (
int i,
int j,
int k) noexcept
99 aux_flag(i,j,k).setCovered();
100 aux_flag(i,j,k).setDisconnected();
101 if (i==bx.bigEnd(0)) {
102 aux_flag(i+1,j,k).setCovered();
104 if (j==bx.bigEnd(1)) {
105 aux_flag(i,j+1,k).setCovered();
107 if (k==bx.bigEnd(2)) {
108 aux_flag(i,j,k+1).setCovered();
112 }
else if (FlagFab[mfi].getType(bx) == FabType::regular ) {
114 ParallelFor(tbx, [=] AMREX_GPU_DEVICE (
int i,
int j,
int k) noexcept
116 aux_flag(i,j,k).setRegular();
117 aux_flag(i,j,k).setDisconnected();
118 aux_vfrac(i,j,k) = 1.0;
119 aux_afrac_x(i,j,k) = 1.0;
120 aux_afrac_y(i,j,k) = 1.0;
121 aux_afrac_z(i,j,k) = 1.0;
122 if (i==bx.bigEnd(0)) {
123 aux_flag(i+1,j,k).setRegular();
124 aux_vfrac(i+1,j,k) = 1.0;
125 aux_afrac_x(i+1,j,k) = 1.0;
127 if (j==bx.bigEnd(1)) {
128 aux_flag(i,j+1,k).setRegular();
129 aux_vfrac(i,j+1,k) = 1.0;
130 aux_afrac_y(i,j+1,k) = 1.0;
132 if (k==bx.bigEnd(2)) {
133 aux_flag(i,j,k+1).setRegular();
134 aux_vfrac(i,j,k+1) = 1.0;
135 aux_afrac_z(i,j,k+1) = 1.0;
139 }
else if (FlagFab[mfi].getType(bx) == FabType::singlevalued ) {
144 Array4<EBCellFlag const>
const& flag = FlagFab.const_array(mfi);
145 Array4<Real const>
const& afrac = (a_factory->getAreaFrac()[a_idim])->const_array(mfi);
146 Array4<Real const>
const& bnorm = a_factory->getBndryNormal()[mfi].const_array();
147 Array4<Real const>
const& bcent = a_factory->getBndryCent()[mfi].const_array();
150 Array4<Real>
const& aux_vcent =
m_volcent->array(mfi);
151 Array4<Real>
const& aux_fcent_x =
m_facecent[0]->array(mfi);
152 Array4<Real>
const& aux_fcent_y =
m_facecent[1]->array(mfi);
153 Array4<Real>
const& aux_fcent_z =
m_facecent[2]->array(mfi);
154 Array4<Real>
const& aux_barea =
m_bndryarea->array(mfi);
155 Array4<Real>
const& aux_bcent =
m_bndrycent->array(mfi);
156 Array4<Real>
const& aux_bnorm =
m_bndrynorm->array(mfi);
159 Box dom_grown = domain;
160 for (
int idim = 0; idim < AMREX_SPACEDIM; ++idim) {
161 if (a_geom.isPeriodic(idim)) {
162 dom_grown.grow(idim, a_ngrow[0]);
166 const IntVect dom_grown_lo = dom_grown.smallEnd();
167 const IntVect dom_grown_hi = dom_grown.bigEnd();
169 BoxList diffList = boxDiff(bx_grown, bx);
170 for (
const Box& b : diffList) {
171 ParallelFor(b, [=] AMREX_GPU_DEVICE (
int i,
int j,
int k) noexcept
173 if ( i < dom_grown_lo[0] || i > dom_grown_hi[0] ||
174 j < dom_grown_lo[1] || j > dom_grown_hi[1] ||
175 k < dom_grown_lo[2] || k > dom_grown_hi[2] ) {
176 aux_flag(i,j,k).setCovered();
177 aux_flag(i,j,k).setDisconnected();
182 #ifndef AMREX_USE_GPU
186 ParallelFor(bx, [=] AMREX_GPU_DEVICE (
int i,
int j,
int k) noexcept
189 aux_flag(i,j,k).setCovered();
190 aux_flag(i,j,k).setDisconnected();
192 if (i==bx.bigEnd(0)) {
193 aux_flag(i+1,j,k).setCovered();
195 if (j==bx.bigEnd(1)) {
196 aux_flag(i,j+1,k).setCovered();
198 if (k==bx.bigEnd(2)) {
199 aux_flag(i,j,k+1).setCovered();
203 IntVect iv_hi(i,j,k);
204 IntVect iv_lo(iv_hi - vdim);
206 bool lo_isCovered = flag(iv_lo).isCovered();
207 bool hi_isCovered = flag(iv_hi).isCovered();
208 bool lo_isRegular = flag(iv_lo).isRegular();
209 bool hi_isRegular = flag(iv_hi).isRegular();
210 bool lo_isSingleValued = flag(iv_lo).isSingleValued();
211 bool hi_isSingleValued = flag(iv_hi).isSingleValued();
213 const bool at_lo_boundary = (!l_periodic && iv_hi[a_idim]==domain.smallEnd(a_idim));
214 const bool at_hi_boundary = (!l_periodic && iv_hi[a_idim]==domain.bigEnd(a_idim));
218 if (at_lo_boundary) {
221 lo_isRegular =
false;
222 lo_isSingleValued =
false;
223 }
else if (hi_isRegular) {
224 lo_isCovered =
false;
226 lo_isSingleValued =
false;
227 }
else if (hi_isSingleValued) {
228 if (almostEqual(afrac(i,j,k),0.0)) {
230 lo_isRegular =
false;
231 lo_isSingleValued =
false;
232 }
else if (almostEqual(afrac(i,j,k),1.0)) {
233 lo_isCovered =
false;
235 lo_isSingleValued =
false;
237 lo_isCovered =
false;
238 lo_isRegular =
false;
239 lo_isSingleValued =
true;
247 if (at_hi_boundary) {
250 hi_isRegular =
false;
251 hi_isSingleValued =
false;
252 }
else if (lo_isRegular) {
253 hi_isCovered =
false;
255 hi_isSingleValued =
false;
256 }
else if (lo_isSingleValued) {
257 if (almostEqual(afrac(i,j,k),0.0)) {
259 hi_isRegular =
false;
260 hi_isSingleValued =
false;
261 }
else if (almostEqual(afrac(i,j,k),1.0)) {
262 hi_isCovered =
false;
264 hi_isSingleValued =
false;
266 hi_isCovered =
false;
267 hi_isRegular =
false;
268 hi_isSingleValued =
true;
274 if ( lo_isCovered && hi_isCovered) {
278 }
else if ( lo_isRegular && hi_isRegular) {
280 aux_flag(i,j,k).setRegular();
281 aux_flag(i,j,k).setConnected();
283 aux_vfrac(i,j,k) = 1.0;
285 aux_afrac_x(i,j,k) = 1.0;
286 aux_afrac_y(i,j,k) = 1.0;
287 aux_afrac_z(i,j,k) = 1.0;
289 if (i==bx.bigEnd(0)) {
290 aux_afrac_x(i+1,j,k) = 1.0;
292 if (j==bx.bigEnd(1)) {
293 aux_afrac_y(i,j+1,k) = 1.0;
295 if (k==bx.bigEnd(2)) {
296 aux_afrac_z(i,j,k+1) = 1.0;
301 #ifndef AMREX_USE_GPU
302 if (verbose) { Print() <<
"\ncell: " << amrex::IntVect(i,j,k) <<
"\n"; }
304 Array<Real,AMREX_SPACEDIM> lo_arr = {-0.5,-0.5,-0.5};
305 Array<Real,AMREX_SPACEDIM> hi_arr = { 0.5, 0.5, 0.5};
314 RealVect lo_point (bcent(iv_lo,0), bcent(iv_lo,1), bcent(iv_lo,2));
315 RealVect lo_normal(bnorm(iv_lo,0), bnorm(iv_lo,1), bnorm(iv_lo,2));
317 if (at_lo_boundary) {
318 lo_point[a_idim] += 1.0;
321 if (lo_isSingleValued ) {
322 Real bnorm_x = bnorm(iv_lo,0) * dx[0];
323 Real bnorm_y = bnorm(iv_lo,1) * dx[1];
324 Real bnorm_z = bnorm(iv_lo,2) * dx[2];
326 Real norm = sqrt( bnorm_x*bnorm_x + bnorm_y*bnorm_y + bnorm_z*bnorm_z);
328 RealVect bnorm_isoparam ( bnorm_x / norm, bnorm_y / norm, bnorm_z / norm);
330 lo_normal = bnorm_isoparam;
334 lo_arr[a_idim] = 0.0;
335 hi_arr[a_idim] = 0.5;
336 RealBox lo_rbx(lo_arr.data(), hi_arr.data());
338 eb_cut_cell_ lo_eb_cc(flag(iv_lo), lo_rbx, lo_point, lo_normal);
342 AMREX_ASSERT( !lo_isCovered || lo_eb_cc.isCovered() );
343 AMREX_ASSERT( !lo_isRegular || lo_eb_cc.isRegular() );
349 RealVect hi_point (bcent(iv_hi,0), bcent(iv_hi,1), bcent(iv_hi,2));
350 RealVect hi_normal(bnorm(iv_hi,0), bnorm(iv_hi,1), bnorm(iv_hi,2));
352 if (at_hi_boundary) {
353 hi_point[a_idim] += -1.0;
356 if (hi_isSingleValued ) {
357 Real bnorm_x = bnorm(iv_hi,0) * dx[0];
358 Real bnorm_y = bnorm(iv_hi,1) * dx[1];
359 Real bnorm_z = bnorm(iv_hi,2) * dx[2];
361 Real norm = sqrt( bnorm_x*bnorm_x + bnorm_y*bnorm_y + bnorm_z*bnorm_z);
363 RealVect bnorm_isoparam ( bnorm_x / norm, bnorm_y / norm, bnorm_z / norm);
365 hi_normal = bnorm_isoparam;
369 lo_arr[a_idim] = -0.5;
370 hi_arr[a_idim] = 0.0;
371 RealBox hi_rbx(lo_arr.data(), hi_arr.data());
373 eb_cut_cell_ hi_eb_cc(flag(iv_hi), hi_rbx, hi_point, hi_normal);
377 AMREX_ASSERT( !hi_isCovered || hi_eb_cc.isCovered() );
378 AMREX_ASSERT( !hi_isRegular || hi_eb_cc.isRegular() );
381 #if defined(AMREX_DEBUG) || defined(AMREX_TESTING) || 1
391 eb_cut_cell_ hi_hi_eb_cc(flag(iv_hi), lo_rbx, hi_point, hi_normal);
395 #ifndef AMREX_USE_GPU
396 if ( !(!hi_isRegular || hi_hi_eb_cc.isRegular()) ||
397 !(!hi_isCovered || hi_hi_eb_cc.isCovered()) ) {
398 Print() <<
"flag(iv_hi) and hi_hi_eb_cc flags do not agree\n"
399 <<
"\n isRegular() " << hi_isRegular <<
" " << hi_hi_eb_cc.isRegular()
400 <<
"\n isCovered() " << hi_isCovered <<
" " << hi_hi_eb_cc.isCovered()
406 AMREX_ALWAYS_ASSERT( !hi_isRegular || hi_hi_eb_cc.isRegular() );
407 AMREX_ALWAYS_ASSERT( !hi_isCovered || hi_hi_eb_cc.isCovered() );
414 if ( hi_isSingleValued ) {
416 Real const adx = (a_idim == 0)
417 ? (hi_eb_cc.areaLo(0) - hi_hi_eb_cc.areaHi(0)) * dx[1] * dx[2]
418 : (hi_eb_cc.areaLo(0) + hi_hi_eb_cc.areaLo(0)) * dx[1] * dx[2]
419 - (hi_eb_cc.areaHi(0) + hi_hi_eb_cc.areaHi(0)) * dx[1] * dx[2];
421 Real const ady = (a_idim == 1)
422 ? (hi_eb_cc.areaLo(1) - hi_hi_eb_cc.areaHi(1)) * dx[0] * dx[2]
423 : (hi_eb_cc.areaLo(1) + hi_hi_eb_cc.areaLo(1)) * dx[0] * dx[2]
424 - (hi_eb_cc.areaHi(1) + hi_hi_eb_cc.areaHi(1)) * dx[0] * dx[2];
426 Real const adz = (a_idim == 2)
427 ? (hi_eb_cc.areaLo(2) - hi_hi_eb_cc.areaHi(2)) * dx[0] * dx[1]
428 : (hi_eb_cc.areaLo(2) + hi_hi_eb_cc.areaLo(2)) * dx[0] * dx[1]
429 - (hi_eb_cc.areaHi(2) + hi_hi_eb_cc.areaHi(2)) * dx[0] * dx[1];
431 Real const apnorm = std::sqrt(adx*adx + ady*ady + adz*adz);
434 Real const apnorminv = 1. / apnorm;
435 RealVect
const normal(adx*apnorminv, ady*apnorminv, adz*apnorminv);
436 Real const dot_normals = normal.dotProduct(hi_normal);
438 #ifndef AMREX_USE_GPU
439 if ( !amrex::almostEqual(dot_normals, 1.0) ) {
440 Print() <<
"\nFail: check-1 dot_normals " << dot_normals
446 }
else if (verbose) {
447 Print() <<
"Pass: dot_normals = 1.0\n";
451 AMREX_ALWAYS_ASSERT( amrex::almostEqual(dot_normals, 1.0) );
456 #ifndef AMREX_USE_GPU
457 Real const abs_err = std::abs( hi_eb_cc.areaHi(a_idim) - hi_hi_eb_cc.areaLo(a_idim) );
459 if ( abs_err >= machine_tol ) {
460 Print() <<
"\nFail: check-2 area abs_err: " << abs_err
461 <<
"\n hi_eb_cc.areaHi " << hi_eb_cc.areaHi(a_idim)
462 <<
"\n hi_hi_eb_cc.areaLo " << hi_hi_eb_cc.areaLo(a_idim)
464 }
else if (verbose) {
465 Print() <<
"Pass: hi_eb_cc.areaHi = hi_hi_eb_cc.areaLo"
466 <<
" abs_err: " << abs_err <<
"\n";
468 AMREX_ALWAYS_ASSERT( abs_err < machine_tol );
473 {
Real const abs_err = amrex::max(std::abs(lo_eb_cc.areaHi(a_idim) - afrac(iv_hi)),
474 std::abs(hi_eb_cc.areaLo(a_idim) - afrac(iv_hi)));
475 Real compare_tol = 5.0e-6;
476 #ifndef AMREX_USE_GPU
477 if ( abs_err >= compare_tol ) {
479 Print() <<
"\nFail: check-3 area abs_err " << abs_err
480 <<
"\n hi_eb_cc.areaLo(" << a_idim <<
") = " << hi_eb_cc.areaLo(a_idim)
481 <<
"\n lo_eb_cc.areaHi(" << a_idim <<
") = " << lo_eb_cc.areaHi(a_idim)
482 <<
"\n afrac" << iv_hi <<
" = " << afrac(iv_hi)
484 }
else if (verbose) {
485 Print() <<
"Pass: hi_eb_cc.areaLo = afrac = " << afrac(iv_hi)
486 <<
" abs_err: " << abs_err <<
"\n";
489 AMREX_ALWAYS_ASSERT( abs_err < compare_tol );
494 {
Real const vol = hi_eb_cc.volume() + hi_hi_eb_cc.volume();
495 Real const abs_err = amrex::Math::abs(vfrac(iv_hi) - vol);
496 Real compare_tol = 5.0e-6;
497 #ifndef AMREX_USE_GPU
498 if ( abs_err >= compare_tol ) {
501 amrex::Print() <<
"\nFail: check-4 volume abs_err: " << abs_err
502 <<
"\n point: " << hi_point
503 <<
"\n normal: " << hi_normal
504 <<
"\n hi_eb_cc.volume() " << hi_eb_cc.volume()
505 <<
"\n hi_hi_eb_cc.volume() " << hi_hi_eb_cc.volume()
506 <<
"\n vfrac: " << vfrac(iv_hi)
508 }
else if (verbose) {
509 Print() <<
"Pass: hi_eb_cc + hi_hi_eb_cc = vfrac = " << vfrac(iv_hi)
510 <<
" abs_err: " << abs_err <<
"\n";
513 AMREX_ALWAYS_ASSERT( abs_err < compare_tol );
523 if (lo_eb_cc.isCovered() && hi_eb_cc.isCovered()) {
527 }
else if (lo_eb_cc.isRegular() && hi_eb_cc.isRegular()) {
529 aux_flag(i,j,k).setRegular();
530 aux_flag(i,j,k).setConnected();
532 aux_vfrac(i,j,k) = 1.0;
534 aux_afrac_x(i,j,k) = 1.0;
535 aux_afrac_y(i,j,k) = 1.0;
536 aux_afrac_z(i,j,k) = 1.0;
538 aux_fcent_x(i,j,k,0) = 0.0; aux_fcent_x(i,j,k,1) = 0.0;
539 aux_fcent_y(i,j,k,0) = 0.0; aux_fcent_y(i,j,k,1) = 0.0;
540 aux_fcent_z(i,j,k,0) = 0.0; aux_fcent_z(i,j,k,1) = 0.0;
542 if (i==bx.bigEnd(0)) {
543 aux_afrac_x(i+1,j,k) = 1.0;
544 aux_fcent_x(i+1,j,k,0) = 0.0; aux_fcent_x(i+1,j,k,1) = 0.0;
546 if (j==bx.bigEnd(1)) {
547 aux_afrac_y(i,j+1,k) = 1.0;
548 aux_fcent_y(i,j+1,k,0) = 0.0; aux_fcent_y(i,j+1,k,1) = 0.0;
550 if (k==bx.bigEnd(2)) {
551 aux_afrac_z(i,j,k+1) = 1.0;
552 aux_fcent_z(i,j,k+1,0) = 0.0; aux_fcent_z(i,j,k+1,1) = 0.0;
555 }
else if ( (lo_eb_cc.isRegular() && hi_eb_cc.isCovered())
556 || (lo_eb_cc.isCovered() && hi_eb_cc.isRegular()) ) {
559 #ifndef AMREX_USE_GPU
560 Print()<<
"eb_aux_ / Check: Regular and Covered cut cells are facing each other." << std::endl;
567 aux_flag(i,j,k).setSingleValued();
571 Real lo_vol {lo_eb_cc.volume()}; AMREX_ASSERT(lo_vol >= 0.0 && lo_vol <= 0.5);
572 Real hi_vol {hi_eb_cc.volume()}; AMREX_ASSERT(hi_vol >= 0.0 && hi_vol <= 0.5);
574 aux_vfrac(i,j,k) = lo_vol + hi_vol;
586 RealVect lo_vcent {lo_eb_cc.centVol()};
587 RealVect hi_vcent {hi_eb_cc.centVol()};
589 lo_vcent[a_idim] = lo_vcent[a_idim] - 0.5;
590 hi_vcent[a_idim] = hi_vcent[a_idim] + 0.5;
592 aux_vcent(i,j,k,0) = ( lo_vol * lo_vcent[0] + hi_vol * hi_vcent[0] ) / aux_vfrac(i,j,k);
593 aux_vcent(i,j,k,1) = ( lo_vol * lo_vcent[1] + hi_vol * hi_vcent[1] ) / aux_vfrac(i,j,k);
594 aux_vcent(i,j,k,2) = ( lo_vol * lo_vcent[2] + hi_vol * hi_vcent[2] ) / aux_vfrac(i,j,k);
598 Real lo_areaLo_x {lo_eb_cc.areaLo(0)};
599 Real lo_areaLo_y {lo_eb_cc.areaLo(1)};
600 Real lo_areaLo_z {lo_eb_cc.areaLo(2)};
602 Real hi_areaLo_x {hi_eb_cc.areaLo(0)};
603 Real hi_areaLo_y {hi_eb_cc.areaLo(1)};
604 Real hi_areaLo_z {hi_eb_cc.areaLo(2)};
606 aux_afrac_x(i,j,k) = (a_idim == 0) ? lo_areaLo_x : lo_areaLo_x + hi_areaLo_x;
607 aux_afrac_y(i,j,k) = (a_idim == 1) ? lo_areaLo_y : lo_areaLo_y + hi_areaLo_y;
608 aux_afrac_z(i,j,k) = (a_idim == 2) ? lo_areaLo_z : lo_areaLo_z + hi_areaLo_z;
610 if (i==bx.bigEnd(0)) {
611 Real lo_areaHi_x {lo_eb_cc.areaHi(0)};
612 Real hi_areaHi_x {hi_eb_cc.areaHi(0)};
613 aux_afrac_x(i+1,j,k) = (a_idim == 0) ? hi_areaHi_x : lo_areaHi_x + hi_areaHi_x;
615 if (j==bx.bigEnd(1)) {
616 Real lo_areaHi_y {lo_eb_cc.areaHi(1)};
617 Real hi_areaHi_y {hi_eb_cc.areaHi(1)};
618 aux_afrac_y(i,j+1,k) = (a_idim == 1) ? hi_areaHi_y : lo_areaHi_y + hi_areaHi_y;
620 if (k==bx.bigEnd(2)) {
621 Real lo_areaHi_z {lo_eb_cc.areaHi(2)};
622 Real hi_areaHi_z {hi_eb_cc.areaHi(2)};
623 aux_afrac_z(i,j,k+1) = (a_idim == 2) ? hi_areaHi_z : lo_areaHi_z + hi_areaHi_z;
636 RealVect lo_centLo_x {lo_eb_cc.centLo(0)};
637 RealVect lo_centLo_y {lo_eb_cc.centLo(1)};
638 RealVect lo_centLo_z {lo_eb_cc.centLo(2)};
640 RealVect hi_centLo_x {hi_eb_cc.centLo(0)};
641 RealVect hi_centLo_y {hi_eb_cc.centLo(1)};
642 RealVect hi_centLo_z {hi_eb_cc.centLo(2)};
645 aux_fcent_x(i,j,k,0) = lo_centLo_x[1];
646 aux_fcent_x(i,j,k,1) = lo_centLo_x[2];
647 aux_fcent_y(i,j,k,0) = (aux_afrac_y(i,j,k) > 0.0)
648 ? ( lo_areaLo_y * (lo_centLo_y[0] - 0.5)
649 + hi_areaLo_y * (hi_centLo_y[0] + 0.5) ) / aux_afrac_y(i,j,k)
651 aux_fcent_y(i,j,k,1) = (aux_afrac_y(i,j,k) > 0.0)
652 ? ( lo_areaLo_y * lo_centLo_y[2]
653 + hi_areaLo_y * hi_centLo_y[2] ) / aux_afrac_y(i,j,k)
655 aux_fcent_z(i,j,k,0) = (aux_afrac_z(i,j,k) > 0.0)
656 ? ( lo_areaLo_z * (lo_centLo_z[0] - 0.5)
657 + hi_areaLo_z * (hi_centLo_z[0] + 0.5) ) / aux_afrac_z(i,j,k)
659 aux_fcent_z(i,j,k,1) = (aux_afrac_z(i,j,k) > 0.0)
660 ? ( lo_areaLo_z * lo_centLo_z[1]
661 + hi_areaLo_z * hi_centLo_z[1] ) / aux_afrac_z(i,j,k)
663 }
else if (a_idim == 1) {
664 aux_fcent_x(i,j,k,0) = (aux_afrac_x(i,j,k) > 0.0)
665 ? ( lo_areaLo_x * (lo_centLo_x[1] - 0.5)
666 + hi_areaLo_x * (hi_centLo_x[1] + 0.5) ) / aux_afrac_x(i,j,k)
668 aux_fcent_x(i,j,k,1) = (aux_afrac_x(i,j,k) > 0.0)
669 ? ( lo_areaLo_x * lo_centLo_x[2]
670 + hi_areaLo_x * hi_centLo_x[2] ) / aux_afrac_x(i,j,k)
672 aux_fcent_y(i,j,k,0) = lo_centLo_y[0];
673 aux_fcent_y(i,j,k,1) = lo_centLo_y[2];
674 aux_fcent_z(i,j,k,0) = (aux_afrac_z(i,j,k) > 0.0)
675 ? ( lo_areaLo_z * lo_centLo_z[0]
676 + hi_areaLo_z * hi_centLo_z[0] ) / aux_afrac_z(i,j,k)
678 aux_fcent_z(i,j,k,1) = (aux_afrac_z(i,j,k) > 0.0)
679 ? ( lo_areaLo_z * (lo_centLo_z[1] - 0.5)
680 + hi_areaLo_z * (hi_centLo_z[1] + 0.5) ) / aux_afrac_z(i,j,k)
682 }
else if (a_idim == 2) {
683 aux_fcent_x(i,j,k,0) = (aux_afrac_x(i,j,k) > 0.0)
684 ? ( lo_areaLo_x * lo_centLo_x[1]
685 + hi_areaLo_x * hi_centLo_x[1] ) / aux_afrac_x(i,j,k)
687 aux_fcent_x(i,j,k,1) = (aux_afrac_x(i,j,k) > 0.0)
688 ? ( lo_areaLo_x * (lo_centLo_x[2] - 0.5)
689 + hi_areaLo_x * (hi_centLo_x[2] + 0.5) ) / aux_afrac_x(i,j,k)
691 aux_fcent_y(i,j,k,0) = (aux_afrac_y(i,j,k) > 0.0)
692 ? ( lo_areaLo_y * lo_centLo_y[0]
693 + hi_areaLo_y * hi_centLo_y[0] ) / aux_afrac_y(i,j,k)
695 aux_fcent_y(i,j,k,1) = (aux_afrac_y(i,j,k) > 0.0)
696 ? ( lo_areaLo_y * (lo_centLo_y[2] - 0.5)
697 + hi_areaLo_y * (hi_centLo_y[2] + 0.5) ) / aux_afrac_y(i,j,k)
699 aux_fcent_z(i,j,k,0) = lo_centLo_z[0];
700 aux_fcent_z(i,j,k,1) = lo_centLo_z[1];
703 if (i==bx.bigEnd(0)) {
704 Real lo_areaHi_x {lo_eb_cc.areaHi(0)};
705 Real hi_areaHi_x {hi_eb_cc.areaHi(0)};
706 RealVect lo_centHi_x {lo_eb_cc.centHi(0)};
707 RealVect hi_centHi_x {hi_eb_cc.centHi(0)};
709 aux_fcent_x(i+1,j,k,0) = hi_centHi_x[1];
710 aux_fcent_x(i+1,j,k,1) = hi_centHi_x[2];
711 }
else if (a_idim == 1) {
712 aux_fcent_x(i+1,j,k,0) = (aux_afrac_x(i+1,j,k) > 0.0)
713 ? ( lo_areaHi_x * (lo_centHi_x[1] - 0.5)
714 + hi_areaHi_x * (hi_centHi_x[1] + 0.5) ) / aux_afrac_x(i+1,j,k)
716 aux_fcent_x(i+1,j,k,1) = (aux_afrac_x(i+1,j,k) > 0.0)
717 ? ( lo_areaHi_x * lo_centHi_x[2]
718 + hi_areaHi_x * hi_centHi_x[2] ) / aux_afrac_x(i+1,j,k)
720 }
else if (a_idim == 2) {
721 aux_fcent_x(i+1,j,k,0) = (aux_afrac_x(i+1,j,k) > 0.0)
722 ? ( lo_areaHi_x * lo_centHi_x[1]
723 + hi_areaHi_x * hi_centHi_x[1] ) / aux_afrac_x(i+1,j,k)
725 aux_fcent_x(i+1,j,k,1) = (aux_afrac_x(i+1,j,k) > 0.0)
726 ? ( lo_areaHi_x * (lo_centHi_x[2] - 0.5)
727 + hi_areaHi_x * (hi_centHi_x[2] + 0.5) ) / aux_afrac_x(i+1,j,k)
731 if (j==bx.bigEnd(1)) {
732 Real lo_areaHi_y {lo_eb_cc.areaHi(1)};
733 Real hi_areaHi_y {hi_eb_cc.areaHi(1)};
734 RealVect lo_centHi_y {lo_eb_cc.centHi(1)};
735 RealVect hi_centHi_y {hi_eb_cc.centHi(1)};
737 aux_fcent_y(i,j+1,k,0) = (aux_afrac_y(i,j+1,k) > 0.0)
738 ? ( lo_areaHi_y * (lo_centHi_y[0] - 0.5)
739 + hi_areaHi_y * (hi_centHi_y[0] + 0.5) ) / aux_afrac_y(i,j+1,k)
741 aux_fcent_y(i,j+1,k,1) = (aux_afrac_y(i,j+1,k) > 0.0)
742 ? ( lo_areaHi_y * lo_centHi_y[2]
743 + hi_areaHi_y * hi_centHi_y[2] ) / aux_afrac_y(i,j+1,k)
745 }
else if (a_idim == 1) {
746 aux_fcent_y(i,j+1,k,0) = lo_centHi_y[0];
747 aux_fcent_y(i,j+1,k,1) = lo_centHi_y[2];
748 }
else if (a_idim == 2) {
749 aux_fcent_y(i,j+1,k,0) = (aux_afrac_y(i,j+1,k) > 0.0)
750 ? ( lo_areaHi_y * lo_centHi_y[0]
751 + hi_areaHi_y * hi_centHi_y[0] ) / aux_afrac_y(i,j+1,k)
753 aux_fcent_y(i,j+1,k,1) = (aux_afrac_y(i,j+1,k) > 0.0)
754 ? ( lo_areaHi_y * (lo_centHi_y[2] - 0.5)
755 + hi_areaHi_y * (hi_centHi_y[2] + 0.5) ) / aux_afrac_y(i,j+1,k)
759 if (k==bx.bigEnd(2)) {
760 Real lo_areaHi_z {lo_eb_cc.areaHi(2)};
761 Real hi_areaHi_z {hi_eb_cc.areaHi(2)};
762 RealVect lo_centHi_z {lo_eb_cc.centHi(2)};
763 RealVect hi_centHi_z {hi_eb_cc.centHi(2)};
765 aux_fcent_z(i,j,k+1,0) = (aux_afrac_z(i,j,k+1) > 0.0)
766 ? ( lo_areaHi_z * (lo_centHi_z[0] - 0.5)
767 + hi_areaHi_z * (hi_centHi_z[0] + 0.5) ) / aux_afrac_z(i,j,k+1)
769 aux_fcent_z(i,j,k+1,1) = (aux_afrac_z(i,j,k+1) > 0.0)
770 ? ( lo_areaHi_z * lo_centHi_z[1]
771 + hi_areaHi_z * hi_centHi_z[1] ) / aux_afrac_z(i,j,k+1)
773 }
else if (a_idim == 1) {
774 aux_fcent_z(i,j,k+1,0) = (aux_afrac_z(i,j,k+1) > 0.0)
775 ? ( lo_areaHi_z * lo_centHi_z[0]
776 + hi_areaHi_z * hi_centHi_z[0] ) / aux_afrac_z(i,j,k+1)
778 aux_fcent_z(i,j,k+1,1) = (aux_afrac_z(i,j,k+1) > 0.0)
779 ? ( lo_areaHi_z * (lo_centHi_z[1] - 0.5)
780 + hi_areaHi_z * (hi_centHi_z[1] + 0.5) ) / aux_afrac_z(i,j,k+1)
782 }
else if (a_idim == 2) {
783 aux_fcent_z(i,j,k+1,0) = lo_centHi_z[0];
784 aux_fcent_z(i,j,k+1,1) = lo_centHi_z[1];
790 Real lo_areaBoun {lo_eb_cc.areaBoun()};
791 Real hi_areaBoun {hi_eb_cc.areaBoun()};
793 aux_barea(i,j,k) = lo_areaBoun + hi_areaBoun;
797 RealVect lo_centBoun {lo_eb_cc.centBoun()};
798 RealVect hi_centBoun {hi_eb_cc.centBoun()};
801 aux_bcent(i,j,k,0) = ( lo_areaBoun * (lo_centBoun[0]-0.5) + hi_areaBoun * (hi_centBoun[0]+0.5) ) / aux_barea(i,j,k);
802 aux_bcent(i,j,k,1) = ( lo_areaBoun * lo_centBoun[1] + hi_areaBoun * hi_centBoun[1] ) / aux_barea(i,j,k);
803 aux_bcent(i,j,k,2) = ( lo_areaBoun * lo_centBoun[2] + hi_areaBoun * hi_centBoun[2] ) / aux_barea(i,j,k);
804 }
else if (a_idim == 1) {
805 aux_bcent(i,j,k,0) = ( lo_areaBoun * lo_centBoun[0] + hi_areaBoun * hi_centBoun[0] ) / aux_barea(i,j,k);
806 aux_bcent(i,j,k,1) = ( lo_areaBoun * (lo_centBoun[1]-0.5) + hi_areaBoun * (hi_centBoun[1]+0.5) ) / aux_barea(i,j,k);
807 aux_bcent(i,j,k,2) = ( lo_areaBoun * lo_centBoun[2] + hi_areaBoun * hi_centBoun[2] ) / aux_barea(i,j,k);
808 }
else if (a_idim == 2) {
809 aux_bcent(i,j,k,0) = ( lo_areaBoun * lo_centBoun[0] + hi_areaBoun * hi_centBoun[0] ) / aux_barea(i,j,k);
810 aux_bcent(i,j,k,1) = ( lo_areaBoun * lo_centBoun[1] + hi_areaBoun * hi_centBoun[1] ) / aux_barea(i,j,k);
811 aux_bcent(i,j,k,2) = ( lo_areaBoun * (lo_centBoun[2]-0.5) + hi_areaBoun * (hi_centBoun[2]+0.5) ) / aux_barea(i,j,k);
816 RealVect eb_normal = ( lo_areaBoun * lo_normal + hi_areaBoun * hi_normal )/ aux_barea(i,j,k);
818 aux_bnorm(i,j,k,0) = eb_normal[0];
819 aux_bnorm(i,j,k,1) = eb_normal[1];
820 aux_bnorm(i,j,k,2) = eb_normal[2];
828 ParallelFor(bx, [=] AMREX_GPU_DEVICE (
int i,
int j,
int k) noexcept
830 if (aux_vfrac(i,j,k) < small_volfrac)
832 aux_vfrac(i,j,k) = 0.0;
841 m_volfrac->FillBoundary(a_geom.periodicity());
843 for (MFIter mfi(*
m_cellflags,
false); mfi.isValid(); ++mfi) {
845 const Box& bx = mfi.validbox();
846 const Box& bx_grown = mfi.growntilebox();
848 Array4<EBCellFlag>
const& aux_flag =
m_cellflags->array(mfi);
849 Array4<Real>
const& aux_vfrac =
m_volfrac->array(mfi);
850 Array4<Real>
const& aux_afrac_x =
m_areafrac[0]->array(mfi);
851 Array4<Real>
const& aux_afrac_y =
m_areafrac[1]->array(mfi);
852 Array4<Real>
const& aux_afrac_z =
m_areafrac[2]->array(mfi);
854 Array4<Real>
const& aux_vcent =
m_volcent->array(mfi);
855 Array4<Real>
const& aux_fcent_x =
m_facecent[0]->array(mfi);
856 Array4<Real>
const& aux_fcent_y =
m_facecent[1]->array(mfi);
857 Array4<Real>
const& aux_fcent_z =
m_facecent[2]->array(mfi);
858 Array4<Real>
const& aux_barea =
m_bndryarea->array(mfi);
859 Array4<Real>
const& aux_bcent =
m_bndrycent->array(mfi);
860 Array4<Real>
const& aux_bnorm =
m_bndrynorm->array(mfi);
862 if (FlagFab[mfi].getType(bx) == FabType::singlevalued ) {
865 Box my_xbx(bx);
if (a_idim == 0) my_xbx.growLo(0,1);
866 ParallelFor(my_xbx, [=] AMREX_GPU_DEVICE (
int i,
int j,
int k) noexcept
868 if (aux_vfrac(i,j,k) < small_volfrac) {
869 aux_afrac_x(i ,j ,k ) = 0.0;
870 aux_afrac_x(i+1,j ,k ) = 0.0;
874 Box my_ybx(bx);
if (a_idim == 1) my_ybx.growLo(1,1);
875 ParallelFor(my_ybx, [=] AMREX_GPU_DEVICE (
int i,
int j,
int k) noexcept
877 if (aux_vfrac(i,j,k) < small_volfrac) {
878 aux_afrac_y(i ,j ,k ) = 0.0;
879 aux_afrac_y(i ,j+1,k ) = 0.0;
883 Box my_zbx(bx);
if (a_idim == 2) my_zbx.growLo(2,1);
884 ParallelFor(my_zbx, [=] AMREX_GPU_DEVICE (
int i,
int j,
int k) noexcept
886 if (aux_vfrac(i,j,k) < small_volfrac) {
887 aux_afrac_z(i ,j ,k+1) = 0.0;
888 aux_afrac_z(i ,j ,k ) = 0.0;
892 ParallelFor(bx, [=] AMREX_GPU_DEVICE (
int i,
int j,
int k) noexcept
894 if (aux_vfrac(i,j,k) < small_volfrac)
896 aux_vcent(i,j,k,0) = 0.0;
897 aux_vcent(i,j,k,1) = 0.0;
898 aux_vcent(i,j,k,2) = 0.0;
900 aux_fcent_x(i ,j ,k ,0) = 0.0;
901 aux_fcent_x(i ,j ,k ,1) = 0.0;
902 aux_fcent_x(i+1,j ,k ,0) = 0.0;
903 aux_fcent_x(i+1,j ,k ,1) = 0.0;
905 aux_fcent_y(i ,j ,k ,0) = 0.0;
906 aux_fcent_y(i ,j ,k ,1) = 0.0;
907 aux_fcent_y(i ,j+1,k ,0) = 0.0;
908 aux_fcent_y(i ,j+1,k ,1) = 0.0;
910 aux_fcent_z(i ,j ,k ,0) = 0.0;
911 aux_fcent_z(i ,j ,k ,1) = 0.0;
912 aux_fcent_z(i ,j ,k+1,0) = 0.0;
913 aux_fcent_z(i ,j ,k+1,1) = 0.0;
915 aux_barea(i,j,k) = 0.0;
917 aux_bcent(i,j,k,0) = 0.0;
918 aux_bcent(i,j,k,1) = 0.0;
919 aux_bcent(i,j,k,2) = 0.0;
921 aux_bnorm(i,j,k,0) = 0.0;
922 aux_bnorm(i,j,k,1) = 0.0;
923 aux_bnorm(i,j,k,2) = 0.0;
925 aux_flag(i,j,k).setCovered();
928 if (std::abs(aux_vcent(i,j,k,0)) < small_value) aux_vcent(i,j,k,0) = 0.0;
929 if (std::abs(aux_vcent(i,j,k,1)) < small_value) aux_vcent(i,j,k,1) = 0.0;
930 if (std::abs(aux_vcent(i,j,k,2)) < small_value) aux_vcent(i,j,k,2) = 0.0;
931 if (std::abs(aux_bcent(i,j,k,0)) < small_value) aux_bcent(i,j,k,0) = 0.0;
932 if (std::abs(aux_bcent(i,j,k,1)) < small_value) aux_bcent(i,j,k,1) = 0.0;
933 if (std::abs(aux_bcent(i,j,k,2)) < small_value) aux_bcent(i,j,k,2) = 0.0;
942 Box upper_slab = makeSlab(bx_grown, a_idim, bx.bigEnd(a_idim)+1);
943 Box bx_grown_1 = bx; bx_grown_1.grow(a_idim,1);
944 BoxList slab_diffList = boxDiff(upper_slab, bx_grown_1);
946 for (
const Box& b : slab_diffList) {
947 ParallelFor(b, [=] AMREX_GPU_DEVICE (
int i,
int j,
int k) noexcept
949 IntVect iv(AMREX_D_DECL(i,j,k));
950 IntVect iv_nearest = iv;
951 for (
int d=0; d<AMREX_SPACEDIM; ++d) {
952 iv_nearest[d] = Clamp(iv[d], bx_grown_1.smallEnd(d), bx_grown_1.bigEnd(d));
954 aux_afrac_x(iv) = aux_afrac_x(iv_nearest);
967 m_volcent->FillBoundary(a_geom.periodicity());
968 for (
int idim = 0; idim < AMREX_SPACEDIM; ++idim) {
969 m_areafrac[idim]->FillBoundary(a_geom.periodicity());
970 m_facecent[idim]->FillBoundary(a_geom.periodicity());
977 for (MFIter mfi(*
m_cellflags,
false); mfi.isValid(); ++mfi) {
979 const Box& bx = mfi.validbox();
980 const Box domain = surroundingNodes(a_geom.Domain(), a_idim);
982 if (FlagFab[mfi].getType(bx) == FabType::singlevalued ) {
984 Array4<EBCellFlag>
const& aux_flag =
m_cellflags->array(mfi);
985 Array4<Real>
const& aux_afrac_x =
m_areafrac[0]->array(mfi);
986 Array4<Real>
const& aux_afrac_y =
m_areafrac[1]->array(mfi);
987 Array4<Real>
const& aux_afrac_z =
m_areafrac[2]->array(mfi);
989 ParallelFor(bx, [=] AMREX_GPU_DEVICE (
int i,
int j,
int k) noexcept
991 EB2::build_cellflag_from_ap (i, j, k, aux_flag, aux_afrac_x, aux_afrac_y, aux_afrac_z);
996 bool l_periodic_x = a_geom.isPeriodic(0);
997 bool l_periodic_y = a_geom.isPeriodic(1);
998 bool l_periodic_z = a_geom.isPeriodic(2);
1000 if (!l_periodic_x) {
1001 const Box dom_grown = grow(grow(domain,1,1),2,1);
1002 const Box bx_grown = grow(grow( bx,1,1),2,1);
1003 const Box bx_face_x_lo = bx_grown & makeSlab(dom_grown,0,domain.smallEnd(0));
1004 const Box bx_face_x_hi = bx_grown & makeSlab(dom_grown,0,domain.bigEnd(0));
1006 ParallelFor(bx_face_x_lo, [=] AMREX_GPU_DEVICE (
int i,
int j,
int k) noexcept
1008 for(
int kk(-1); kk<=1; kk++) {
1009 for(
int jj(-1); jj<=1; jj++) {
1010 aux_flag(i,j,k).setDisconnected(-1,jj,kk);
1013 ParallelFor(bx_face_x_hi, [=] AMREX_GPU_DEVICE (
int i,
int j,
int k) noexcept
1015 for(
int kk(-1); kk<=1; kk++) {
1016 for(
int jj(-1); jj<=1; jj++) {
1017 aux_flag(i,j,k).setDisconnected( 1,jj,kk);
1022 if (!l_periodic_y) {
1023 const Box dom_grown = grow(grow(domain,0,1),2,1);
1024 const Box bx_grown = grow(grow( bx,0,1),2,1);
1025 const Box bx_face_y_lo = bx_grown & makeSlab(dom_grown,1,domain.smallEnd(1));
1026 const Box bx_face_y_hi = bx_grown & makeSlab(dom_grown,1,domain.bigEnd(1));
1028 ParallelFor(bx_face_y_lo, [=] AMREX_GPU_DEVICE (
int i,
int j,
int k) noexcept
1030 for(
int kk(-1); kk<=1; kk++) {
1031 for(
int ii(-1); ii<=1; ii++) {
1032 aux_flag(i,j,k).setDisconnected(ii,-1,kk);
1035 ParallelFor(bx_face_y_hi, [=] AMREX_GPU_DEVICE (
int i,
int j,
int k) noexcept
1037 for(
int kk(-1); kk<=1; kk++) {
1038 for(
int ii(-1); ii<=1; ii++) {
1039 aux_flag(i,j,k).setDisconnected(ii, 1,kk);
1044 if (!l_periodic_z) {
1045 const Box dom_grown = grow(grow(domain,0,1),1,1);
1046 const Box bx_grown = grow(grow( bx,0,1),1,1);
1047 const Box bx_face_z_lo = bx_grown & makeSlab(dom_grown,2,domain.smallEnd(2));
1048 const Box bx_face_z_hi = bx_grown & makeSlab(dom_grown,2,domain.bigEnd(2));
1050 ParallelFor(bx_face_z_lo, [=] AMREX_GPU_DEVICE (
int i,
int j,
int k) noexcept
1052 for(
int jj(-1); jj<=1; jj++) {
1053 for(
int ii(-1); ii<=1; ii++) {
1054 aux_flag(i,j,k).setDisconnected(ii,jj,-1);
1057 ParallelFor(bx_face_z_hi, [=] AMREX_GPU_DEVICE (
int i,
int j,
int k) noexcept
1059 for(
int jj(-1); jj<=1; jj++) {
1060 for(
int ii(-1); ii<=1; ii++) {
1061 aux_flag(i,j,k).setDisconnected(ii,jj, 1);
1073 for (MFIter mfi(*
m_cellflags,
false); mfi.isValid(); ++mfi) {
1075 const Box& bx = mfi.validbox();
1076 const Box gbx = amrex::grow(bx,
m_cellflags->nGrow()-1);
1078 Array4<EBCellFlag>
const& aux_flag =
m_cellflags->array(mfi);
1079 Array4<Real>
const& aux_vfrac =
m_volfrac->array(mfi);
1081 ParallelFor(gbx, [=] AMREX_GPU_DEVICE (
int i,
int j,
int k) noexcept
1083 for(
int kk(-1); kk<=1; kk++) {
1084 for(
int jj(-1); jj<=1; jj++) {
1085 for(
int ii(-1); ii<=1; ii++)
1087 if (aux_vfrac(i+ii,j+jj,k+kk) == 0.0) {
1088 aux_flag(i,j,k).setDisconnected(ii,jj,kk);
1093 ParallelFor(gbx, [=] AMREX_GPU_DEVICE (
int i,
int j,
int k) noexcept
1095 if (aux_vfrac(i,j,k)==0.0) {
1096 aux_flag(i,j,k).setCovered();
AMREX_GPU_HOST_DEVICE AMREX_FORCE_INLINE amrex::Real pp(amrex::Real y)
Definition: ERF_MicrophysicsUtils.H:233
amrex::Real Real
Definition: ERF_ShocInterface.H:19
amrex::FabArray< amrex::EBCellFlagFab > * m_cellflags
Definition: ERF_EBAux.H:44
amrex::MultiFab * m_bndrynorm
Definition: ERF_EBAux.H:49
amrex::MultiFab * m_bndryarea
Definition: ERF_EBAux.H:47
amrex::MultiFab * m_volfrac
Definition: ERF_EBAux.H:45
amrex::MultiFab * m_bndrycent
Definition: ERF_EBAux.H:48
amrex::Array< amrex::MultiFab *, AMREX_SPACEDIM > m_facecent
Definition: ERF_EBAux.H:52
amrex::MultiFab * m_volcent
Definition: ERF_EBAux.H:46
amrex::Array< amrex::MultiFab *, AMREX_SPACEDIM > m_areafrac
Definition: ERF_EBAux.H:51
Definition: ERF_EBCutCell.H:14
real(c_double), parameter epsilon
Definition: ERF_module_model_constants.F90:12