Skip to content

Commit

Permalink
remove some deprecated AMReX constants / macros (#2719)
Browse files Browse the repository at this point in the history
This prepares us for AMReX-Codes/amrex#3713

Co-authored-by: Weiqun Zhang <[email protected]>
  • Loading branch information
zingale and WeiqunZhang authored Feb 6, 2024
1 parent cff7393 commit 09b5fe5
Show file tree
Hide file tree
Showing 44 changed files with 349 additions and 349 deletions.
6 changes: 3 additions & 3 deletions Diagnostics/DustCollapse/main.cpp
Original file line number Diff line number Diff line change
Expand Up @@ -172,17 +172,17 @@ int main(int argc, char* argv[])
const Box& bx = mfi.tilebox();

#if (AMREX_SPACEDIM == 1)
fdustcollapse1d(ARLIM_3D(bx.loVect()), ARLIM_3D(bx.hiVect()),
fdustcollapse1d(AMREX_ARLIM_3D(bx.loVect()), AMREX_ARLIM_3D(bx.hiVect()),
BL_TO_FORTRAN_FAB(lev_data_mf[mfi]),
nbins, dens.dataPtr(),
imask.dataPtr(), mask_size, r1, dens_comp, &cnt);
#elif (AMREX_SPACEDIM == 2)

fdustcollapse2d(ARLIM_3D(bx.loVect()), ARLIM_3D(bx.hiVect()),
fdustcollapse2d(AMREX_ARLIM_3D(bx.loVect()), AMREX_ARLIM_3D(bx.hiVect()),
BL_TO_FORTRAN_FAB(lev_data_mf[mfi]),
nbins, dens.dataPtr(), volcount.dataPtr(),
imask.dataPtr(), mask_size, r1,
ZFILL(level_dx), dx_fine, yctr, dens_comp);
AMREX_ZFILL(level_dx), dx_fine, yctr, dens_comp);
#else
fdustcollapse3d(bx.loVect(), bx.hiVect(),
BL_TO_FORTRAN_FAB(lev_data_mf[mfi]),
Expand Down
4 changes: 2 additions & 2 deletions Diagnostics/Radiation/gaussian_pulse.cpp
Original file line number Diff line number Diff line change
Expand Up @@ -123,11 +123,11 @@ int main(int argc, char* argv[])
for (MFIter mfi(lev_data_mf, true); mfi.isValid(); ++mfi) {
const Box& bx = mfi.tilebox();

fgaussian_pulse(ARLIM_3D(bx.loVect()), ARLIM_3D(bx.hiVect()),
fgaussian_pulse(AMREX_ARLIM_3D(bx.loVect()), AMREX_ARLIM_3D(bx.hiVect()),
BL_TO_FORTRAN_FAB(lev_data_mf[mfi]),
nbins, rad_bin.dataPtr(), ncount.dataPtr(),
imask.dataPtr(), mask_size, r1,
rad_comp, ZFILL(dx), dx_fine, xctr, yctr);
rad_comp, AMREX_ZFILL(dx), dx_fine, xctr, yctr);

}

Expand Down
4 changes: 2 additions & 2 deletions Diagnostics/Radiation/lgt_frnt1d.cpp
Original file line number Diff line number Diff line change
Expand Up @@ -114,13 +114,13 @@ int main(int argc, char* argv[])
for (MFIter mfi(lev_data_mf, true); mfi.isValid(); ++mfi) {
const Box& bx = mfi.tilebox();

flgt_frnt1d(ARLIM_3D(bx.loVect()), ARLIM_3D(bx.hiVect()),
flgt_frnt1d(AMREX_ARLIM_3D(bx.loVect()), AMREX_ARLIM_3D(bx.hiVect()),
BL_TO_FORTRAN_FAB(lev_data_mf[mfi]),
nbins, dens_bin.dataPtr(), vel_bin.dataPtr(),
pres_bin.dataPtr(), rad_bin.dataPtr(),
imask.dataPtr(), mask_size, r1,
dens_comp, xmom_comp, pres_comp, rad_comp,
ZFILL(dx), dx_fine);
AMREX_ZFILL(dx), dx_fine);
}

// adjust r1 for the next lowest level
Expand Down
2 changes: 1 addition & 1 deletion Diagnostics/Radiation/rad_shock.cpp
Original file line number Diff line number Diff line change
Expand Up @@ -135,7 +135,7 @@ int main(int argc, char* argv[])
for (MFIter mfi(lev_data_mf, true); mfi.isValid(); ++mfi) {
const Box& bx = mfi.tilebox();

fradshock(ARLIM_3D(bx.loVect()), ARLIM_3D(bx.hiVect()),
fradshock(AMREX_ARLIM_3D(bx.loVect()), AMREX_ARLIM_3D(bx.hiVect()),
problo.dataPtr(), probhi.dataPtr(),
BL_TO_FORTRAN_FAB(lev_data_mf[mfi]),
nbins, vars_bin.dataPtr(),
Expand Down
2 changes: 1 addition & 1 deletion Diagnostics/Radiation/rad_source.cpp
Original file line number Diff line number Diff line change
Expand Up @@ -81,7 +81,7 @@ int main(int argc, char* argv[])

Real rhoe, rad;

fradsource(ARLIM_3D(bx.loVect()), ARLIM_3D(bx.hiVect()),
fradsource(AMREX_ARLIM_3D(bx.loVect()), AMREX_ARLIM_3D(bx.hiVect()),
BL_TO_FORTRAN_FAB(lev_data_mf[mfi]),
&rhoe, &rad, rhoe_comp, rad_comp);

Expand Down
6 changes: 3 additions & 3 deletions Diagnostics/Radiation/rad_sphere.cpp
Original file line number Diff line number Diff line change
Expand Up @@ -163,12 +163,12 @@ int main(int argc, char* argv[])
for (MFIter mfi(lev_data_mf, true); mfi.isValid(); ++mfi) {
const Box& bx = mfi.tilebox();

fradsphere(ARLIM_3D(bx.loVect()), ARLIM_3D(bx.hiVect()),
ZFILL(problo), ZFILL(probhi),
fradsphere(AMREX_ARLIM_3D(bx.loVect()), AMREX_ARLIM_3D(bx.hiVect()),
AMREX_ZFILL(problo), AMREX_ZFILL(probhi),
BL_TO_FORTRAN_FAB(lev_data_mf[mfi]),
nbins, vars_bin.dataPtr(),
imask.dataPtr(), mask_size, r1,
ZFILL(dx), &cnt);
AMREX_ZFILL(dx), &cnt);
}

// adjust r1 for the next lowest level
Expand Down
2 changes: 1 addition & 1 deletion Diagnostics/Radiation/rhd_shocktube.cpp
Original file line number Diff line number Diff line change
Expand Up @@ -150,7 +150,7 @@ int main(int argc, char* argv[])
for (MFIter mfi(lev_data_mf, true); mfi.isValid(); ++mfi) {
const Box& bx = mfi.tilebox();

frhdshocktube(ARLIM_3D(bx.loVect()), ARLIM_3D(bx.hiVect()),
frhdshocktube(AMREX_ARLIM_3D(bx.loVect()), AMREX_ARLIM_3D(bx.hiVect()),
BL_TO_FORTRAN_FAB(lev_data_mf[mfi]),
nbins, dens_bin.dataPtr(), vel_bin.dataPtr(),
pres_bin.dataPtr(), rad_bin.dataPtr(),
Expand Down
4 changes: 2 additions & 2 deletions Docs/source/faq.rst
Original file line number Diff line number Diff line change
Expand Up @@ -106,10 +106,10 @@ Debugging

::

print_state(mf, IntVect(D_DECL(10, 20, 30)));
print_state(mf, IntVect(AMREX_D_DECL(10, 20, 30)));

Here, the IntVect has the dimension that we were compiled with
(and this is handled through the preprocessor ``D_DECL``). In
(and this is handled through the preprocessor ``AMREX_D_DECL``). In
this case, we are inspecting zone (10, 20, 30), in the global index
space. Note that since a multifab exists only on a single level, the
integer indices here refer to the global index space on that level.
Expand Down
12 changes: 6 additions & 6 deletions Exec/gravity_tests/DustCollapse/problem_bc_fill.H
Original file line number Diff line number Diff line change
Expand Up @@ -30,7 +30,7 @@ void problem_bc_fill(int i, int j, int k,
Real r = std::sqrt(x * x + y * y + z * z);

// XLO
if (bcs(0).lo(0) == FOEXTRAP && i < domlo[0]) {
if (bcs(0).lo(0) == amrex::BCType::foextrap && i < domlo[0]) {

int ic = domlo[0];
Real xc = problo[0] + (static_cast<Real>(ic) + 0.5_rt) * dx[0] - problem::center[0];
Expand All @@ -50,7 +50,7 @@ void problem_bc_fill(int i, int j, int k,
}

// XHI
if (bcs(0).hi(0) == FOEXTRAP && i > domhi[0]) {
if (bcs(0).hi(0) == amrex::BCType::foextrap && i > domhi[0]) {

int ic = domhi[0];
Real xc = problo[0] + (static_cast<Real>(ic) + 0.5_rt) * dx[0] - problem::center[0];
Expand All @@ -71,7 +71,7 @@ void problem_bc_fill(int i, int j, int k,

#if AMREX_SPACEDIM >= 2
// YLO
if (bcs(0).lo(1) == FOEXTRAP && j < domlo[1]) {
if (bcs(0).lo(1) == amrex::BCType::foextrap && j < domlo[1]) {

int jc = domlo[1];
Real yc = problo[1] + (static_cast<Real>(jc) + 0.5_rt) * dx[1] - problem::center[1];
Expand All @@ -91,7 +91,7 @@ void problem_bc_fill(int i, int j, int k,
}

// YHI
if (bcs(0).hi(1) == FOEXTRAP && j > domhi[1]) {
if (bcs(0).hi(1) == amrex::BCType::foextrap && j > domhi[1]) {

int jc = domhi[1];
Real yc = problo[1] + (static_cast<Real>(jc) + 0.5_rt) * dx[1] - problem::center[1];
Expand All @@ -112,7 +112,7 @@ void problem_bc_fill(int i, int j, int k,

#if AMREX_SPACEDIM == 3
// ZLO
if (bcs(0).lo(2) == FOEXTRAP && k < domlo[2]) {
if (bcs(0).lo(2) == amrex::BCType::foextrap && k < domlo[2]) {

int kc = domlo[2];
Real zc = problo[2] + (static_cast<Real>(kc) + 0.5_rt) * dx[2] - problem::center[2];
Expand All @@ -132,7 +132,7 @@ void problem_bc_fill(int i, int j, int k,
}

// ZHI
if (bcs(0).hi(2) == FOEXTRAP && k > domhi[2]) {
if (bcs(0).hi(2) == amrex::BCType::foextrap && k > domhi[2]) {

int kc = domhi[2];
Real zc = problo[2] + (static_cast<Real>(kc) + 0.5_rt) * dx[2] - problem::center[2];
Expand Down
6 changes: 3 additions & 3 deletions Exec/gravity_tests/hydrostatic_adjust/problem_bc_fill.H
Original file line number Diff line number Diff line change
Expand Up @@ -14,7 +14,7 @@ void problem_bc_fill(int i, int j, int k,

if (AMREX_SPACEDIM == 1) {

if (bcs(UMX).hi(0) == FOEXTRAP && i > domhi[0]) {
if (bcs(UMX).hi(0) == amrex::BCType::foextrap && i > domhi[0]) {

Real vel = amrex::max(state(i,j,k,UMX) / state(i,j,k,URHO), 0.0);
state(i,j,k,URHO) = problem::hse_rho_top;
Expand All @@ -36,7 +36,7 @@ void problem_bc_fill(int i, int j, int k,
}
else if (AMREX_SPACEDIM == 2) {

if (bcs(UMY).hi(1) == FOEXTRAP && j > domhi[1]) {
if (bcs(UMY).hi(1) == amrex::BCType::foextrap && j > domhi[1]) {

Real vel = amrex::max(state(i,j,k,UMY) / state(i,j,k,URHO), 0.0);
state(i,j,k,URHO) = problem::hse_rho_top;
Expand All @@ -58,7 +58,7 @@ void problem_bc_fill(int i, int j, int k,
}
else {

if (bcs(UMZ).hi(2) == FOEXTRAP && k > domhi[2]) {
if (bcs(UMZ).hi(2) == amrex::BCType::foextrap && k > domhi[2]) {

Real vel = amrex::max(state(i,j,k,UMZ) / state(i,j,k,URHO), 0.0);
state(i,j,k,URHO) = problem::hse_rho_top;
Expand Down
6 changes: 3 additions & 3 deletions Exec/hydro_tests/double_mach_reflection/problem_bc_fill.H
Original file line number Diff line number Diff line change
Expand Up @@ -18,7 +18,7 @@ void problem_bc_fill(int i, int j, int k,
// x boundaries
//-------------------------------------------------------------------------

if ((bcs(URHO).lo(0) == EXT_DIR || bcs(URHO).lo(0) == FOEXTRAP) && i < domlo[0]) {
if ((bcs(URHO).lo(0) == amrex::BCType::ext_dir || bcs(URHO).lo(0) == amrex::BCType::foextrap) && i < domlo[0]) {
state(i,j,k,URHO) = problem::rho_l;
state(i,j,k,UMX) = problem::rho_l * problem::u_l;
state(i,j,k,UMY) = problem::rho_l * problem::v_l;
Expand All @@ -43,7 +43,7 @@ void problem_bc_fill(int i, int j, int k,
Real y = problo[1] + dx[1] * (static_cast<Real>(j) + 0.5e0_rt);

// YLO
if ((bcs(URHO).lo(1) == EXT_DIR || bcs(URHO).lo(1) == FOEXTRAP) && j < domlo[1]) {
if ((bcs(URHO).lo(1) == amrex::BCType::ext_dir || bcs(URHO).lo(1) == amrex::BCType::foextrap) && j < domlo[1]) {
if (x < 1.e0_rt / 6.e0_rt) {
// ICs
state(i,j,k,URHO) = problem::rho_l;
Expand Down Expand Up @@ -71,7 +71,7 @@ void problem_bc_fill(int i, int j, int k,
}

// YHI
if ((bcs(URHO).hi(2) == EXT_DIR || bcs(URHO).hi(2) == FOEXTRAP) && j > domhi[1]) {
if ((bcs(URHO).hi(2) == amrex::BCType::ext_dir || bcs(URHO).hi(2) == amrex::BCType::foextrap) && j > domhi[1]) {
state(i,j,k,URHO ) = 0.e0_rt;
state(i,j,k,UMX ) = 0.e0_rt;
state(i,j,k,UMY ) = 0.e0_rt;
Expand Down
12 changes: 6 additions & 6 deletions Exec/radiation_tests/Rad2Tshock/problem_bc_fill.H
Original file line number Diff line number Diff line change
Expand Up @@ -18,7 +18,7 @@ void problem_bc_fill(int i, int j, int k,
if (problem::idir == 1) {

// XLO
if ((bcs(URHO).lo(0) == EXT_DIR || bcs(URHO).lo(0) == FOEXTRAP) && i < domlo[0]) {
if ((bcs(URHO).lo(0) == amrex::BCType::ext_dir || bcs(URHO).lo(0) == amrex::BCType::foextrap) && i < domlo[0]) {
state(i,j,k,URHO) = problem::rho0;
state(i,j,k,UMX) = problem::rho0 * problem::v0;
state(i,j,k,UMY) = 0.e0_rt;
Expand All @@ -33,7 +33,7 @@ void problem_bc_fill(int i, int j, int k,
}

// XHI
if ((bcs(URHO).hi(0) == EXT_DIR || bcs(URHO).hi(0) == FOEXTRAP) && i > domhi[0]) {
if ((bcs(URHO).hi(0) == amrex::BCType::ext_dir || bcs(URHO).hi(0) == amrex::BCType::foextrap) && i > domhi[0]) {
state(i,j,k,URHO) = problem::rho1;
state(i,j,k,UMX) = problem::rho1 * problem::v1;
state(i,j,k,UMY) = 0.e0_rt;
Expand All @@ -51,7 +51,7 @@ void problem_bc_fill(int i, int j, int k,
else if (problem::idir == 2) {

// YLO
if ((bcs(URHO).lo(1) == EXT_DIR || bcs(URHO).lo(1) == FOEXTRAP) && j < domlo[1]) {
if ((bcs(URHO).lo(1) == amrex::BCType::ext_dir || bcs(URHO).lo(1) == amrex::BCType::foextrap) && j < domlo[1]) {
state(i,j,k,URHO) = problem::rho0;
state(i,j,k,UMX) = 0.e0_rt;
state(i,j,k,UMY) = problem::rho0 * problem::v0;
Expand All @@ -66,7 +66,7 @@ void problem_bc_fill(int i, int j, int k,
}

// YHI
if ((bcs(URHO).hi(1) == EXT_DIR || bcs(URHO).hi(1) == FOEXTRAP) && j > domhi[1]) {
if ((bcs(URHO).hi(1) == amrex::BCType::ext_dir || bcs(URHO).hi(1) == amrex::BCType::foextrap) && j > domhi[1]) {
state(i,j,k,URHO) = problem::rho1;
state(i,j,k,UMX) = 0.e0_rt;
state(i,j,k,UMY) = problem::rho1 * problem::v1;
Expand All @@ -84,7 +84,7 @@ void problem_bc_fill(int i, int j, int k,
else if (problem::idir == 3) {

// ZLO
if ((bcs(URHO).lo(2) == EXT_DIR || bcs(URHO).lo(2) == FOEXTRAP) && k < domlo[2]) {
if ((bcs(URHO).lo(2) == amrex::BCType::ext_dir || bcs(URHO).lo(2) == amrex::BCType::foextrap) && k < domlo[2]) {
state(i,j,k,URHO) = problem::rho0;
state(i,j,k,UMX) = 0.e0_rt;
state(i,j,k,UMY) = 0.e0_rt;
Expand All @@ -99,7 +99,7 @@ void problem_bc_fill(int i, int j, int k,
}

// ZHI
if ((bcs(URHO).hi(2) == EXT_DIR || bcs(URHO).hi(2) == FOEXTRAP) && k > domhi[2]) {
if ((bcs(URHO).hi(2) == amrex::BCType::ext_dir || bcs(URHO).hi(2) == amrex::BCType::foextrap) && k > domhi[2]) {
state(i,j,k,URHO) = problem::rho1;
state(i,j,k,UMX) = 0.e0_rt;
state(i,j,k,UMY) = 0.e0_rt;
Expand Down
36 changes: 18 additions & 18 deletions Exec/science/Detonation/problem_bc_fill.H
Original file line number Diff line number Diff line change
Expand Up @@ -63,39 +63,39 @@ void problem_bc_fill(int i, int j, int k,
// Note: in these checks we're only looking at the boundary
// conditions on the first state component (density).

if (i < domlo[0] && (bcs(0).lo(0) != REFLECT_ODD &&
bcs(0).lo(0) != INT_DIR &&
bcs(0).lo(0) != REFLECT_EVEN)) {
if (i < domlo[0] && (bcs(0).lo(0) != amrex::BCType::reflect_odd &&
bcs(0).lo(0) != amrex::BCType::int_dir &&
bcs(0).lo(0) != amrex::BCType::reflect_even)) {
do_ambient_fill = true;
}
else if (i > domhi[0] && (bcs(0).hi(0) != REFLECT_ODD &&
bcs(0).hi(0) != INT_DIR &&
bcs(0).hi(0) != REFLECT_EVEN)) {
else if (i > domhi[0] && (bcs(0).hi(0) != amrex::BCType::reflect_odd &&
bcs(0).hi(0) != amrex::BCType::int_dir &&
bcs(0).hi(0) != amrex::BCType::reflect_even)) {
do_ambient_fill = true;
}

if (AMREX_SPACEDIM >= 2) {
if (j < domlo[1] && (bcs(0).lo(1) != REFLECT_ODD &&
bcs(0).lo(1) != INT_DIR &&
bcs(0).lo(1) != REFLECT_EVEN)) {
if (j < domlo[1] && (bcs(0).lo(1) != amrex::BCType::reflect_odd &&
bcs(0).lo(1) != amrex::BCType::int_dir &&
bcs(0).lo(1) != amrex::BCType::reflect_even)) {
do_ambient_fill = true;
}
else if (j > domhi[1] && (bcs(0).hi(1) != REFLECT_ODD &&
bcs(0).hi(1) != INT_DIR &&
bcs(0).hi(1) != REFLECT_EVEN)) {
else if (j > domhi[1] && (bcs(0).hi(1) != amrex::BCType::reflect_odd &&
bcs(0).hi(1) != amrex::BCType::int_dir &&
bcs(0).hi(1) != amrex::BCType::reflect_even)) {
do_ambient_fill = true;
}
}

if (AMREX_SPACEDIM == 3) {
if (k < domlo[2] && (bcs(0).lo(2) != REFLECT_ODD &&
bcs(0).lo(2) != INT_DIR &&
bcs(0).lo(2) != REFLECT_EVEN)) {
if (k < domlo[2] && (bcs(0).lo(2) != amrex::BCType::reflect_odd &&
bcs(0).lo(2) != amrex::BCType::int_dir &&
bcs(0).lo(2) != amrex::BCType::reflect_even)) {
do_ambient_fill = true;
}
else if (k > domhi[2] && (bcs(0).hi(2) != REFLECT_ODD &&
bcs(0).hi(2) != INT_DIR &&
bcs(0).hi(2) != REFLECT_EVEN)) {
else if (k > domhi[2] && (bcs(0).hi(2) != amrex::BCType::reflect_odd &&
bcs(0).hi(2) != amrex::BCType::int_dir &&
bcs(0).hi(2) != amrex::BCType::reflect_even)) {
do_ambient_fill = true;
}
}
Expand Down
10 changes: 5 additions & 5 deletions Exec/science/wdmerger/Prob.cpp
Original file line number Diff line number Diff line change
Expand Up @@ -101,10 +101,10 @@ Castro::wd_update (Real time, Real dt)
GpuArray<bool, 3> symm_bound_hi{false};

for (int n = 0; n < AMREX_SPACEDIM; ++n) {
if (phys_bc.lo()[n] == Symmetry) {
if (phys_bc.lo()[n] == amrex::PhysBCType::symmetry) {
symm_bound_lo[n] = true;
}
if (phys_bc.hi()[n] == Symmetry) {
if (phys_bc.hi()[n] == amrex::PhysBCType::symmetry) {
symm_bound_hi[n] = true;
}
}
Expand Down Expand Up @@ -665,9 +665,9 @@ Castro::update_relaxation(Real time, Real dt) {

const int* lo_bc = phys_bc.lo();

const bool symm_lo_x = (lo_bc[0] == Symmetry);
const bool symm_lo_y = (lo_bc[1] == Symmetry);
const bool symm_lo_z = (lo_bc[2] == Symmetry);
const bool symm_lo_x = (lo_bc[0] == amrex::PhysBCType::symmetry);
const bool symm_lo_y = (lo_bc[1] == amrex::PhysBCType::symmetry);
const bool symm_lo_z = (lo_bc[2] == amrex::PhysBCType::symmetry);

ReduceOps<ReduceOpSum, ReduceOpSum, ReduceOpSum, ReduceOpSum, ReduceOpSum, ReduceOpSum> reduce_op;
ReduceData<Real, Real, Real, Real, Real, Real> reduce_data(reduce_op);
Expand Down
10 changes: 5 additions & 5 deletions Exec/science/wdmerger/wdmerger_util.cpp
Original file line number Diff line number Diff line change
Expand Up @@ -462,15 +462,15 @@ void binary_setup ()
const Real* problo = DefaultGeometry().ProbLo();
const Real* probhi = DefaultGeometry().ProbHi();

if (Castro::physbc().lo(0) == Symmetry && problem::center[0] != problo[0]) {
if (Castro::physbc().lo(0) == amrex::PhysBCType::symmetry && problem::center[0] != problo[0]) {
amrex::Error("Symmetric lower x-boundary but the center is not on this boundary.");
}

if (Castro::physbc().lo(1) == Symmetry && problem::center[1] != problo[1]) {
if (Castro::physbc().lo(1) == amrex::PhysBCType::symmetry && problem::center[1] != problo[1]) {
amrex::Error("Symmetric lower y-boundary but the center is not on this boundary.");
}

if (Castro::physbc().lo(2) == Symmetry && problem::center[2] != problo[2]) {
if (Castro::physbc().lo(2) == amrex::PhysBCType::symmetry && problem::center[2] != problo[2]) {
amrex::Error("Symmetric lower z-boundary but the center is not on this boundary.");
}

Expand Down Expand Up @@ -656,7 +656,7 @@ void binary_setup ()

Real length;

if (Castro::physbc().lo(problem::axis_1-1) == Symmetry) {
if (Castro::physbc().lo(problem::axis_1-1) == amrex::PhysBCType::symmetry) {

// In this case we're only modelling the secondary.
length = problem::r_P_initial + problem::radius_P;
Expand Down Expand Up @@ -787,7 +787,7 @@ void binary_setup ()

// Safety check: make sure the stars are actually inside the computational domain.

if (!(AMREX_SPACEDIM == 2 && Castro::physbc().lo(1) == Symmetry)) {
if (!(AMREX_SPACEDIM == 2 && Castro::physbc().lo(1) == amrex::PhysBCType::symmetry)) {

if ((0.5_rt * (probhi[0] - problo[0]) < problem::radius_P) ||
(0.5_rt * (probhi[1] - problo[1]) < problem::radius_P) ||
Expand Down
Loading

0 comments on commit 09b5fe5

Please sign in to comment.