Skip to content

Commit

Permalink
Check divu (#66)
Browse files Browse the repository at this point in the history
* add max_dt to prevent too large timestep

* adding injection test case for enclosed/open domain

* fix signs on divu terms to match paper

* Added source terms for rhoH and rhoYm in divu calc needed for injection; running, but something isnt quite right...

* adding confined domain pressure correction for mass injection

* updates to EnclosedInjection files

* add max_dt to prevent too large timestep

* adding injection test case for enclosed/open domain

* fix signs on divu terms to match paper

* Added source terms for rhoH and rhoYm in divu calc needed for injection; running, but something isnt quite right...

* adding confined domain pressure correction for mass injection

* updates to EnclosedInjection files

* Cleaning up and reverting divU sign change

* Update EB_ChallengeProblem with new PMF. (#32)

* Remove managed memory to enable running with HIP (ROCm 4.5) (#33)

* Remove managed arg. from ProbParm

* Fix SunMem init.

* Add a 3D input file to FlameSheet.

* Add timer on SDC k update portion.

* Remove mask from inst. RR calculation. EB are handled using box flag and
isCovered.

* Remove Managed arg from RegTests.

* Remove mamged arg. from TripleFlame case.

* Add FlameSheet dodecane Lu inputs. (#34)

* Fix efield (#35)

* Fix Efield BCfill with PMF changes.

* Update 1D efield flame source code.

* Enable initializing data from pltfile (#36)

* Enable initializing data from a pltfile, possibly a PeleLM one as
long as the mass fractions are stored in there.

* Add Extern/amrdata to the list of AMReX packages.

* Tprof regions (#37)

* Setup Tprof regions in advance/oneSDC to get clearer profiling data.

* Pass MAGMA flag to TPL and add CUDA ptxas optim. off flag.

* Switch to MF interpolators. (#38)

* Multi-component diffusion (#39)

* Add a Multi-Component diffusionOp to class.

* add ncomp to diffusionOp constructor, default to 1

* getMCDiffusionOp function. if ncomp != m_ncomp, reset the operator.

* Reset mcdiffusionOp during regrid.

* Enable DiffusionOp::diffuse_scalar, DiffusionOp::computeDiffFluxes and DiffusionOp::computeDiffLap
with multiple components.

* Switch to getMCDiffusionOp when dealing with species.

* NewStateRedist was removed from AMReX-Hydro

* Change level data layout (#40)

* Overhaul level data structure, introducing state MF in place of separate MF
for velocity, density, species, ...
Fix a bug on the averageDownState function that previously did nothing ...

* Restore TurnInflow. Change the process slightly where s_ext now contains
the turbulence data coming into bcnormal such that the user can decide to overwrite
locally the turbulence if needed.

* Set level data I_R to zero if we are not doing divu iters or it could
get junk.

* Adding sumodules to LMeX (#41)

* A fair amount of wrongly commited changed in previous PR, but some were good. (#42)

* Fix sundials6 (#43)

* Rmove call to MemHelper initialize.

* Add USE_SUNDIALS as preamble to Make.PeleLMeX.

* Fix change in the way umac growth faces are filled.

* Update submodules.

* Tune down most warnings in LMeX. (#44)

* Update perio test (#45)

* Update the convected Species/Temperature gaussian test inputs.

* Add missing mean flow direction in Convected Gaussian.

* Update periodic regtest to unable diffusion convergence test (#46)

* Add parameter controling the gaussian width based on a diffusion process.

* Add parsing.

* Update initalization to properly setup the diffusion problem.

* Small change to pprocConvOrder.py to aneble hacking the reference solution.

* Add an input file to generate the reference analytical solution.

* Fix input.2d_DiffGauS for convergence testing.

* Fix turbInflow (#47)

* Fix parsing tagging input for box.

* Couple of fixes for turbinflow for error introduced while re-arranging the
level data.

* Fix TurbInflow case to match changes in turbinflow velocity field handling.

* Add a input file with refinement on loZ.

* Initialize unitTest (#48)

* Abort if runMode is not right.

* Parse the runMode and evaluate variables list.

* Cut the init short if we are in evaluate mode.

* Add a container for the evaluate variables.

* Add a evaluate capability for a few components of the advance function.
Derive can now work without passsing a function ptr, just to keep the
same list class.

* Add a UnitTest for a dodecane PMF.

* Minor tweaks to Evaluate mode.

* Fix fill crse patch turb inflow (#49)

* Avoid using nan in s_ext when using inflow turb.

* Pre-fill the new fine MF with TurbInflow data before filling the patch.

* fillcrsepatch with nGrow to avoid using a fillPatch later

* Improper definition of turb_center

* Add a stiffer scalar advection version, convecting a Gaussian in a periodic box. (#50)

* Add M. Reith 1NJOD case.  (#51)

* Setup 1NJOD case.

* Add velocity maximas with verbose >= 2

* If turb is not activated when USE_TURBINFLOW is defined, don't read turbdata.

* Something's up with eta, just get rid of turb outside the jet for now.

* Remove incomplete minmax print of velocity in computeDt.

* Update sub mods (#53)

* Updating submodules.

* Add missing USE_HIP argument to make TPL

* Pass state Array4 in initdata instead of separate Array4 for each entry. (#54)

* Update the Case/* pelelm_initdata to take in state Array4 instead of separate entries.

* Update call to pelelm_initdata to take in state_arr instead of separate entries.

* Update Efield folder.

* Update UnitTest folder.

* Update RegTest/EB* cases.

* Update the remainder of the tests.

* Activate fpe in HotBubble regtest 2D.

* Add a couple of HoBubble regtests.

* Need to keep the aux Array4.

* Update submods.

* Missing change to state Array4

* Remove deprecated include of pmf.H

* Make PeleLM.H trans_parms static. (#55)

* Restore the ability to run incompressible flows (#56)

* Restore the incompressible run time option.

* Update EB_EnclosedVortex with an incompressible run input file.

* Add an incompressible decaying HIT case.

* Update input to enable running out-of-the-box.

* Add HIT to CI suite.

* Add a background gp0 option and make gravity of GpuArray.

* Add an EB_PipeFlow RegTest.

* Add EB_PipeFlow to CI.

* Gravity need to be a vector now.

* Fix file name in HIT.

* Shorten PipeFlow test.

* Update TurbInflow (#57)

* Remove compile flag from GMake.

* Move the turb data into PeleLM.H and update calls to refactored turbinflow.

* Update TurbInflow regtest.

* Update GMake and input files.

* Add TurbInflow tests to CI.

* Activate FPE traps while testing TurbInflow

* Fix input typo and coarsen turbinflow tests.

* Update submodules.

* Add support for Bell, Dawson & Shubin (BDS) advection scheme (#58)

* Add BDS folder of AMReX-Hydro

* For now, add a separate string for scalar advection scheme.

* Use m_scalar_advection_scheme for AofS and AofV. Predict velocity
still uses Godunov.

* Update handling of advection keys to match recent changes in IAMR.

* Update 2D input bubble.

* Add AA JetInCrossflow case. BDS looks good there.

* Update submodule for BDS

* Update normal jet case for new TurbInflow.

* Add message checking lifted from AmrLevel. (#59)

* Add the option to zero visc the diffusivity and thus add the zero_visc (#60)

* Add the option to zero visc the diffusivity and thus add the zero_visc
kernel to all the pelelm_prob.H

* Domain is now used even with EB

* Restart plt cpp (#61)

* Start extracting the data from plt Header.

* Replace amrData by a set of C++ routine using AmrCore FillPatch
operations. We can now restart a finer simulation using the pltfile of a
coarser one too.

* Remove fortran.

* PltFileManager moved to PelePhysics.

* Update the PltFileManager calls.

* Update submodules.

* Add flexibililty to EB refinement (#52)

* Quick relaxation of EB refinement constrain.

* Set up a signed distance function at level 0 to control EB refinement.

* Add a function to get the signed distance at any level from the level0 class data.

* Parse the EB-refinement strategy keys.

* Implement 'Static' EB-refinement strategy. Logic to derefine is still a bit approximative.

* Switch the modified FillSignedDistance. Need AMReX PR merge.

* Don't change AMReX signDist function and add some code to extend it
manually. Might need further testing.

* Revert change in capturing the Reactor type. Default is ReactorNull.

* Fix FPE while filling level0 signdist

* Swirl flow wall interaction (#62)

* Add M. Reza case. First version.

* Update Mohammadreza case.

* Update input file.

* Add pmf_data file

* Use previous Ubuntu for now, latest has issues with apt-get update

* Shorten pipeflow test.

* add max_dt to prevent too large timestep

* adding injection test case for enclosed/open domain

* fix signs on divu terms to match paper

* Added source terms for rhoH and rhoYm in divu calc needed for injection; running, but something isnt quite right...

* adding confined domain pressure correction for mass injection

* updates to EnclosedInjection files

* adding injection test case for enclosed/open domain

* Added source terms for rhoH and rhoYm in divu calc needed for injection; running, but something isnt quite right...

* adding confined domain pressure correction for mass injection

* updates to EnclosedInjection files

* Cleaning up and reverting divU sign change

* removing unused arguments in compute_divu

* removine old/new get state call

* Removing one more instance of unused variables

* Update submodules.

* Fix FPE by passing timeStamp to initTemporal function.
Add pNew to tempState
Update the TurbInflow case with changes in PelePhysics.

* addressing PR comments

Co-authored-by: Lucas Esclapez <13371051+esclapez@users.noreply.github.com>
Co-authored-by: Lucas Esclapez <lucas.esclapez@nrel.gov>
  • Loading branch information
3 people committed Mar 31, 2022
1 parent 5d17a21 commit 375e861
Show file tree
Hide file tree
Showing 26 changed files with 785 additions and 48 deletions.
2 changes: 1 addition & 1 deletion .github/workflows/linux.yml
Original file line number Diff line number Diff line change
Expand Up @@ -348,6 +348,6 @@ jobs:
working-directory: ./Exec/RegTests/TurbInflow/
run: |
mpirun -n 2 ./PeleLMeX3d.gnu.DEBUG.MPI.ex input.3d peleLM.num_init_iter=1 amr.n_cell=32 32 32 amr.max_step=2 amr.plot_int=-1 amr.check_int=-1
mpirun -n 2 ./PeleLMeX3d.gnu.DEBUG.MPI.ex input.3d_negY peleLM.num_init_iter=1 amr.n_cell=32 32 32 amr.max_step=2 amr.plot_int=-1 amr.check_int=-1
mpirun -n 2 ./PeleLMeX3d.gnu.DEBUG.MPI.ex input.3d_twoInjs peleLM.num_init_iter=1 amr.n_cell=32 32 32 amr.max_step=2 amr.plot_int=-1 amr.check_int=-1
mpirun -n 2 ./PeleLMeX3d.gnu.DEBUG.MPI.ex input.3d_posX peleLM.num_init_iter=1 amr.n_cell=32 32 32 amr.max_step=2 amr.plot_int=-1 amr.check_int=-1
mpirun -n 2 ./PeleLMeX3d.gnu.DEBUG.MPI.ex input.3d_BoxLoZ peleLM.num_init_iter=1 amr.n_cell=32 32 32 amr.max_step=2 amr.plot_int=-1 amr.check_int=-1
31 changes: 31 additions & 0 deletions Exec/RegTests/EnclosedInjection/GNUmakefile
Original file line number Diff line number Diff line change
@@ -0,0 +1,31 @@
TOP = ../../../..
AMREX_HOME ?= ${TOP}/amrex
PELELMEX_HOME ?= ${TOP}/PeleLMeX
PELE_PHYSICS_HOME ?= ${TOP}/PelePhysics
AMREX_HYDRO_HOME ?= ${TOP}/AMReX-Hydro


# AMReX
DIM = 3
DEBUG = FALSE
PRECISION = DOUBLE
VERBOSE = FALSE
TINY_PROFILE = FALSE

# Compilation
COMP = gnu
USE_MPI = TRUE
USE_OMP = FALSE
USE_CUDA = FALSE
USE_HIP = FALSE

# PeleLMeX

# PelePhysics
Chemistry_Model = drm19
Eos_Model = Fuego
Transport_Model = Simple

USE_SUNDIALS_PP = TRUE

include $(PELELMEX_HOME)/Utils/Make.PeleLMeX
94 changes: 94 additions & 0 deletions Exec/RegTests/EnclosedInjection/input.2d-regt
Original file line number Diff line number Diff line change
@@ -0,0 +1,94 @@
#----------------------DOMAIN DEFINITION------------------------
geometry.is_periodic = 0 0 0 # For each dir, 0: non-perio, 1: periodic
geometry.coord_sys = 0 # 0 => cart, 1 => RZ
geometry.prob_lo = -0.5 -0.5 0 # x_lo y_lo (z_lo)
geometry.prob_hi = 0.5 0.5 1 # x_hi y_hi (z_hi)

# >>>>>>>>>>>>> BC FLAGS <<<<<<<<<<<<<<<<
# Interior, Inflow, Outflow, Symmetry,
# SlipWallAdiab, NoSlipWallAdiab, SlipWallIsotherm, NoSlipWallIsotherm
peleLM.lo_bc = NoSlipWallAdiab NoSlipWallAdiab Inflow
peleLM.hi_bc = NoSlipWallAdiab NoSlipWallAdiab NoSlipWallAdiab


#-------------------------AMR CONTROL----------------------------
amr.n_cell = 32 32 32 # 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 = 1 # how often to regrid
amr.n_error_buf = 2 2 2 2 # number of buffer cells in error est
amr.grid_eff = 0.7 # what constitutes an efficient grid
amr.blocking_factor = 4 # block factor in grid generation (min box size)
amr.max_grid_size = 64 # max box size


#--------------------------- Problem -------------------------------
prob.P_mean = 101325.0
prob.T_mean = 300.0
prob.T_jet = 300.0
prob.V_jet = 10.0
prob.jet_rad = 0.1

#-------------------------PeleLM CONTROL----------------------------
peleLM.v = 3
peleLM.incompressible = 0
peleLM.rho = 1.17
peleLM.mu = 0.0
peleLM.gravity = 0.0 0.0 0.0
# Diffusion
peleLM.use_wbar = 1
deltaT_verbose = 1
deltaT_iterMax = 10
deltaT_tol = 1e-8
# Advance
peleLM.sdc_iterMax = 1
peleLM.floor_species = 0
# Reaction
peleLM.do_react = 1
peleLM.use_typ_vals_chem = 1
peleLM.typical_values_reset_int = 10
# Advection
# Temporals
peleLM.do_temporals = 1
peleLM.temporal_int = 1
peleLM.mass_balance = 1
# Chamber
peleLM.closed_chamber = 1

godunov.use_ppm = 0

amr.plot_int = 10
amr.max_step = 100000
amr.dt_shrink = 0.1
amr.dt_change_max = 1.1
amr.max_dt = 0.5
amr.stop_time = 0.05
amr.cfl = 0.7
amr.derive_plot_vars = avg_pressure mag_vort mass_fractions

cvode.solve_type = dense # CVODE Linear solve type (for Newton direction)
ode.analytical_jacobian = 0 # Provide analytical jacobian (from Fuego)

#--------------------REFINEMENT CONTROL------------------------
#amr.refinement_indicators = temp
#amr.temp.max_level = 10
#amr.temp.value_greater = 800
#amr.temp.field_name = temp

#amr.refinement_indicators = magVort
#amr.magVort.max_level = 1
#amr.magVort.value_greater = 500.0
#amr.magVort.field_name = mag_vort

#amr.refinement_indicators = yH2
#amr.yH2.max_level = 10
#amr.yH2.value_greater = 1.0e-8
#amr.yH2.adjacent_difference_greater = 1e-2
#amr.yH2.field_name = Y(H2)



#amrex.fpe_trap_invalid = 1
#amrex.fpe_trap_zero = 1
#amrex.fpe_trap_overflow = 1
169 changes: 169 additions & 0 deletions Exec/RegTests/EnclosedInjection/pelelm_prob.H
Original file line number Diff line number Diff line change
@@ -0,0 +1,169 @@
#ifndef PELELM_PROB_H_
#define PELELM_PROB_H_

#include <AMReX_Geometry.H>
#include <AMReX_FArrayBox.H>
#include <AMReX_SPACE.H>

#include <PeleLM_Index.H>
#include <pelelm_prob_parm.H>
#include <PMFData.H>
#include <PelePhysics.H>

AMREX_GPU_DEVICE
AMREX_FORCE_INLINE
void pelelm_initdata(int i, int j, int k,
int is_incompressible,
amrex::Array4<amrex::Real> const& state,
amrex::Array4<amrex::Real> 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();

AMREX_D_TERM(const amrex::Real x = prob_lo[0] + (i+0.5)*dx[0];,
const amrex::Real y = prob_lo[1] + (j+0.5)*dx[1];,
const amrex::Real z = prob_lo[2] + (k+0.5)*dx[2];);

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 = prob_hi[2] - prob_lo[2]);

constexpr amrex::Real Pi = 3.14159265358979323846264338327950288;

auto eos = pele::physics::PhysicsType::eos();
amrex::Real massfrac[NUM_SPECIES] = {0.0};

state(i,j,k,TEMP) = prob_parm.T_mean;

massfrac[O2_ID] = 0.233;
massfrac[N2_ID] = 0.767;

AMREX_D_TERM(state(i,j,k,VELX) = 0.0;,
state(i,j,k,VELY) = 0.0;,
state(i,j,k,VELZ) = 0.0);

amrex::Real P_cgs = prob_parm.P_mean * 10.0;

// Density
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;

// Enthalpy
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);

// Species mass
for (int n = 0; n < NUM_SPECIES; n++) {
state(i,j,k,FIRSTSPEC+n) = massfrac[n] * state(i,j,k,DENSITY);
}
}

AMREX_GPU_DEVICE
AMREX_FORCE_INLINE
void
bcnormal(
const amrex::Real x[AMREX_SPACEDIM],
const int m_nAux,
amrex::Real s_ext[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)
{

auto eos = pele::physics::PhysicsType::eos();
amrex::Real massfrac[NUM_SPECIES] = {0.0};
amrex::Real molefrac[NUM_SPECIES] = {0.0};
amrex::Real X_air[NUM_SPECIES] = {0.0};
amrex::Real Y_air[NUM_SPECIES] = {0.0};
amrex::Real X_jet[NUM_SPECIES] = {0.0};
amrex::Real Y_jet[NUM_SPECIES] = {0.0};
amrex::Real eta = 0.0;
amrex::Real p_int;

const amrex::Real* prob_lo = geomdata.ProbLo();
const amrex::Real* prob_hi = geomdata.ProbHi();
const amrex::Real* dx = geomdata.CellSize();

// Simple, air into air injection
X_air[O2_ID] = 0.21;
X_air[N2_ID] = 1.0 - X_air[O2_ID];

X_jet[O2_ID] = 0.21;
X_jet[N2_ID] = 1.0 - X_air[O2_ID];

eos.X2Y(X_air, Y_air);
eos.X2Y(X_jet, Y_jet);

if (idir == 2 and sgn == 1){

if (time <= 0.1){

eta = 0.5 * (1.0 - tanh( (sqrt(x[0]*x[0] + x[1]*x[1]) - prob_parm.jet_rad) / (prob_parm.bl_thickness / 4.0)));

for (int n = 0; n < NUM_SPECIES; n++) {
massfrac[n] = eta * Y_jet[n] + (1.0 - eta) * Y_air[n];
}

amrex::Real rho_cgs, P_cgs, RhoH_temp;
P_cgs = prob_parm.P_mean * 10.0;

s_ext[TEMP] = eta * prob_parm.T_jet + (1.0 - eta) * prob_parm.T_mean;

eos.PYT2R(P_cgs, massfrac, s_ext[TEMP], rho_cgs);
s_ext[DENSITY] = rho_cgs * 1.0e3;

eos.TY2H(s_ext[TEMP], massfrac, RhoH_temp);
s_ext[RHOH] = RhoH_temp * 1.0e-4 * s_ext[DENSITY]; // CGS -> MKS conversion

for (int n = 0; n < NUM_SPECIES; n++) {
s_ext[FIRSTSPEC + n] = massfrac[n] * s_ext[DENSITY];
}

// Velocity
s_ext[VELX] = 0.0;
s_ext[VELY] = 0.0;
s_ext[VELZ] = eta * prob_parm.V_jet;
}

}

}

AMREX_GPU_DEVICE
AMREX_FORCE_INLINE
void
zero_visc (int i, int j, int k,
amrex::Array4<amrex::Real> 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, ...)
if (beta_comp == 0 && nComp == NUM_SPECIES) {
if (dir == 2 && k <= domainBox.smallEnd(dir)) {
const amrex::Real* prob_lo = geomdata.ProbLo();
const amrex::Real* prob_hi = geomdata.ProbHi();
const amrex::Real* dx = geomdata.CellSize();

// Just over whole inlet
for (int n = 0; n < nComp; n++) {
beta(i,j,k,n) = 0.0;
}
}
}
}

#endif
15 changes: 15 additions & 0 deletions Exec/RegTests/EnclosedInjection/pelelm_prob.cpp
Original file line number Diff line number Diff line change
@@ -0,0 +1,15 @@
#include <PeleLM.H>
#include <AMReX_ParmParse.H>
#include <pmf.H>

void PeleLM::readProbParm()
{
amrex::ParmParse pp("prob");

pp.query("P_mean", prob_parm->P_mean);
pp.query("T_mean", prob_parm->T_mean);
pp.query("T_jet", prob_parm->T_jet);
pp.query("V_jet", prob_parm->V_jet);
pp.query("jet_rad", prob_parm->jet_rad);
pp.query("bl_thickness", prob_parm->bl_thickness);
}
17 changes: 17 additions & 0 deletions Exec/RegTests/EnclosedInjection/pelelm_prob_parm.H
Original file line number Diff line number Diff line change
@@ -0,0 +1,17 @@
#ifndef PELELM_PROB_PARM_H_
#define PELELM_PROB_PARM_H_

#include <AMReX_REAL.H>

using namespace amrex::literals;

struct ProbParm
{
amrex::Real P_mean = 101325.0_rt;
amrex::Real T_mean = 300.0_rt;
amrex::Real T_jet = 1000.0_rt;
amrex::Real V_jet = 1.0_rt;
amrex::Real jet_rad = 0.25_rt;
amrex::Real bl_thickness= 0.01_rt;
};
#endif
15 changes: 9 additions & 6 deletions Exec/RegTests/TurbInflow/input.3d
Original file line number Diff line number Diff line change
Expand Up @@ -29,12 +29,15 @@ prob.P_mean = 101325.0
prob.flowDir = 2
prob.flowMag = 5

turbinflow.turb_file = TurbFileHIT/TurbTEST
turbinflow.turb_scale_loc = 633.151
turbinflow.turb_scale_vel = 0.5
turbinflow.turb_center = 0.005 0.005
turbinflow.turb_conv_vel = 5.
turbinflow.turb_nplane = 32
turbinflows = lowZ
turbinflow.lowZ.turb_file = TurbFileHIT/TurbTEST
turbinflow.lowZ.dir = 2
turbinflow.lowZ.side = low
turbinflow.lowZ.turb_scale_loc = 633.151
turbinflow.lowZ.turb_scale_vel = 0.5
turbinflow.lowZ.turb_center = 0.005 0.005
turbinflow.lowZ.turb_conv_vel = 5.
turbinflow.lowZ.turb_nplane = 32

#------------ INPUTS TO CONSTANT TRANSPORT -----------------
transport.const_viscosity = 0.0001
Expand Down
15 changes: 9 additions & 6 deletions Exec/RegTests/TurbInflow/input.3d_BoxLoZ
Original file line number Diff line number Diff line change
Expand Up @@ -29,12 +29,15 @@ prob.P_mean = 101325.0
prob.flowDir = 2
prob.flowMag = 5

turbinflow.turb_file = TurbFileHIT/TurbTEST
turbinflow.turb_scale_loc = 633.151
turbinflow.turb_scale_vel = 0.5
turbinflow.turb_center = 0.005 0.005
turbinflow.turb_conv_vel = 5.
turbinflow.turb_nplane = 32
turbinflows = lowZ
turbinflow.lowZ.turb_file = TurbFileHIT/TurbTEST
turbinflow.lowZ.dir = 2
turbinflow.lowZ.side = low
turbinflow.lowZ.turb_scale_loc = 633.151
turbinflow.lowZ.turb_scale_vel = 0.5
turbinflow.lowZ.turb_center = 0.005 0.005
turbinflow.lowZ.turb_conv_vel = 5.
turbinflow.lowZ.turb_nplane = 32

#------------ INPUTS TO CONSTANT TRANSPORT -----------------
transport.const_viscosity = 0.0001
Expand Down
Loading

0 comments on commit 375e861

Please sign in to comment.