Skip to content

Commit

Permalink
remove some deprecated AMReX constants / macros
Browse files Browse the repository at this point in the history
  • Loading branch information
zingale committed Jan 21, 2024
1 parent 931bec9 commit 994078a
Show file tree
Hide file tree
Showing 15 changed files with 118 additions and 118 deletions.
16 changes: 8 additions & 8 deletions Source/driver/Castro.cpp
Original file line number Diff line number Diff line change
Expand Up @@ -245,14 +245,14 @@ Castro::read_params ()
{
if (dgeom.isPeriodic(dir))
{
if (lo_bc[dir] != Interior)
if (lo_bc[dir] != amrex::PhysBCType::interior)
{
std::cerr << "Castro::read_params:periodic in direction "
<< dir
<< " but low BC is not Interior\n";
amrex::Error();
}
if (hi_bc[dir] != Interior)
if (hi_bc[dir] != amrex::PhysBCType::interior)
{
std::cerr << "Castro::read_params:periodic in direction "
<< dir
Expand All @@ -269,14 +269,14 @@ Castro::read_params ()
//
for (int dir=0; dir<AMREX_SPACEDIM; dir++)
{
if (lo_bc[dir] == Interior)
if (lo_bc[dir] == amrex::PhysBCType::interior)
{
std::cerr << "Castro::read_params:interior bc in direction "
<< dir
<< " but not periodic\n";
amrex::Error();
}
if (hi_bc[dir] == Interior)
if (hi_bc[dir] == amrex::PhysBCType::interior)
{
std::cerr << "Castro::read_params:interior bc in direction "
<< dir
Expand All @@ -286,15 +286,15 @@ Castro::read_params ()
}
}

if ( dgeom.IsRZ() && (lo_bc[0] != Symmetry) ) {
if ( dgeom.IsRZ() && (lo_bc[0] != amrex::PhysBCType::symmetry) ) {
std::cerr << "ERROR:Castro::read_params: must set r=0 boundary condition to Symmetry for r-z\n";
amrex::Error();
}

#if (AMREX_SPACEDIM == 1)
if ( dgeom.IsSPHERICAL() )
{
if ( (lo_bc[0] != Symmetry) && (dgeom.ProbLo(0) == 0.0) )
if ( (lo_bc[0] != amrex::PhysBCType::symmetry) && (dgeom.ProbLo(0) == 0.0) )
{
std::cerr << "ERROR:Castro::read_params: must set r=0 boundary condition to Symmetry for spherical\n";
amrex::Error();
Expand Down Expand Up @@ -3551,12 +3551,12 @@ Castro::apply_tagging_restrictions(TagBoxArray& tags, [[maybe_unused]] Real time

int boundary_buf = n_error_buf[dim] + blocking_factor[dim] / ref_ratio[dim];

if ((physbc_lo[dim] != Symmetry && physbc_lo[dim] != Interior) &&
if ((physbc_lo[dim] != amrex::PhysBCType::symmetry && physbc_lo[dim] != amrex::PhysBCType::interior) &&
(idx[dim] <= domlo[dim] + boundary_buf)) {
outer_boundary_test[dim] = true;
}

if ((physbc_hi[dim] != Symmetry && physbc_lo[dim] != Interior) &&
if ((physbc_hi[dim] != amrex::PhysBCType::symmetry && physbc_lo[dim] != amrex::PhysBCType::interior) &&
(idx[dim] >= domhi[dim] - boundary_buf)) {
outer_boundary_test[dim] = true;
}
Expand Down
16 changes: 8 additions & 8 deletions Source/driver/Castro_setup.cpp
Original file line number Diff line number Diff line change
Expand Up @@ -31,23 +31,23 @@ typedef StateDescriptor::BndryFunc BndryFunc;
//
static int scalar_bc[] =
{
INT_DIR, EXT_DIR, FOEXTRAP, REFLECT_EVEN, REFLECT_EVEN, REFLECT_EVEN
amrex::BCType::int_dir, amrex::BCType::ext_dir, amrex::BCType::foextrap, amrex::BCType::reflect_even, amrex::BCType::reflect_even, amrex::BCType::reflect_even
};

static int norm_vel_bc[] =
{
INT_DIR, EXT_DIR, FOEXTRAP, REFLECT_ODD, REFLECT_ODD, REFLECT_ODD
amrex::BCType::int_dir, amrex::BCType::ext_dir, amrex::BCType::foextrap, amrex::BCType::reflect_odd, amrex::BCType::reflect_odd, amrex::BCType::reflect_odd
};

static int tang_vel_bc[] =
{
INT_DIR, EXT_DIR, FOEXTRAP, REFLECT_EVEN, REFLECT_EVEN, REFLECT_EVEN
amrex::BCType::int_dir, amrex::BCType::ext_dir, amrex::BCType::foextrap, amrex::BCType::reflect_even, amrex::BCType::reflect_even, amrex::BCType::reflect_even
};

#ifdef MHD
static int mag_field_bc[] =
{
INT_DIR, EXT_DIR, FOEXTRAP, REFLECT_EVEN, FOEXTRAP, HOEXTRAP
amrex::BCType::int_dir, amrex::BCType::ext_dir, amrex::BCType::foextrap, amrex::BCType::reflect_even, amrex::BCType::foextrap, HOEXTRAP
};
#endif

Expand Down Expand Up @@ -146,11 +146,11 @@ void
replace_inflow_bc (BCRec& bc)
{
for (int dir = 0; dir < AMREX_SPACEDIM; ++dir) {
if (bc.lo(dir) == EXT_DIR) {
bc.setLo(dir, FOEXTRAP);
if (bc.lo(dir) == amrex::BCType::ext_dir) {
bc.setLo(dir, amrex::BCType::foextrap);
}
if (bc.hi(dir) == EXT_DIR) {
bc.setHi(dir, FOEXTRAP);
if (bc.hi(dir) == amrex::BCType::ext_dir) {
bc.setHi(dir, amrex::BCType::foextrap);
}
}
}
Expand Down
2 changes: 1 addition & 1 deletion Source/driver/MGutils.cpp
Original file line number Diff line number Diff line change
Expand Up @@ -20,7 +20,7 @@ apply_metric(const Box& bx,
[=] AMREX_GPU_DEVICE (int i, int j, int k) noexcept
{

IntVect idx(D_DECL(i, j, k));
IntVect idx(AMREX_D_DECL(i, j, k));

// at centers
if (rbx.contains(idx)) {
Expand Down
12 changes: 6 additions & 6 deletions Source/driver/timestep.cpp
Original file line number Diff line number Diff line change
Expand Up @@ -46,7 +46,7 @@ Castro::estdt_cfl (int is_new)

Array4<Real const> const& u = ua[box_no];

IntVect idx(D_DECL(i,j,k));
IntVect idx(AMREX_D_DECL(i,j,k));

Real rhoInv = 1.0_rt / u(i,j,k,URHO);

Expand Down Expand Up @@ -150,7 +150,7 @@ Castro::estdt_mhd (int is_new)
Array4<Real const> const& by_arr = bya[box_no];
Array4<Real const> const& bz_arr = bza[box_no];

IntVect idx(D_DECL(i,j,k));
IntVect idx(AMREX_D_DECL(i,j,k));

Real rhoInv = 1.0_rt / u_arr(i,j,k,URHO);
Real bcx = 0.5_rt * (bx_arr(i+1,j,k) + bx_arr(i,j,k));
Expand Down Expand Up @@ -253,7 +253,7 @@ Castro::estdt_temp_diffusion (int is_new)

Array4<Real const> const& ustate = ua[box_no];

IntVect idx(D_DECL(i,j,k));
IntVect idx(AMREX_D_DECL(i,j,k));

if (ustate(i,j,k,URHO) > ldiffuse_cutoff_density) {

Expand Down Expand Up @@ -315,7 +315,7 @@ Castro::estdt_burning (int is_new)
{

if (castro::dtnuc_e > 1.e199_rt && castro::dtnuc_X > 1.e199_rt) {
IntVect idx(D_DECL(0,0,0));
IntVect idx(AMREX_D_DECL(0,0,0));
return {ValLocPair<Real, IntVect>{1.e200_rt, idx}};
}

Expand All @@ -331,7 +331,7 @@ Castro::estdt_burning (int is_new)

Array4<Real const> const& S = ua[box_no];

IntVect idx(D_DECL(i,j,k));
IntVect idx(AMREX_D_DECL(i,j,k));

// Set a floor on the minimum size of a derivative. This floor
// is small enough such that it will result in no timestep limiting.
Expand Down Expand Up @@ -368,7 +368,7 @@ Castro::estdt_burning (int is_new)
#if AMREX_SPACEDIM == 1
burn_state.dx = dx[0];
#else
burn_state.dx = amrex::min(D_DECL(dx[0], dx[1], dx[2]));
burn_state.dx = amrex::min(AMREX_D_DECL(dx[0], dx[1], dx[2]));
#endif

burn_state.rho = S(i,j,k,URHO);
Expand Down
22 changes: 11 additions & 11 deletions Source/gravity/Gravity.cpp
Original file line number Diff line number Diff line change
Expand Up @@ -1655,7 +1655,7 @@ Gravity::init_multipole_grav()

for (int b = 0; b < AMREX_SPACEDIM; ++b) {

if ((lo_bc[b] == Symmetry) && (parent->Geom(0).Coord() == 0)) {
if ((lo_bc[b] == amrex::PhysBCType::symmetry) && (parent->Geom(0).Coord() == 0)) {
if (std::abs(problem::center[b] - problo[b]) < edgeTolerance) {
multipole::volumeFactor *= 2.0_rt;
multipole::doReflectionLo(b) = true;
Expand All @@ -1666,7 +1666,7 @@ Gravity::init_multipole_grav()
}
}

if ((hi_bc[b] == Symmetry) && (parent->Geom(0).Coord() == 0)) {
if ((hi_bc[b] == amrex::PhysBCType::symmetry) && (parent->Geom(0).Coord() == 0)) {
if (std::abs(problem::center[b] - probhi[b]) < edgeTolerance) {
multipole::volumeFactor *= 2.0_rt;
multipole::doReflectionHi(b) = true;
Expand Down Expand Up @@ -1800,9 +1800,9 @@ Gravity::fill_multipole_BCs(int crse_level, int fine_level, const Vector<MultiFa
// domain in 2D, since we can only have one
// radial index for calculating the multipole moments.

Box boxq0( IntVect(D_DECL(0, 0, 0)), IntVect(D_DECL(gravity::lnum, 0, npts-1)) );
Box boxqC( IntVect(D_DECL(0, 0, 0)), IntVect(D_DECL(gravity::lnum, gravity::lnum, npts-1)) );
Box boxqS( IntVect(D_DECL(0, 0, 0)), IntVect(D_DECL(gravity::lnum, gravity::lnum, npts-1)) );
Box boxq0( IntVect(AMREX_D_DECL(0, 0, 0)), IntVect(AMREX_D_DECL(gravity::lnum, 0, npts-1)) );
Box boxqC( IntVect(AMREX_D_DECL(0, 0, 0)), IntVect(AMREX_D_DECL(gravity::lnum, gravity::lnum, npts-1)) );
Box boxqS( IntVect(AMREX_D_DECL(0, 0, 0)), IntVect(AMREX_D_DECL(gravity::lnum, gravity::lnum, npts-1)) );

FArrayBox qL0(boxq0);
FArrayBox qLC(boxqC);
Expand Down Expand Up @@ -2483,12 +2483,12 @@ Gravity::fill_direct_sum_BCs(int crse_level, int fine_level, const Vector<MultiF
bool doSymmetricAdd {false};

for (int b = 0; b < 3; ++b) {
if (physbc_lo[b] == Symmetry) {
if (physbc_lo[b] == amrex::PhysBCType::symmetry) {
doSymmetricAddLo[b] = true;
doSymmetricAdd = true;
}

if (physbc_hi[b] == Symmetry) {
if (physbc_hi[b] == amrex::PhysBCType::symmetry) {
doSymmetricAddHi[b] = true;
doSymmetricAdd = true;
}
Expand Down Expand Up @@ -2930,12 +2930,12 @@ Gravity::make_mg_bc ()
mlmg_lobc[idim] = MLLinOp::BCType::Periodic;
mlmg_hibc[idim] = MLLinOp::BCType::Periodic;
} else {
if (phys_bc->lo(idim) == Symmetry) {
if (phys_bc->lo(idim) == amrex::PhysBCType::symmetry) {
mlmg_lobc[idim] = MLLinOp::BCType::Neumann;
} else {
mlmg_lobc[idim] = MLLinOp::BCType::Dirichlet;
}
if (phys_bc->hi(idim) == Symmetry) {
if (phys_bc->hi(idim) == amrex::PhysBCType::symmetry) {
mlmg_hibc[idim] = MLLinOp::BCType::Neumann;
} else {
mlmg_hibc[idim] = MLLinOp::BCType::Dirichlet;
Expand Down Expand Up @@ -3524,10 +3524,10 @@ Gravity::sanity_check (int level)
{
if (!geom.isPeriodic(dir))
{
if (phys_bc->lo(dir) != Symmetry) {
if (phys_bc->lo(dir) != amrex::PhysBCType::symmetry) {
shrunk_domain.growLo(dir,-1);
}
if (phys_bc->hi(dir) != Symmetry) {
if (phys_bc->hi(dir) != amrex::PhysBCType::symmetry) {
shrunk_domain.growHi(dir,-1);
}
}
Expand Down
4 changes: 2 additions & 2 deletions Source/hydro/Castro_mol.cpp
Original file line number Diff line number Diff line change
Expand Up @@ -29,8 +29,8 @@ Castro::mol_plm_reconstruct(const Box& bx,
const int* lo_bc = phys_bc.lo();
const int* hi_bc = phys_bc.hi();

bool lo_symm = lo_bc[idir] == Symmetry;
bool hi_symm = hi_bc[idir] == Symmetry;
bool lo_symm = lo_bc[idir] == amrex::PhysBCType::symmetry;
bool hi_symm = hi_bc[idir] == amrex::PhysBCType::symmetry;

const auto domlo = geom.Domain().loVect3d();
const auto domhi = geom.Domain().hiVect3d();
Expand Down
4 changes: 2 additions & 2 deletions Source/hydro/advection_util.cpp
Original file line number Diff line number Diff line change
Expand Up @@ -694,8 +694,8 @@ Castro::enforce_reflect_states(const Box& bx, const int idir,
const auto domlo = geom.Domain().loVect3d();
const auto domhi = geom.Domain().hiVect3d();

bool lo_bc_test = lo_bc[idir] == Symmetry;
bool hi_bc_test = hi_bc[idir] == Symmetry;
bool lo_bc_test = lo_bc[idir] == amrex::PhysBCType::symmetry;
bool hi_bc_test = hi_bc[idir] == amrex::PhysBCType::symmetry;

// normal velocity
const int QUN = QU + idir;
Expand Down
12 changes: 6 additions & 6 deletions Source/hydro/riemann.cpp
Original file line number Diff line number Diff line change
Expand Up @@ -51,12 +51,12 @@ Castro::cmpflx_plus_godunov(const Box& bx,
const int* hi_bc = phys_bc.hi();

// do we want to force the flux to zero at the boundary?
const bool special_bnd_lo = (lo_bc[idir] == Symmetry ||
lo_bc[idir] == SlipWall ||
lo_bc[idir] == NoSlipWall);
const bool special_bnd_hi = (hi_bc[idir] == Symmetry ||
hi_bc[idir] == SlipWall ||
hi_bc[idir] == NoSlipWall);
const bool special_bnd_lo = (lo_bc[idir] == amrex::PhysBCType::symmetry ||
lo_bc[idir] == amrex::PhysBCType::slipwall ||
lo_bc[idir] == amrex::PhysBCType::noslipwall);
const bool special_bnd_hi = (hi_bc[idir] == amrex::PhysBCType::symmetry ||
hi_bc[idir] == amrex::PhysBCType::slipwall ||
hi_bc[idir] == amrex::PhysBCType::noslipwall);

auto coord = geom.Coord();

Expand Down
4 changes: 2 additions & 2 deletions Source/hydro/trace_plm.cpp
Original file line number Diff line number Diff line change
Expand Up @@ -37,8 +37,8 @@ Castro::trace_plm(const Box& bx, const int idir,
const int* lo_bc = phys_bc.lo();
const int* hi_bc = phys_bc.hi();

bool lo_symm = lo_bc[idir] == Symmetry;
bool hi_symm = hi_bc[idir] == Symmetry;
bool lo_symm = lo_bc[idir] == amrex::PhysBCType::symmetry;
bool hi_symm = hi_bc[idir] == amrex::PhysBCType::symmetry;

const auto domlo = geom.Domain().loVect3d();
const auto domhi = geom.Domain().hiVect3d();
Expand Down
2 changes: 1 addition & 1 deletion Source/particles/CastroParticles.cpp
Original file line number Diff line number Diff line change
Expand Up @@ -137,7 +137,7 @@ Castro::ParticleDerive(const std::string& name,
//
auto derive_dat = ParticleDerive("particle_count",time,ngrow);

IntVect trr(D_DECL(1,1,1));
IntVect trr(AMREX_D_DECL(1,1,1));

for (int lev = level+1; lev <= parent->finestLevel(); lev++)
{
Expand Down
64 changes: 32 additions & 32 deletions Source/problems/Castro_bc_fill_nd.cpp
Original file line number Diff line number Diff line change
Expand Up @@ -25,11 +25,11 @@ void ca_statefill(Box const& bx, FArrayBox& data,
Vector<BCRec> bcr_noinflow{bcr};
for (auto & bc : bcr_noinflow) {
for (int dir = 0; dir < AMREX_SPACEDIM; ++dir) {
if (bc.lo(dir) == EXT_DIR) {
bc.setLo(dir, FOEXTRAP);
if (bc.lo(dir) == amrex::BCType::ext_dir) {
bc.setLo(dir, amrex::BCType::foextrap);
}
if (bc.hi(dir) == EXT_DIR) {
bc.setHi(dir, FOEXTRAP);
if (bc.hi(dir) == amrex::BCType::ext_dir) {
bc.setHi(dir, amrex::BCType::foextrap);
}
}
}
Expand Down Expand Up @@ -62,39 +62,39 @@ void ca_statefill(Box const& bx, FArrayBox& data,
// corners.

#if AMREX_SPACEDIM == 2
if ((bcr[URHO].lo(0) == EXT_DIR && bcr[URHO].lo(1) == EXT_DIR) ||
(bcr[URHO].lo(0) == EXT_DIR && bcr[URHO].hi(1) == EXT_DIR) ||
(bcr[URHO].hi(0) == EXT_DIR && bcr[URHO].lo(1) == EXT_DIR) ||
(bcr[URHO].hi(0) == EXT_DIR && bcr[URHO].hi(1) == EXT_DIR)) {
if ((bcr[URHO].lo(0) == amrex::BCType::ext_dir && bcr[URHO].lo(1) == amrex::BCType::ext_dir) ||
(bcr[URHO].lo(0) == amrex::BCType::ext_dir && bcr[URHO].hi(1) == amrex::BCType::ext_dir) ||
(bcr[URHO].hi(0) == amrex::BCType::ext_dir && bcr[URHO].lo(1) == amrex::BCType::ext_dir) ||
(bcr[URHO].hi(0) == amrex::BCType::ext_dir && bcr[URHO].hi(1) == amrex::BCType::ext_dir)) {
amrex::Error("Error: external boundaries meeting at a corner not supported");
}
#endif

#if AMREX_SPACEDIM == 3
if ((bcr[URHO].lo(0) == EXT_DIR && // xl, yl, zl corner
(bcr[URHO].lo(1) == EXT_DIR || bcr[URHO].lo(2) == EXT_DIR)) ||
(bcr[URHO].lo(1) == EXT_DIR && bcr[URHO].lo(2) == EXT_DIR) ||
(bcr[URHO].lo(0) == EXT_DIR && // xl, yr, zl corner
(bcr[URHO].hi(1) == EXT_DIR || bcr[URHO].lo(2) == EXT_DIR)) ||
(bcr[URHO].hi(1) == EXT_DIR && bcr[URHO].lo(2) == EXT_DIR) ||
(bcr[URHO].lo(0) == EXT_DIR && // xl, yl, zr corner
(bcr[URHO].lo(1) == EXT_DIR || bcr[URHO].hi(2) == EXT_DIR)) ||
(bcr[URHO].lo(1) == EXT_DIR && bcr[URHO].hi(2) == EXT_DIR) ||
(bcr[URHO].lo(0) == EXT_DIR && // xl, yr, zr corner
(bcr[URHO].hi(1) == EXT_DIR || bcr[URHO].hi(2) == EXT_DIR)) ||
(bcr[URHO].hi(1) == EXT_DIR && bcr[URHO].hi(2) == EXT_DIR) ||
(bcr[URHO].hi(0) == EXT_DIR && // xr, yl, zl corner
(bcr[URHO].lo(1) == EXT_DIR || bcr[URHO].lo(2) == EXT_DIR)) ||
(bcr[URHO].lo(1) == EXT_DIR && bcr[URHO].lo(2) == EXT_DIR) ||
(bcr[URHO].hi(0) == EXT_DIR && // xr, yr, zl corner
(bcr[URHO].hi(1) == EXT_DIR || bcr[URHO].lo(2) == EXT_DIR)) ||
(bcr[URHO].hi(1) == EXT_DIR && bcr[URHO].lo(2) == EXT_DIR) ||
(bcr[URHO].hi(0) == EXT_DIR && // xr, yl, zr corner
(bcr[URHO].lo(1) == EXT_DIR || bcr[URHO].hi(2) == EXT_DIR)) ||
(bcr[URHO].lo(1) == EXT_DIR && bcr[URHO].hi(2) == EXT_DIR) ||
(bcr[URHO].hi(0) == EXT_DIR && // xr, yr, zr corner
(bcr[URHO].hi(1) == EXT_DIR || bcr[URHO].hi(2) == EXT_DIR)) ||
(bcr[URHO].hi(1) == EXT_DIR && bcr[URHO].hi(2) == EXT_DIR)) {
if ((bcr[URHO].lo(0) == amrex::BCType::ext_dir && // xl, yl, zl corner
(bcr[URHO].lo(1) == amrex::BCType::ext_dir || bcr[URHO].lo(2) == amrex::BCType::ext_dir)) ||
(bcr[URHO].lo(1) == amrex::BCType::ext_dir && bcr[URHO].lo(2) == amrex::BCType::ext_dir) ||
(bcr[URHO].lo(0) == amrex::BCType::ext_dir && // xl, yr, zl corner
(bcr[URHO].hi(1) == amrex::BCType::ext_dir || bcr[URHO].lo(2) == amrex::BCType::ext_dir)) ||
(bcr[URHO].hi(1) == amrex::BCType::ext_dir && bcr[URHO].lo(2) == amrex::BCType::ext_dir) ||
(bcr[URHO].lo(0) == amrex::BCType::ext_dir && // xl, yl, zr corner
(bcr[URHO].lo(1) == amrex::BCType::ext_dir || bcr[URHO].hi(2) == amrex::BCType::ext_dir)) ||
(bcr[URHO].lo(1) == amrex::BCType::ext_dir && bcr[URHO].hi(2) == amrex::BCType::ext_dir) ||
(bcr[URHO].lo(0) == amrex::BCType::ext_dir && // xl, yr, zr corner
(bcr[URHO].hi(1) == amrex::BCType::ext_dir || bcr[URHO].hi(2) == amrex::BCType::ext_dir)) ||
(bcr[URHO].hi(1) == amrex::BCType::ext_dir && bcr[URHO].hi(2) == amrex::BCType::ext_dir) ||
(bcr[URHO].hi(0) == amrex::BCType::ext_dir && // xr, yl, zl corner
(bcr[URHO].lo(1) == amrex::BCType::ext_dir || bcr[URHO].lo(2) == amrex::BCType::ext_dir)) ||
(bcr[URHO].lo(1) == amrex::BCType::ext_dir && bcr[URHO].lo(2) == amrex::BCType::ext_dir) ||
(bcr[URHO].hi(0) == amrex::BCType::ext_dir && // xr, yr, zl corner
(bcr[URHO].hi(1) == amrex::BCType::ext_dir || bcr[URHO].lo(2) == amrex::BCType::ext_dir)) ||
(bcr[URHO].hi(1) == amrex::BCType::ext_dir && bcr[URHO].lo(2) == amrex::BCType::ext_dir) ||
(bcr[URHO].hi(0) == amrex::BCType::ext_dir && // xr, yl, zr corner
(bcr[URHO].lo(1) == amrex::BCType::ext_dir || bcr[URHO].hi(2) == amrex::BCType::ext_dir)) ||
(bcr[URHO].lo(1) == amrex::BCType::ext_dir && bcr[URHO].hi(2) == amrex::BCType::ext_dir) ||
(bcr[URHO].hi(0) == amrex::BCType::ext_dir && // xr, yr, zr corner
(bcr[URHO].hi(1) == amrex::BCType::ext_dir || bcr[URHO].hi(2) == amrex::BCType::ext_dir)) ||
(bcr[URHO].hi(1) == amrex::BCType::ext_dir && bcr[URHO].hi(2) == amrex::BCType::ext_dir)) {
amrex::Error("Error: external boundaries meeting at a corner not supported");
}
#endif
Expand Down
Loading

0 comments on commit 994078a

Please sign in to comment.