diff --git a/Exec/RegTests/PassiveScalar/GNUmakefile~ b/Exec/RegTests/PassiveScalar/GNUmakefile~ deleted file mode 100644 index 34dea3c0..00000000 --- a/Exec/RegTests/PassiveScalar/GNUmakefile~ +++ /dev/null @@ -1,38 +0,0 @@ -# AMReX -DIM = 3 -COMP = intel-llvm -PRECISION = DOUBLE -USE_EB = FALSE -USE_HYPRE = FALSE - -# Profiling -PROFILE = FALSE -TINY_PROFILE = FALSE -COMM_PROFILE = FALSE -TRACE_PROFILE = FALSE -MEM_PROFILE = FALSE -USE_GPROF = FALSE - -# Performance -USE_MPI = FALSE -USE_OMP = FALSE -USE_CUDA = FALSE -USE_HIP = FALSE -USE_SYCL = FALSE - -# Debugging -DEBUG = FALSE -FSANITIZER = FALSE -THREAD_SANITIZER = FALSE - -# PeleLMeX - -# PelePhysics -Chemistry_Model = air -Eos_Model = Fuego -Transport_Model = Constant - -PELE_HOME ?= ../../.. -PELE_PHYSICS_HOME = ../../../../PelePhysics -AMREX_HYDRO_HOME = ../../../../AMReX-Hydro -include $(PELE_HOME)/Exec/Make.PeleLMeX diff --git a/Exec/RegTests/PassiveScalar/README.md~ b/Exec/RegTests/PassiveScalar/README.md~ deleted file mode 100644 index 306af030..00000000 --- a/Exec/RegTests/PassiveScalar/README.md~ +++ /dev/null @@ -1,3 +0,0 @@ -## HotBubble -Case of a 2D/2D-RZ/3D bubble of light gases (either hotter or lighter mixture composition) lifted under the effect of -a gravity field. Testing of RZ algorithm and gravity forces. diff --git a/Exec/RegTests/PassiveScalar/input.2d-regt~ b/Exec/RegTests/PassiveScalar/input.2d-regt~ deleted file mode 100644 index 04ed510d..00000000 --- a/Exec/RegTests/PassiveScalar/input.2d-regt~ +++ /dev/null @@ -1,59 +0,0 @@ -#----------------------DOMAIN DEFINITION------------------------ -geometry.is_periodic = 1 1 # For each dir, 0: non-perio, 1: periodic -geometry.coord_sys = 0 # 0 => cart, 1 => RZ -geometry.prob_lo = 0.0 0.0 # x_lo y_lo (z_lo) -geometry.prob_hi = 1.0 1.0 # x_hi y_hi (z_hi) - -# >>>>>>>>>>>>> BC FLAGS <<<<<<<<<<<<<<<< -# Interior, Inflow, Outflow, Symmetry, -# SlipWallAdiab, NoSlipWallAdiab, SlipWallIsotherm, NoSlipWallIsotherm -peleLM.lo_bc = Interior Interior -peleLM.hi_bc = Interior Interior - - -#-------------------------AMR CONTROL---------------------------- -amr.n_cell = 64 64 # Level 0 number of cells in each direction -amr.v = 1 # AMR verbose -amr.max_level = 0 # maximum level number allowed -amr.ref_ratio = 2 2 2 2 # refinement ratio -amr.regrid_int = 5 # how often to regrid -amr.n_error_buf = 1 1 2 2 # number of buffer cells in error est -amr.grid_eff = 0.7 # what constitutes an efficient grid -amr.blocking_factor = 16 # block factor in grid generation (min box size) -amr.max_grid_size = 64 # max box size - - -#-------------------------PeleLM CONTROL---------------------------- -peleLM.v = 1 -peleLM.aux_vars = a b c - -peleLM.a.advect = 1 -peleLM.a.diff_coeff = 0 - -peleLM.b.advect = 0 -peleLM.b.diff_coeff = 1e-5 - -peleLM.c.advect = 1 -peleLM.c.diff_coeff = 1e-5 - - -#amr.restart = chk00005 -#amr.check_int = 2000 -amr.plot_int = 100 -amr.max_step = 400 -amr.dt_shrink = 0.1 -amr.stop_time = 1 -#amr.fixed_dt = 0.0001 -#amr.stop_time = 1.00 -amr.cfl = 0.9 -amr.derive_plot_vars = avg_pressure mag_vort - -#--------------------REFINEMENT CONTROL------------------------ -#amr.refinement_indicators = temp -#amr.temp.max_level = 1 -#amr.temp.value_greater = 305 -#amr.temp.field_name = temp - -#amrex.fpe_trap_invalid = 1 -#amrex.fpe_trap_zero = 1 -#amrex.fpe_trap_overflow = 1 diff --git a/Exec/RegTests/PassiveScalar/input.3d-regt~ b/Exec/RegTests/PassiveScalar/input.3d-regt~ deleted file mode 100644 index eb6d90b2..00000000 --- a/Exec/RegTests/PassiveScalar/input.3d-regt~ +++ /dev/null @@ -1,59 +0,0 @@ -#----------------------DOMAIN DEFINITION------------------------ -geometry.is_periodic = 1 1 # For each dir, 0: non-perio, 1: periodic -geometry.coord_sys = 0 # 0 => cart, 1 => RZ -geometry.prob_lo = 0.0 0.0 # x_lo y_lo (z_lo) -geometry.prob_hi = 1.0 1.0 # x_hi y_hi (z_hi) - -# >>>>>>>>>>>>> BC FLAGS <<<<<<<<<<<<<<<< -# Interior, Inflow, Outflow, Symmetry, -# SlipWallAdiab, NoSlipWallAdiab, SlipWallIsotherm, NoSlipWallIsotherm -peleLM.lo_bc = Interior Interior -peleLM.hi_bc = Interior Interior - - -#-------------------------AMR CONTROL---------------------------- -amr.n_cell = 64 64 # Level 0 number of cells in each direction -amr.v = 1 # AMR verbose -amr.max_level = 0 # maximum level number allowed -amr.ref_ratio = 2 2 2 2 # refinement ratio -amr.regrid_int = 5 # how often to regrid -amr.n_error_buf = 1 1 2 2 # number of buffer cells in error est -amr.grid_eff = 0.7 # what constitutes an efficient grid -amr.blocking_factor = 16 # block factor in grid generation (min box size) -amr.max_grid_size = 64 # max box size - - -#-------------------------PeleLM CONTROL---------------------------- -peleLM.v = 1 -peleLM.aux_vars = a b c - -peleLM.a.advect = 1 -peleLM.a.diff_coeff = 0 - -peleLM.b.advect = 0 -peleLM.b.diff_coeff = 1e-2 - -peleLM.c.advect = 1 -peleLM.c.diff_coeff = 1e-2 - - -#amr.restart = chk00005 -#amr.check_int = 2000 -amr.plot_int = 100 -amr.max_step = 400 -amr.dt_shrink = 0.1 -amr.stop_time = 1 -#amr.fixed_dt = 0.0001 -#amr.stop_time = 1.00 -amr.cfl = 0.9 -amr.derive_plot_vars = avg_pressure mag_vort - -#--------------------REFINEMENT CONTROL------------------------ -#amr.refinement_indicators = temp -#amr.temp.max_level = 1 -#amr.temp.value_greater = 305 -#amr.temp.field_name = temp - -#amrex.fpe_trap_invalid = 1 -#amrex.fpe_trap_zero = 1 -#amrex.fpe_trap_overflow = 1 diff --git a/Exec/RegTests/PassiveScalar/pelelmex_prob.H~ b/Exec/RegTests/PassiveScalar/pelelmex_prob.H~ deleted file mode 100644 index d9273d95..00000000 --- a/Exec/RegTests/PassiveScalar/pelelmex_prob.H~ +++ /dev/null @@ -1,122 +0,0 @@ -#ifndef PELELM_PROB_H -#define PELELM_PROB_H - -#include -#include -#include - -#include -#include -#include -#include - -AMREX_GPU_DEVICE -AMREX_FORCE_INLINE -void -pelelmex_initdata( - int i, - int j, - int k, - int is_incompressible, - int nAux, - amrex::Array4 const& state, - amrex::Array4 const& aux, - amrex::GeometryData const& geomdata, - ProbParm const& prob_parm, - pele::physics::PMF::PmfData::DataContainer const* /*pmf_data*/) -{ - const amrex::Real* prob_lo = geomdata.ProbLo(); - const amrex::Real* prob_hi = geomdata.ProbHi(); - const amrex::Real* dx = geomdata.CellSize(); - - auto eos = pele::physics::PhysicsType::eos(prob_parm.eosparm); - - state(i,j,k,TEMP) = 300; - amrex::Real P_cgs = prob_parm.P_mean * 10.0; - amrex::Real molefrac[NUM_SPECIES] = {0.0}; - amrex::Real massfrac[NUM_SPECIES] = {0.0}; - - molefrac[N2_ID] = 0.79; - molefrac[O2_ID] = 0.21; - - eos.X2Y(molefrac,massfrac); - amrex::Real rho_cgs = 0.0; - eos.PYT2R(P_cgs,massfrac,state(i,j,k,TEMP),rho_cgs); - state(i,j,k,DENSITY) = rho_cgs * 1.0e3; - - for (int n = 0; n < NUM_SPECIES; n++) { - state(i,j,k,FIRSTSPEC+n) = state(i,j,k,DENSITY)*massfrac[n]; - } - amrex::Real h_cgs = 0.0; - eos.TY2H(state(i,j,k,TEMP),massfrac,h_cgs); - state(i,j,k,RHOH) = h_cgs * 1.0e-4 * state(i,j,k,DENSITY); - - AMREX_D_TERM(const amrex::Real Lx = prob_hi[0] - prob_lo[0];,const amrex::Real Ly = prob_hi[1] - prob_lo[1];,const amrex::Real Lz = rob_hi[2] - prob_lo[2]); - - //want a cubic domain for ease -#if AMREX_SPACEDIM > 1 - AMREX_ALWAYS_ASSERT(AMREX_D_TERM(,(Lx == Ly), && (Ly == Lz))); -#endif - //find the centre of the domain - const amrex::Real cen[AMREX_SPACEDIM] = {AMREX_D_DECL(prob_lo[0] + 0.5*Lx,prob_lo[1]+0.5*Ly,prob_lo[2]+0.5*Lz)}; - - //radius from centre - const amrex::Real r = std::hypot(AMREX_D_DECL(prob_lo[0] + (i+0.5)*dx[0]-cen[0], prob_lo[1] + (j + 0.5) * dx[1]-cen[1] , prob_lo[2] + (k + 0.5) * dx[2] - cen[2])); - - const amrex::Real sigma = Lx/3.0; - - //impose radial Gaussian profile in all auxiliaries - for (int n = 0; n < nAux; n++) { - aux(i,j,k,n) = std::exp(-r*r/(sigma*sigma)); - } - - //constant upwards flow - state(i,j,k,VELX) = 0.0; -#if AMREX_SPACEDIM == 2 - state(i,j,k,VELY) = 1.0; -#else - state(i,j,k,VELY) = 0.0; - state(i,j,k,VELZ) = 1.0; -#endif - -} - -AMREX_GPU_DEVICE -AMREX_FORCE_INLINE -void -bcnormal( - const amrex::Real* /*x[AMREX_SPACEDIM]*/, - const int /*m_nAux*/, - amrex::Real* /*s_ext[NVAR]*/, - amrex::Real* /*s_aux[NVAR]*/, - const int /*idir*/, - const int /*sgn*/, - const amrex::Real /*time*/, - amrex::GeometryData const& /*geomdata*/, - ProbParm const& /*prob_parm*/, - pele::physics::PMF::PmfData::DataContainer const* /*pmf_data*/) -{ - //Periodic boundaries -} - -AMREX_GPU_DEVICE -AMREX_FORCE_INLINE -void -zero_visc( - int i, - int j, - int k, - amrex::Array4 const& beta, - amrex::GeometryData const& geomdata, - amrex::Box const& domainBox, - const int dir, - const int beta_comp, - const int nComp) -{ - amrex::ignore_unused( - i, j, k, beta, geomdata, domainBox, dir, beta_comp, nComp); - // We treat species when beta_comp == 0 and nComp == NUM_SPECIES - // otherwise this routine could be called for other face diffusivity (Temp, - // velocity, ...) -} -#endif diff --git a/Exec/RegTests/PassiveScalar/pelelmex_prob.cpp~ b/Exec/RegTests/PassiveScalar/pelelmex_prob.cpp~ deleted file mode 100644 index c019e1b2..00000000 --- a/Exec/RegTests/PassiveScalar/pelelmex_prob.cpp~ +++ /dev/null @@ -1,9 +0,0 @@ -#include -#include - -void -PeleLM::readProbParm() // NOLINT(readability-make-member-function-const) -{ - amrex::ParmParse pp("prob"); - pp.query("P_mean", prob_parm->P_mean); -} diff --git a/Exec/RegTests/PassiveScalar/pelelmex_prob_parm.H~ b/Exec/RegTests/PassiveScalar/pelelmex_prob_parm.H~ deleted file mode 100644 index 4305b6bd..00000000 --- a/Exec/RegTests/PassiveScalar/pelelmex_prob_parm.H~ +++ /dev/null @@ -1,15 +0,0 @@ -#ifndef PELELM_PROB_PARM_H -#define PELELM_PROB_PARM_H - -#include - -using namespace amrex::literals; - -struct ProbParm -{ - amrex::Real P_mean = 101325.0_rt; - pele::physics::eos::EosParm const* - eosparm; - -}; -#endif