Runtime Parameters Documentation for FLASH Release 3.2


Driver/DriverMain
    dr_abortPause [INTEGER] [2]
        Valid Values: 0 to INFTY
        When Driver_abortFlash is called to abnormally end execution, and
        dr_abortPause is grater than zero, the FLASH Driver_abortFlash code will
        sleep for dr_abortPause seconds after writing explanatory messages (to
        standard output and, possibly, to log files) but before calling
        MPI_ABORT. See also eachProcWritesOwnAbortLog for controlling the
        generation of per-processor log files.
    dtinit [REAL] [1.E-10]
        Valid Values: Unconstrained
        Initial timestep
    dtmax [REAL] [1.E5]
        Valid Values: Unconstrained
        Maximum timestep
    dtmin [REAL] [1.E-10]
        Valid Values: Unconstrained
        Minimum timestep
    eachProcWritesOwnAbortLog [BOOLEAN] [FALSE]
        Should each process writes messages to its own log file when
        Driver_abortFlash gets called to abnormally end execution? If true, each
        process in which Driver_abortFlash is called will attempt to write an
        explanatory message to its own log file, whether that file already
        existed or needs to be newly created.  If false, the Driver_abortFlash
        message will appear only in the regular log file (if the Logfile code
        unit is used), and normally only when Driver_abortFlash is called by the
        process with PE 0.
    nbegin [INTEGER] [1]
        Valid Values: 1 to INFTY
        First timestep
    nend [INTEGER] [100]
        Valid Values: Unconstrained
        Maximum number of timesteps to take
    restart [BOOLEAN] [FALSE]
        Is this a restart run?
    sweepOrder [INTEGER] [123]
        Valid Values: 123, 132, 213, 231, 312, 321
        Determine the order of the directional sweeps
    tinitial [REAL] [0.0]
        Valid Values: Unconstrained
        Initial simulation time
    tmax [REAL] [0.2]
        Valid Values: Unconstrained
        Maximum simulation time
    tstep_change_factor [REAL] [2.0]
        Valid Values: Unconstrained
        The initial dt is multiplied with this factor at & every timestep, until
        it is limited by CFL condition & allowing users to specify very
        conservative initial dt.
    wall_clock_time_limit [REAL] [604800.]
        Valid Values: Unconstrained
        Total wall clock time limit (seconds)
    zFinal [REAL] [0.0]
        Valid Values: Unconstrained
        The final redshift in a simulation.  The simulation will stop
    zInitial [REAL] [-1.0]
        Valid Values: Unconstrained
        The initial redshift in a simulation.  < 0 if not being used.

Grid/GridMain
    bndPriorityOne [INTEGER] [1]
        Valid Values: 1, 2, 3
        indicates the direction (IAXIS, JAXIS or KAXIS) gets top priority when
        applying boundary conditions in corner guardcells We define three values
        for edges left, center, right, of which center represents interior,
        while left and right represent the corresponding guardcells. We define a
        corner where more than one dimension has its its guardcells, so the
        application must determine which direction gets to fill them. In 2-D,
        there are four corners: (left,left), (left,right), (right,left) and
        (right,right). In 3-D case, the following corners are possible :
        (left,left,left),(left,left,center),
        (left,left,right),(left,center,left),
        (left,center,right),(left,right,left),
        (left,right,center),(left,right,right)
        (center,left,left),(center,left,right),
        (center,right,left),(center,right,right),
        (right,left,left),(right,left,center),
        (right,left,right),(right,center,left),
        (right,center,right),(right,right,left),
        (right,right,center),(right,right,right)
    bndPriorityThree [INTEGER] [3]
        Valid Values: 1, 2, 3
        the least priority dimension in applying boundary conditions
    bndPriorityTwo [INTEGER] [2]
        Valid Values: 1, 2, 3
        the second priority dimension in applying boundary conditions
    convertToConsvdForMeshCalls [BOOLEAN] [FALSE]
        indicates if appropriate variables are converted from primitive to
        conserved form during propagation before control is passed to Paramesh
        for refinement, derefinement, or guardcell filling.  This is the old way
        of ensuring that solution variables are in the correct form for
        interpolation. It involves unnecessary conversions back and forth and
        should be obsoleted by the newer mechanism enabled by runtime parameter
        "convertToConsvdInMeshInterp".  The name is a replacement for the old
        "conserved_var" which many people have found to be very confusing
        terminology.
    eosMode [STRING] ["dens_ie"]
        Valid Values: "dens_ie", "dens_pres", "dens_temp"
        determines how to operate on thermodynamic quantities Possible values
        are "dens_ie", where density and internal energy are supplied and
        pressure and temperature are returned; "dens_pres", where density and
        pressure are given and energy and temperature are computed;  and
        "dens_temp", where density and temperature are given and pressure and
        energy are computed. In future other values may become available as
        relativistic physics is implemented in the code
    eosModeInit [STRING] ["dens_ie"]
        Valid Values: "dens_ie", "dens_pres", "dens_temp"
        determines how to operate on thermodynamic quantities for the initial
        conditions.  A call to Simulation_initBlock sets initial conditions on
        each block, and an eos call follows which ensures the initial values are
        thermodynamically consistent.  The value of eosModeInit determines the
        mode in which these eos calls operate.  Possible values are "dens_ie",
        where density and internal energy are supplied and pressure and
        temperature are returned; "dens_pres", where density and pressure are
        given and energy and temperature are computed; and "dens_temp", where
        density and temperature are given and pressure and energy are computed. 
        In future other values may become available as relativistic physics is
        implemented in the code
    geometry [STRING] ["cartesian"]
        Valid Values: "cartesian", "polar", "cylindrical", "spherical"
        Grid geometry
    grav_boundary_type [STRING] ["isolated"]
        Valid Values: Unconstrained
        Type of gravitational boundary condition
    smalle [REAL] [1.E-10]
        Valid Values: Unconstrained
        Cutoff value for energy
    smallx [REAL] [1.E-10]
        Valid Values: Unconstrained
        Cutoff value for abundances
    unbiased_geometry [BOOLEAN] [FALSE]
        attempt to remove floating point bias from geometry discretization. Not
        implemented in FLASH3.
    xl_boundary_type [STRING] ["periodic"]
        Valid Values: Unconstrained
        lower (left) boundary condition in x dir
    xmax [REAL] [1.]
        Valid Values: Unconstrained
        physical domain upper bound in x dir
    xmin [REAL] [0.]
        Valid Values: Unconstrained
        physical domain lower bound in x dir
    xr_boundary_type [STRING] ["periodic"]
        Valid Values: Unconstrained
        upper (right) boundary condition in x dir
    yl_boundary_type [STRING] ["periodic"]
        Valid Values: Unconstrained
        lower boundary condition in y dir
    ymax [REAL] [1.]
        Valid Values: Unconstrained
        physical domain upper bound in y dir
    ymin [REAL] [0.]
        Valid Values: Unconstrained
        physical domain lower bound in y dir
    yr_boundary_type [STRING] ["periodic"]
        Valid Values: Unconstrained
        upper boundary condition in y dir
    zl_boundary_type [STRING] ["periodic"]
        Valid Values: Unconstrained
        lower boundary condition in z dir
    zmax [REAL] [1.]
        Valid Values: Unconstrained
        physical domain lower bound in x dir
    zmin [REAL] [0.]
        Valid Values: Unconstrained
        physical domain lower bound in z dir
    zr_boundary_type [STRING] ["periodic"]
        Valid Values: Unconstrained
        upper boundary condition in z dir

Grid/GridMain/UG
    compute_grid_size [BOOLEAN] [true]
        compute grid size in the case of non-fixed-block size, non fixed block
        size mode means block dims are not specified at compile time
    flux_correct [BOOLEAN] [false]
        turns flux correction on or off in UG always false since all blocks on
        same level
    iGridSize [INTEGER] [1]
        Valid Values: Unconstrained
        Global number of interior cells in the i direction ONLY needed when
        running in NON_FIXED_BLOCKSIZE mode (ie. don't need for Paramesh or
        simple Uniform Grid)
    iProcs [INTEGER] [1]
        Valid Values: Unconstrained
        number of procs in the i dir
    iguard [INTEGER] [4]
        Valid Values: Unconstrained
        number of guardcells in i direction.  Not yet in use.
    jGridSize [INTEGER] [1]
        Valid Values: Unconstrained
        Global number of interior cells in the j direction ONLY needed when
        running in NON_FIXED_BLOCKSIZE mode (ie. don't need for Paramesh or
        simple Uniform Grid)
    jProcs [INTEGER] [1]
        Valid Values: Unconstrained
        number of procs in the j dir
    jguard [INTEGER] [4]
        Valid Values: Unconstrained
        number of guardcells in j direction, this is only implemented for nfbs
    kGridSize [INTEGER] [1]
        Valid Values: Unconstrained
        Global number of interior cells in the k direction ONLY needed when
        running in NON_FIXED_BLOCKSIZE mode (ie. don't need for Paramesh or
        simple Uniform Grid)
    kProcs [INTEGER] [1]
        Valid Values: Unconstrained
        number of procs in the k dir
    kguard [INTEGER] [4]
        Valid Values: Unconstrained
        number of guardcells in k direction
    nblockx [INTEGER] [1]
        Valid Values: Unconstrained
        number of blocks along X - ignored by UG Grid
    nblocky [INTEGER] [1]
        Valid Values: Unconstrained
        number of blocks along Y - ignored by UG Grid
    nblockz [INTEGER] [1]
        Valid Values: Unconstrained
        number of blocks along Z - ignored by UG Grid
    smallp [REAL] [1.E-10]
        Valid Values: Unconstrained
        Cutoff value for pressure
    smallt [REAL] [1.E-10]
        Valid Values: Unconstrained
        Cutoff value for temperature
    smallu [REAL] [1.E-10]
        Valid Values: Unconstrained
        Cutoff value for velocity
    smlrho [REAL] [1.E-10]
        Valid Values: Unconstrained
        Cutoff value for density

Grid/GridMain/paramesh
    convertToConsvdInMeshInterp [BOOLEAN] [TRUE]
        indicates if appropriate variables are converted to conserved form
        during propagation within the interpolation routines invoked by
        Paramesh. This applies to interpolation (both "prolongation" and
        "restriction") in the course of refinement, derefinement, or guardcell
        filling. This is the newer way of ensuring that solution variables are
        interpolated in the correct form. It avoids unnecessary conversions back
        and force and should replace the old mechanism enabled by runtime
        parameter "convertToConsvdForMeshCalls". However, it is only available
        with PARAMESH 3 or later.
    derefine_cutoff_1 [REAL] [0.2]
        Valid Values: Unconstrained
        threshold value to trigger derefinement for refine_var_1
    derefine_cutoff_2 [REAL] [0.2]
        Valid Values: Unconstrained
        threshold value to trigger derefinement for refine_var_2
    derefine_cutoff_3 [REAL] [0.2]
        Valid Values: Unconstrained
        threshold value to trigger derefinement for refine_var_3
    derefine_cutoff_4 [REAL] [0.2]
        Valid Values: Unconstrained
        threshold value to trigger derefinement for refine_var_4
    earlyBlockDistAdjustment [BOOLEAN] [TRUE]
        If true, let Paramesh redistribute blocks across processors early, so
        that the block distribution chosen by Paramesh will be in effect when
        time evolution begins after restart. If earlyBlockDistAdjustment is
        false, the block distribution enacted by the IO unit when it read a
        checkpoint file will normally still be in effect when time evolution
        begins after a restart. This flag is ignored if not restarting from a
        checkpoint.
    flux_correct [BOOLEAN] [true]
        turns on or off flux correction
    gr_lrefineMaxRedDoByLogR [BOOLEAN] [FALSE]
        Softly force effectively a lower lrefine_max depending on distance from
        center. See gr_lrefineMaxRedRadiusFact.
    gr_lrefineMaxRedDoByTime [BOOLEAN] [FALSE]
        Lower the effective lrefine_max as a function of time. See runtime
        parameters gr_lrefineMaxRedTRef, gr_lrefineMaxRedTimeScale, and
        gr_lrefineMaxRedLogBase.
    gr_lrefineMaxRedLogBase [REAL] [10.0]
        Valid Values: TINY to INFTY
        Logarithm base for determining when repeated reductions in effective
        lrefine_max should happen. The nth reduction will happen at
        t=gr_lrefineMaxRedTRef+gr_lrefineMaxRedTimeScale*gr_lrefineMaxRedLogBase**(n-1).
    gr_lrefineMaxRedRadiusFact [REAL] [0.0]
        Valid Values: Unconstrained
        factor that determines a minimum resolution (and thus maximum refinement
        level) based on distance from a center. See x_refine_center,
        y_refine_center, z_refine_center for the center coordinates.  This is
        approximately (linearly) equivalent to requiring a minimum *angular*
        resolution, within the limits set by the global lrefine_min and
        lrefine_max.  Only used when gr_lrefineMaxRedDoByLogR is TRUE.
    gr_lrefineMaxRedTRef [REAL] [0.0]
        Valid Values: Unconstrained
        reference time for time-based max level reduction. The effective
        reduction of lrefine_max only kicks in for times greater than
        gr_lrefineMaxRedTRef. The first time lrefine_max is effectively lowered
        actually happens at t=gr_lrefineMaxRedTRef+gr_lrefineMaxRedTimeScale.
    gr_lrefineMaxRedTimeScale [REAL] [1.0]
        Valid Values: TINY to INFTY
        the time scale for effectively lowering lrefine_max: The first reduction
        takes place at t=gr_lrefineMaxRedTRef+gr_lrefineMaxRedTimeScale.
    interpol_order [INTEGER] [2]
        Valid Values: 0, 1, 2
        the default interpolation order when using "monotonic" interpolation
        routines
    lrefine_del [INTEGER] [0]
        Valid Values: Unconstrained
        Try to reduce the maximum refinement level by this number of levels on a
        restart.
    lrefine_max [INTEGER] [1]
        Valid Values: Unconstrained
        maximum AMR refinement level
    lrefine_max_prev [INTEGER] [1]
        Valid Values: Unconstrained
        for now a hack
    lrefine_min [INTEGER] [1]
        Valid Values: Unconstrained
        minimum AMR refinement level
    max_particles_per_blk [INTEGER] [100]
        Valid Values: Unconstrained
        integer  if the number of particles in a block exceeds this, it must
        refine  when particle count is a refinement criterion
    min_particles_per_blk [INTEGER] [1]
        Valid Values: Unconstrained
        integer  if the number of particles in a block is below this, it must
        derefine when particle count is a refinement criterion
    nblockx [INTEGER] [1]
        Valid Values: Unconstrained
        num initial blocks in x dir
    nblocky [INTEGER] [1]
        Valid Values: Unconstrained
        num initial blocks in y dir
    nblockz [INTEGER] [1]
        Valid Values: Unconstrained
        num initial blocks in z dir
    nrefs [INTEGER] [2]
        Valid Values: Unconstrained
        refine/derefine AMR grid every nrefs timesteps
    refine_cutoff_1 [REAL] [0.8]
        Valid Values: Unconstrained
        threshold value to trigger refinement for refine_var_1
    refine_cutoff_2 [REAL] [0.8]
        Valid Values: Unconstrained
        threshold value to trigger refinement for refine_var_2
    refine_cutoff_3 [REAL] [0.8]
        Valid Values: Unconstrained
        threshold value to trigger refinement for refine_var_3
    refine_cutoff_4 [REAL] [0.8]
        Valid Values: Unconstrained
        threshold value to trigger refinement for refine_var_4
    refine_filter_1 [REAL] [0.01]
        Valid Values: Unconstrained
        prevents error calculations to determine refinement from diverging
        numerically for refine_var_1
    refine_filter_2 [REAL] [0.01]
        Valid Values: Unconstrained
        prevents error calculations to determine refinement from diverging
        numerically for refine_var_1
    refine_filter_3 [REAL] [0.01]
        Valid Values: Unconstrained
        prevents error calculations to determine refinement from diverging
        numerically for refine_var_3
    refine_filter_4 [REAL] [0.01]
        Valid Values: Unconstrained
        prevents error calculations to determine refinement from diverging
        numerically for refine_var_4
    refine_on_particle_count [BOOLEAN] [false]
        if true, the count of particles in blocks act as a refinement criterion
    refine_var_1 [STRING] ["none"]
        Valid Values: Unconstrained
        indicates 1st variable on which to refine
    refine_var_2 [STRING] ["none"]
        Valid Values: Unconstrained
        indicates 2nd variable on which to refine
    refine_var_3 [STRING] ["none"]
        Valid Values: Unconstrained
        indicates 3rd variable on which to refine
    refine_var_4 [STRING] ["none"]
        Valid Values: Unconstrained
        indicates 4th variable on which to refine
    refine_var_count [INTEGER] [4]
        Valid Values: Unconstrained
        count of maximum allowed variable to be used
    small [REAL] [1.E-10]
        Valid Values: Unconstrained
        Cutoff value ... DEV: for what?
    smallp [REAL] [1.E-10]
        Valid Values: Unconstrained
        Cutoff value for pressure
    smallt [REAL] [1.E-10]
        Valid Values: Unconstrained
        Cutoff value for temperature
    smallu [REAL] [1.E-10]
        Valid Values: Unconstrained
        Cutoff value for velocity
    smlrho [REAL] [1.E-10]
        Valid Values: Unconstrained
        Cutoff value for density
    x_refine_center [REAL] [0.0]
        Valid Values: Unconstrained
        First coordinate of center for distance-based refinement patterns
    y_refine_center [REAL] [0.0]
        Valid Values: Unconstrained
        Second coordinate of center for distance-based refinement patterns
    z_refine_center [REAL] [0.0]
        Valid Values: Unconstrained
        Third coordinate of center for distance-based refinement patterns

Grid/GridMain/paramesh/Paramesh2
    msgbuf [INTEGER] [1]
        Valid Values: Unconstrained
        triggers consolication of MPI messages in PM2. 1 indicates to
        "consolidate". PM2 specific, should always stay at 1

Grid/GridMain/paramesh/Paramesh2/quadratic_cartesian
    grid_monotone_hack [BOOLEAN] [TRUE]
        If .true., apply radical monotonicity constraints to interpolants (i.e.,
        completely flatten them if they violate monotonicity)

Grid/GridMain/paramesh/paramesh4
    enableMaskedGCFill [BOOLEAN] [FALSE]
        When enableMaskedGCFill is FALSE, Grid_fillGuardCells is forced to
        always ignore optional mask arguments when present in calls. This is the
        default behavior. Set enableMaskedGCFill TRUE to enable masked guard
        cell filling.

Grid/GridParticles
    gr_ptNumToReduce [INTEGER] [10]
        Valid Values: Unconstrained
        integer  if particles are to be removed at runtime, how many
    gr_ptRemove [BOOLEAN] [FALSE]
        boolean.  This is a switch which determines the action if the number
    gr_ptRemoveAlgo [INTEGER] [2]
        Valid Values: Unconstrained
        integer  The algorithm used in determining which particles to remove

Grid/GridParticles/GridParticlesMove
    gr_ptNumToReduce [INTEGER] [10]
        Valid Values: Unconstrained
        integer  if particles are to be removed at runtime, how many
    gr_ptRemove [BOOLEAN] [FALSE]
        boolean.  This is a switch which determines the action if the number
    gr_ptRemoveAlgo [INTEGER] [2]
        Valid Values: Unconstrained
        integer  The algorithm used in determining which particles to remove

Grid/GridParticles/GridParticlesMove/Paramesh
    gr_ptMaxPerProcBlockFactor [REAL] [0.70]
        Valid Values: 0.0 to 1.0
        When the effective max_particles_per_blk is lowered on a processor
        because refinement criteria based on the number of particles PER
        PROCESSOR are used, then the new effective max_particles_per_blk is set
        to (gr_ptMaxPerProcBlockFactor * pt_maxPerProc). In addition, when the
        effective min_particles_per_blk is lowered on a processor because
        refinement criteria based on the number of particles PER PROCESSOR are
        used, then the new effective min_particles_per_blk is set to (0.5^NDIM *
        gr_ptMaxPerProcBlockFactor * pt_maxPerProc).
    gr_ptMaxPerProcBlockNoFuzz [INTEGER] [3]
        Valid Values: 0 to INFTY
        A safety margin for estimating the size of basically unpredictable
        changes of the number of blocks on a processor when remeshing happens.
    gr_ptMaxPerProcLowerThresh [REAL] [0.0625]
        Valid Values: 0.0 to 1.0
        A threshold. When the number of particles on a processor gets above
        (ptMaxPerProcLowerThresh * number of blocks on the processor), the
        effective min_particles_per_blk for blocks on this processor may be
        lowered.
    gr_ptMaxPerProcUpperThresh [REAL] [0.25]
        Valid Values: 0.0 to 1.0
        A threshold. When the number of particles on a processor gets above
        (ptMaxPerProcUpperThresh * number of blocks on the processor), the
        effective max_particles_per_blk for blocks on this processor may be
        lowered.
    gr_ptRefineOnPtMaxPerProc [BOOLEAN] [FALSE]
        controls whether refinement criteria based on the number of particles
        PER PROCESSOR are used. These work by strengthening refinement criteria
        requested through the max_particles_per_blk and min_particles_per_blk
        RPs.  Requires RP refine_on_particle_count to be TRUE.

Grid/GridSolvers/IsoBndMultipole
    mpole_lmax [INTEGER] [0]
        Valid Values: Unconstrained
        Maximum multipole moment to use
    octant [BOOLEAN] [false]
        In 3d cartesian geometry, assume symmetry about left-facing volume faces
    quadrant [BOOLEAN] [false]
        In 2d cylindrical coords, assume symmetry about grid bottom to evolve a
        quadrant

Grid/GridSolvers/Multigrid
    mg_maxCorrections [INTEGER] [100]
        Valid Values: Unconstrained
        Maximum number of correction V-cycles to employ.
    mg_maxResidualNorm [REAL] [1.E-6]
        Valid Values: Unconstrained
        Apply V-cycle corrections until this residual norm is reached or
        mg_maxCorrections V-cycles have been performed.
    mg_printNorm [BOOLEAN] [TRUE]
        If .true., print the ratio of the residual norm to the source norm as
        each V-cycle is completed.
    quadrant [BOOLEAN] [false]
        True if only one quadrant is being calculated in 2-d cylindrical
        coordinates

Grid/GridSolvers/Multigrid/PfftTopLevelSolve
    xl_mg_boundary_type [STRING] ["periodic"]
        Valid Values: Unconstrained
        lower (left) boundary condition in x dir
    xr_mg_boundary_type [STRING] ["periodic"]
        Valid Values: Unconstrained
        upper (right) boundary condition in x dir
    yl_mg_boundary_type [STRING] ["periodic"]
        Valid Values: Unconstrained
        lower boundary condition in y dir
    yr_mg_boundary_type [STRING] ["periodic"]
        Valid Values: Unconstrained
        upper boundary condition in y dir
    zl_mg_boundary_type [STRING] ["periodic"]
        Valid Values: Unconstrained
        lower boundary condition in z dir
    zr_mg_boundary_type [STRING] ["periodic"]
        Valid Values: Unconstrained
        upper boundary condition in z dir

Grid/GridSolvers/Multipole
    mpole_3daxisymmetric [BOOLEAN] [false]
        In 3d cartesian geometry, use only m=0 multipole moments
    mpole_dumpMoments [BOOLEAN] [false]
        Should the Moment array be dumped at each timestep?
    mpole_lmax [INTEGER] [0]
        Valid Values: Unconstrained
        Maximum multipole moment to use
    mpole_subSample [INTEGER] [1]
        Valid Values: 1 to 12
        Integer which controls the sub-sampling in the mpole_potential routine
        and mpole_moments routine.  Set to smaller numbers to make potential
        calculations (slightly) less smooth and faster. Was hardcoded in Flash2
        as Nint6 = 6 in mpole_potential and Nint=2 in mpole_moments
    mpole_useMatrixMPI [BOOLEAN] [false]
        Switch added during the DAT to calculate MPI_allreduce in a matrix
        fashion & Set to .false. to retain the previous behaviour
    octant [BOOLEAN] [false]
        In 3d cartesian geometry, assume symmetry about left-facing volume faces
    quadrant [BOOLEAN] [false]
        In 2d cylindrical coords, assume symmetry about grid bottom to evolve a
        quadrant

Grid/GridSolvers/Pfft
    pfft_setupOnce [BOOLEAN] [TRUE]


IO/IOMain
    alwaysComputeUserVars [BOOLEAN] [true]
        Allows the user to force the computation of user variables (i.e. those
        computed by Grid_computeUserVars) for all checkpoint files.  Defaults to
        true.  If set to false, lone calls to IO_writeCheckpoint will not call
        Grid_computeUserVars.  Plotfiles always call Grid_computeUserVars.
    alwaysRestrictCheckpoint [BOOLEAN] [true]
        Allows the user to choose whether checkpoint file data is always
        restricted, so all ancestor blocks have valid data. The default is true.
        It can be set to false for debugging purposes, in which case only the
        data from IO_output will be guaranteed to have fully restricted data. 
        See the User's guide for more information.
    basenm [STRING] ["flash_"]
        Valid Values: Unconstrained
        Base name for checkpoint files
    bytePack [BOOLEAN] [FALSE]
        compress plotfile data to bytes !!Only implemented with UG in hdf5 !!!
        !!Not tested
    checkpointFileIntervalStep [INTEGER] [0]
        Valid Values: Unconstrained
        Checkpoint after this many steps
    checkpointFileIntervalTime [REAL] [1.]
        Valid Values: Unconstrained
        Checkpoint after this much time
    checkpointFileIntervalZ [REAL] [HUGE(1.)]
        Valid Values: Unconstrained

    checkpointFileNumber [INTEGER] [0]
        Valid Values: Unconstrained
        Initial checkpoint file number (used for restarts as well)
    chkGuardCellsInput [BOOLEAN] [FALSE]
        if true guardcells are read from the checkpoint file. Default is false
        where only interior cells are read and written. Currently only
        implemented with hdf5 parallel paramesh IO implementation
    chkGuardCellsOutput [BOOLEAN] [FALSE]
        if true guardcells are written the checkpoint file.
    corners [BOOLEAN] [FALSE]
        does nothing.  However, it is part of the checkpoint file specification,
        so we retain the checkpoint entry, but force it to be .false.. It was
        used in FLASH2 to interpolate the data to the zone corners before
        storing the data in the plotfile (for creating improved iso-surfaces).
    forcedPlotFileNumber [INTEGER] [0]
        Valid Values: Unconstrained

    ignoreForcedPlot [BOOLEAN] [false]

    memory_stat_freq [INTEGER] [100000]
        Valid Values: Unconstrained
        Specify the number of timesteps between memory statistic dumps to
        flash.log !!NOT Yet Implemented in F3
    outputSplitNum [INTEGER] [1]
        Valid Values: Unconstrained
        Split checkpoint, plotfiles, particle plots into this many files per
        dump Not fully implemented, only hdf5 parallel. use at own risk
    output_directory [STRING] [""]
        Valid Values: Unconstrained
        output dir for checkpoint file, can be absolute or relative path
    plotFileIntervalStep [INTEGER] [0]
        Valid Values: Unconstrained
        Write a plotfile after this many steps
    plotFileIntervalTime [REAL] [1.]
        Valid Values: Unconstrained
        Write a plotfile after this much time
    plotFileIntervalZ [REAL] [HUGE(1.)]
        Valid Values: Unconstrained
        Write a plotfile after this change in z
    plotFileNumber [INTEGER] [0]
        Valid Values: Unconstrained
        Initial plot file number
    plot_grid_var_1 [STRING] ["none"]
        Valid Values: Unconstrained
        Allows user to output specific scratch grid vars Up to 12 choices are
        allowed.  If plot_grid_var_X is set to "none" then no variable will be
        saved. The parameter should have the same name as the variable
        corresponding to it. For exampe, if a variable is declared GRID_VAR
        vrtz, to write that grid variable to a plotfile a parameter should be
        declared as PARAMETER plot_grid_var_X STRING "vrtz"
    plot_grid_var_10 [STRING] ["none"]
        Valid Values: Unconstrained

    plot_grid_var_11 [STRING] ["none"]
        Valid Values: Unconstrained

    plot_grid_var_12 [STRING] ["none"]
        Valid Values: Unconstrained

    plot_grid_var_2 [STRING] ["none"]
        Valid Values: Unconstrained

    plot_grid_var_3 [STRING] ["none"]
        Valid Values: Unconstrained

    plot_grid_var_4 [STRING] ["none"]
        Valid Values: Unconstrained

    plot_grid_var_5 [STRING] ["none"]
        Valid Values: Unconstrained

    plot_grid_var_6 [STRING] ["none"]
        Valid Values: Unconstrained

    plot_grid_var_7 [STRING] ["none"]
        Valid Values: Unconstrained

    plot_grid_var_8 [STRING] ["none"]
        Valid Values: Unconstrained

    plot_grid_var_9 [STRING] ["none"]
        Valid Values: Unconstrained

    plot_var_1 [STRING] ["none"]
        Valid Values: Unconstrained

    plot_var_10 [STRING] ["none"]
        Valid Values: Unconstrained

    plot_var_11 [STRING] ["none"]
        Valid Values: Unconstrained

    plot_var_12 [STRING] ["none"]
        Valid Values: Unconstrained

    plot_var_2 [STRING] ["none"]
        Valid Values: Unconstrained

    plot_var_3 [STRING] ["none"]
        Valid Values: Unconstrained

    plot_var_4 [STRING] ["none"]
        Valid Values: Unconstrained

    plot_var_5 [STRING] ["none"]
        Valid Values: Unconstrained

    plot_var_6 [STRING] ["none"]
        Valid Values: Unconstrained

    plot_var_7 [STRING] ["none"]
        Valid Values: Unconstrained

    plot_var_8 [STRING] ["none"]
        Valid Values: Unconstrained

    plot_var_9 [STRING] ["none"]
        Valid Values: Unconstrained

    plot_var_, for N=1..MAX_PLOT_VARS [STRING] ["none"]
        Valid Values: Unconstrained
        (automatically generated by setup)
    plotfileGridQuantityDP [BOOLEAN] [false]
        If true, this sets the grid variables (unk, facevars, etc.) to be output
        in double precision in plotfiles. Default value is false.
    plotfileMetadataDP [BOOLEAN] [false]
        Sets the floating point grid metadata fields to be written in double
        precision if true in plotfiles.  Default value is false
    prof_file [STRING] ["profile.dat"]
        Valid Values: Unconstrained
        !!NOT yet implemented yet in F3
    rolling_checkpoint [INTEGER] [10000]
        Valid Values: Unconstrained
        Checkpoint file number cycling span. Only the last rolling_checkpoint
        files are kept.
    stats_file [STRING] ["flash.dat"]
        Valid Values: Unconstrained
        Name of the file integral quantities are written to (.dat file)
    useCollectiveHDF5 [BOOLEAN] [false]
        If true, all non-headder, non-list datasets will be written using HDF5's
        collective output mode otherwise, the independent access mode is used. 
        Default value is false.
    wall_clock_checkpoint [REAL] [43200.]
        Valid Values: Unconstrained
        Checkpoint after XX seconds (wallclock time) This is useful to ensure
        that the job outputs a restart file before a queue window closes.
    wr_integrals_freq [INTEGER] [1]
        Valid Values: Unconstrained
        Number of timesteps between writing to flash.dat

IO/IOParticles
    particleFileIntervalStep [INTEGER] [0]
        Valid Values: Unconstrained
        write a particle file after this many steps
    particleFileIntervalTime [REAL] [1.]
        Valid Values: Unconstrained
        Write a particle plot after this much time
    particleFileIntervalZ [REAL] [HUGE(1.)]
        Valid Values: Unconstrained
        write a particle file after this change in redshift
    particleFileNumber [INTEGER] [0]
        Valid Values: Unconstrained
        Initial particle plot file number

Particles
    useParticles [BOOLEAN] [FALSE]
        Whether to advance particles [TRUE] or not [FALSE]

Particles/ParticlesInitialization/Lattice
    __doc__
        Lattice uniformly distributes the particles throughout physical domain
    pt_initialXMax [REAL] [1.0]
        Valid Values: Unconstrained
        maximum value in x for particle initialization -- by default = xmax
    pt_initialXMin [REAL] [0.0]
        Valid Values: Unconstrained
        minimum value in x for particle initialization -- by default = xmin
    pt_initialYMax [REAL] [1.0]
        Valid Values: Unconstrained
        maximum value in y for particle initialization -- by default = ymax
    pt_initialYMin [REAL] [0.0]
        Valid Values: Unconstrained
        minimum value in y for particle initialization -- by default = ymin
    pt_initialZMax [REAL] [1.0]
        Valid Values: Unconstrained
        maximum value in z for particle initialization -- by default = zmax
    pt_initialZMin [REAL] [0.0]
        Valid Values: Unconstrained
        minimum value in z for particle initialization -- by default = zmin
    pt_numX [INTEGER] [1]
        Valid Values: Unconstrained

    pt_numY [INTEGER] [1]
        Valid Values: Unconstrained

    pt_numZ [INTEGER] [1]
        Valid Values: Unconstrained


Particles/ParticlesInitialization/WithDensity
    pt_numParticlesWanted [INTEGER] [100]
        Valid Values: Unconstrained
        Number of tracer particles to use (not guaranteed to get exactly this
        many)
    pt_pRand [INTEGER] [100000]
        Valid Values: Unconstrained
        No idea, sadly -- some sort of big number to initialize randomness

Particles/ParticlesInitialization/WithDensity/RejectionMethod
    __doc__
        This is completely untested, don't use without further work

Particles/ParticlesMain
    particle_attribute_1 [STRING] ["none"]
        Valid Values: Unconstrained

    particle_attribute_10 [STRING] ["none"]
        Valid Values: Unconstrained

    particle_attribute_2 [STRING] ["none"]
        Valid Values: Unconstrained

    particle_attribute_3 [STRING] ["none"]
        Valid Values: Unconstrained

    particle_attribute_4 [STRING] ["none"]
        Valid Values: Unconstrained

    particle_attribute_5 [STRING] ["none"]
        Valid Values: Unconstrained

    particle_attribute_6 [STRING] ["none"]
        Valid Values: Unconstrained

    particle_attribute_7 [STRING] ["none"]
        Valid Values: Unconstrained

    particle_attribute_8 [STRING] ["none"]
        Valid Values: Unconstrained

    particle_attribute_9 [STRING] ["none"]
        Valid Values: Unconstrained

    pt_dtChangeTolerance [REAL] [0.4]
        Valid Values: 0.0 to INFTY
        EstiMidpoint does predictor step if time step change is less than this
        percentage. Set to 0 to always do Euler, set to huge number to always
        use estim. midpoints
    pt_dtFactor [REAL] [0.5]
        Valid Values: Unconstrained
        Factor multiplying dx/|v| in setting particle timestep limit
    pt_maxPerProc [INTEGER] [1000]
        Valid Values: Unconstrained
        Maximum number of particles per processor -- too small will cause a
        crash at reallocation
    pt_numAtOnce [INTEGER] [1]
        Valid Values: Unconstrained
        To be used when reading the particles from some file
    pt_small [REAL] [1.0E-10]
        Valid Values: Unconstrained
        If velocities are greater than this, then time stepping may be limited
    useParticles [BOOLEAN] [TRUE]
        Whether to advance particles [TRUE] or not [FALSE]

Particles/ParticlesMain/passive/EstiMidpoint2
    pt_dtChangeToleranceDown [REAL] [0.8]
        Valid Values: 0.00 to 1.01
        controls Euler vs. estimated midpoint step in
        EstiMidpoint2Passive/Particles_advance when time step increases.
    pt_dtChangeToleranceUp [REAL] [5.0]
        Valid Values: 0.00 to INFTY
        controls Euler vs. estimated midpoint step in
        EstiMidpoint2Passive/Particles_advance when time step increases.

Particles/ParticlesMapping/meshWeighting/CIC
    smearLen [INTEGER] [1]
        Valid Values: Unconstrained


PhysicalConstants/PhysicalConstantsMain
    pc_unitsBase [STRING] ["CGS"]
        Valid Values: Unconstrained
        Base Unit system for Physical Constants -- can be "CGS" or "MKS"

Simulation/SimulationMain/Blast2
    refine_var_1 [STRING] ["pres"]
        Valid Values: Unconstrained
        first variable on which to refine
    refine_var_2 [STRING] ["dens"]
        Valid Values: Unconstrained
        second variable on which to refine
    sim_pLeft [REAL] [1000.]
        Valid Values: Unconstrained
        Pressure  in the left part of the grid
    sim_pMid [REAL] [0.01]
        Valid Values: Unconstrained
        Pressure  in the middle of the grid
    sim_pRight [REAL] [100.]
        Valid Values: Unconstrained
        Pressure  in the righ part of the grid
    sim_posnL [REAL] [0.1]
        Valid Values: Unconstrained
        Point of intersection between the left shock plane and x-axis
    sim_posnR [REAL] [0.9]
        Valid Values: Unconstrained
        Point of intersection between the right shock plane and the x-axis
    sim_rhoLeft [REAL] [1.]
        Valid Values: Unconstrained
        Density in the left part of the grid
    sim_rhoMid [REAL] [1.]
        Valid Values: Unconstrained
        Density in the middle of the grid
    sim_rhoRight [REAL] [1.]
        Valid Values: Unconstrained
        Density in the right part of the grid
    sim_uLeft [REAL] [0.]
        Valid Values: Unconstrained
        fluid velocity in the left part of the grid
    sim_uMid [REAL] [0.]
        Valid Values: Unconstrained
        fluid velocity in the middle of the grid
    sim_uRight [REAL] [0.]
        Valid Values: Unconstrained
        fluid velocity in the right part of the grid
    sim_xangle [REAL] [0.]
        Valid Values: Unconstrained
        Angle made by diaphragm normal w/x-axis (deg)
    sim_yangle [REAL] [90.]
        Valid Values: Unconstrained
        Angle made by diaphragm normal w/y-axis (deg)

Simulation/SimulationMain/Cellular
    noiseAmplitude [REAL] [1.0e-2]
        Valid Values: Unconstrained
        amplitude of the white noise added to the perturbation
    noiseDistance [REAL] [5.0]
        Valid Values: Unconstrained
        distances above and below r_init get noise added
    radiusPerturb [REAL] [25.6]
        Valid Values: Unconstrained
        distance below which the perturbation is applied
    rhoAmbient [REAL] [1.0e7]
        Valid Values: 0 to INFTY
        density of the cold upstream material
    rhoPerturb [REAL] [4.236e7]
        Valid Values: Unconstrained
        density of the post shock material
    tempAmbient [REAL] [2.0e8]
        Valid Values: 0 to INFTY
        temperature of the cold upstream material
    tempPerturb [REAL] [4.423e9]
        Valid Values: Unconstrained
        temperature of the post shock material
    usePseudo1d [BOOLEAN] [FALSE]
        .true. for a 1d initial configuration, with the copied along the y and z
        directions .false. for a spherical configuration
    velxAmbient [REAL] [0.0]
        Valid Values: Unconstrained
        x-velocity of the cold upstream material
    velxPerturb [REAL] [2.876E+08]
        Valid Values: Unconstrained
        x-velocity of the post shock material
    xCenterPerturb [REAL] [0.0]
        Valid Values: Unconstrained

    xc12 [REAL] [1.0]
        Valid Values: 0.0 to 1.0
        mass fraction of c12
    xhe4 [REAL] [0.0]
        Valid Values: 0.0 to 1.0
        mass fraction of he4
    xo16 [REAL] [0.0]
        Valid Values: 0.0 to 1.0
        mass fraction of o16
    yCenterPerturb [REAL] [0.0]
        Valid Values: Unconstrained

    zCenterPerturb [REAL] [0.0]
        Valid Values: Unconstrained


Simulation/SimulationMain/ConductionDelta
    orientation [INTEGER] [1]
        Valid Values: 0, 1, 2, 3
        1/2/3 -- planar source is oriented along x/y/z axis, 0     --
        three-dimensional point source
    rho_init [REAL] [1.]
        Valid Values: Unconstrained
        background density
    sim_Q [REAL] [1.0]
        Valid Values: Unconstrained
        factor used for scaling the initial temperature distribution
    sim_tempBackground [REAL] [0.0]
        Valid Values: Unconstrained
        constant temperature background, the Gaussian peak gets added to this
    sim_xctr [REAL] [0.5]
        Valid Values: Unconstrained
        Temperature peak center X-coordinate
    sim_yctr [REAL] [0.5]
        Valid Values: Unconstrained
        Temperature peak center Y-coordinate
    sim_zctr [REAL] [0.5]
        Valid Values: Unconstrained
        Temperature peak center Z-coordinate
    toffset [REAL] [.001]
        Valid Values: Unconstrained
        time offset for initial condition

Simulation/SimulationMain/DustCollapse
    sim_ictr [REAL] [0.5]
        Valid Values: Unconstrained

    sim_initDens [REAL] [1.]
        Valid Values: Unconstrained

    sim_initRad [REAL] [0.05]
        Valid Values: Unconstrained

    sim_jctr [REAL] [0.5]
        Valid Values: Unconstrained

    sim_kctr [REAL] [0.5]
        Valid Values: Unconstrained

    sim_tAmbient [REAL] [1.]
        Valid Values: Unconstrained


Simulation/SimulationMain/HydroStatic
    sim_presRef [REAL] [1.0]
        Valid Values: Unconstrained

    sim_tempRef [REAL] [300.0]
        Valid Values: Unconstrained

    sim_xyzRef [REAL] [0.5]
        Valid Values: Unconstrained


Simulation/SimulationMain/IsentropicVortex
    nx_subint [INTEGER] [10]
        Valid Values: Unconstrained
        number of subintervals along IAXIS
    ny_subint [INTEGER] [10]
        Valid Values: Unconstrained
        number of subintervals along JAXIS
    p_ambient [REAL] [1.0]
        Valid Values: Unconstrained
        Initial ambient pressure
    particle_attribute_1 [STRING] ["pdens"]
        Valid Values: Unconstrained

    particle_attribute_2 [STRING] ["ptemp"]
        Valid Values: Unconstrained

    rho_ambient [REAL] [1.0]
        Valid Values: Unconstrained
        Initial ambient density
    u_ambient [REAL] [1.0]
        Valid Values: Unconstrained
        Initial ambient velocity
    v_ambient [REAL] [1.0]
        Valid Values: Unconstrained

    vortex_strength [REAL] [5.0]
        Valid Values: Unconstrained

    xctr [REAL] [0.0]
        Valid Values: Unconstrained
        x coordinate of the vortex center
    yctr [REAL] [0.0]
        Valid Values: Unconstrained
        y coordinate of the vortex center

Simulation/SimulationMain/Jeans
    amplitude [REAL] [0.01]
        Valid Values: Unconstrained

    delta_deref [REAL] [0.01]
        Valid Values: Unconstrained

    delta_ref [REAL] [0.1]
        Valid Values: Unconstrained

    lambdax [REAL] [1.]
        Valid Values: Unconstrained

    lambday [REAL] [1.]
        Valid Values: Unconstrained

    lambdaz [REAL] [1.]
        Valid Values: Unconstrained

    p0 [REAL] [1.]
        Valid Values: Unconstrained

    reference_density [REAL] [1.]
        Valid Values: Unconstrained

    rho0 [REAL] [1.]
        Valid Values: Unconstrained


Simulation/SimulationMain/MacLaurin
    angular_velocity [REAL] [0.]
        Valid Values: Unconstrained
        Dimensionless angular velocity (Omega)
    density [REAL] [1.]
        Valid Values: -1.0 to INFTY
        Spheroid density (rho)): set to -1 to generate spheroid mass of 1.0
    eccentricity [REAL] [0.]
        Valid Values: 0.0 to 1.0
        Eccentricity of the ellipsoid (e)
    equatorial_semimajor_axis [REAL] [1.]
        Valid Values: 0.1 to INFTY
        Equatorial semimajor axis (a1)
    nsubzones [INTEGER] [2]
        Valid Values: 1 to INFTY
        Number of sub-zones per dimension
    xctr [REAL] [0.5]
        Valid Values: Unconstrained
        X-coordinate of center of spheroid
    yctr [REAL] [0.5]
        Valid Values: Unconstrained
        Y-coordinate of center of spheroid
    zctr [REAL] [0.5]
        Valid Values: Unconstrained
        Z-coordinate of center of spheroid

Simulation/SimulationMain/NeiTest
    radius [REAL] [0.2]
        Valid Values: Unconstrained

    rho_ambient [REAL] [2.e-16]
        Valid Values: Unconstrained

    t_ambient [REAL] [1.e4]
        Valid Values: Unconstrained

    t_perturb [REAL] [0.2]
        Valid Values: Unconstrained

    vel_init [REAL] [3.e5]
        Valid Values: Unconstrained

    xstep [REAL] [1.5e7]
        Valid Values: Unconstrained


Simulation/SimulationMain/Orbit
    ext_field [BOOLEAN] [TRUE]
        external field (TRUE) or self-grav (FALSE)?
    num_particles [INTEGER] [2]
        Valid Values: Unconstrained

    ptmass [REAL] [1.]
        Valid Values: Unconstrained
        point mass if external field
    separation [REAL] [1.]
        Valid Values: Unconstrained
        particle separation (2*radius)

Simulation/SimulationMain/Pancake
    MaxParticlePerZone [INTEGER] [10]
        Valid Values: Unconstrained

    Tfiducial [REAL] [100.0]
        Valid Values: Unconstrained

    lambda [REAL] [3.0857E24]
        Valid Values: Unconstrained

    pt_numX [INTEGER] [1]
        Valid Values: Unconstrained

    pt_numY [INTEGER] [1]
        Valid Values: Unconstrained

    pt_numZ [INTEGER] [1]
        Valid Values: Unconstrained

    xangle [REAL] [0.0]
        Valid Values: Unconstrained

    yangle [REAL] [90.0]
        Valid Values: Unconstrained

    zcaustic [REAL] [1.0]
        Valid Values: Unconstrained

    zfiducial [REAL] [100.0]
        Valid Values: Unconstrained


Simulation/SimulationMain/PoisParticles
    sim_densityThreshold [REAL] [0.85]
        Valid Values: Unconstrained

    sim_ptMass [REAL] [0.005]
        Valid Values: Unconstrained

    sim_smlRho [REAL] [1.e-10]
        Valid Values: Unconstrained


Simulation/SimulationMain/PoisTest
    sim_smlRho [REAL] [1.E-10]
        Valid Values: Unconstrained
        smallest allowed value of density

Simulation/SimulationMain/RHD_Sod
    sim_pLeft [REAL] [1.]
        Valid Values: Unconstrained
        Pressure  in the left part of the grid
    sim_pRight [REAL] [0.1]
        Valid Values: Unconstrained
        Pressure  in the righ part of the grid
    sim_posn [REAL] [0.5]
        Valid Values: Unconstrained

    sim_rhoLeft [REAL] [1.]
        Valid Values: Unconstrained
        Density in the left part of the grid
    sim_rhoRight [REAL] [0.125]
        Valid Values: Unconstrained
        Density in the right part of the grid
    sim_uLeft [REAL] [0.]
        Valid Values: Unconstrained
        fluid velocity in the left part of the grid
    sim_uRight [REAL] [0.]
        Valid Values: Unconstrained
        fluid velocity in the right part of the grid
    sim_vLeft [REAL] [0.]
        Valid Values: Unconstrained
        fluid velocity in the left part of the grid
    sim_vRight [REAL] [0.]
        Valid Values: Unconstrained
        fluid velocity in the right part of the grid
    sim_wLeft [REAL] [0.]
        Valid Values: Unconstrained
        fluid velocity in the left part of the grid
    sim_wRight [REAL] [0.]
        Valid Values: Unconstrained
        fluid velocity in the right part of the grid
    sim_xangle [REAL] [0.]
        Valid Values: Unconstrained
        Angle made by diaphragm normal w/x-axis (deg)
    sim_yangle [REAL] [90.]
        Valid Values: Unconstrained


Simulation/SimulationMain/SBlast
    sim_A1 [REAL] [1.]
        Valid Values: 1 to INFTY
        Atomic weight in region 2
    sim_A2 [REAL] [1.]
        Valid Values: 1 to INFTY

    sim_AIn [REAL] [1.]
        Valid Values: 1 to INFTY
        Atomic weight inside the energy source
    sim_EIn [REAL] [1.]
        Valid Values: 0 to INFTY
        Total energy inside the energy source
    sim_Z1 [REAL] [1.]
        Valid Values: 1 to INFTY
        Atomic number in region 1
    sim_Z2 [REAL] [1.]
        Valid Values: 1 to INFTY
        Atomic number in region 2
    sim_ZIn [REAL] [1.]
        Valid Values: 1 to INFTY
        Atomic number inside the energy source
    sim_atmos1 [INTEGER] [0]
        Valid Values: Unconstrained

    sim_atmos2 [INTEGER] [0]
        Valid Values: Unconstrained

    sim_gamma1 [REAL] [1.4]
        Valid Values: 1.1 to INFTY
        gamma in region 1
    sim_gamma2 [REAL] [1.4]
        Valid Values: 1.1 to INFTY
        gamma in region 2
    sim_gammaIn [REAL] [1.4]
        Valid Values: 1.1 to INFTY
        gamma inside the energy source
    sim_geo [INTEGER] [0]
        Valid Values: Unconstrained
        specifies the geometry of the problem, not the geometry of the grid
    sim_h1 [REAL] [1.]
        Valid Values: Unconstrained
        Thickness of region 1
    sim_ibound [BOOLEAN] [FALSE]
        Bounday/Discontinuity present?
    sim_p1 [REAL] [1.]
        Valid Values: 0 to INFTY
        Pressure in region 2
    sim_p2 [REAL] [1.]
        Valid Values: 0 to INFTY

    sim_pIn [REAL] [1.]
        Valid Values: 0 to INFTY
        Pressure inside the energy source
    sim_rIn [REAL] [0.1]
        Valid Values: 0 to INFTY
        radius of the energy source
    sim_rho1 [REAL] [1.]
        Valid Values: 0 to INFTY
        Density in region 2
    sim_rho2 [REAL] [1.]
        Valid Values: 0 to INFTY

    sim_rhoIn [REAL] [1.]
        Valid Values: 0 to INFTY
        Density inside the energy source
    sim_sh1 [REAL] [1.]
        Valid Values: Unconstrained
        Scale height in region 2
    sim_sh2 [REAL] [1.]
        Valid Values: Unconstrained

    sim_useE [BOOLEAN] [FALSE]
        Use total energy to define energy source
    sim_xcIn [REAL] [0.]
        Valid Values: Unconstrained
        x location of the center of the energy source
    sim_ycIn [REAL] [0.]
        Valid Values: Unconstrained
        y location of the center of the energy source
    sim_zcIn [REAL] [0.]
        Valid Values: Unconstrained
        z location of the center of the energy source

Simulation/SimulationMain/Sedov
    sim_expEnergy [REAL] [1.]
        Valid Values: Unconstrained
        Explosion energy (distributed over 2^dimen central zones)
    sim_nsubzones [INTEGER] [7]
        Valid Values: Unconstrained
        Number of `sub-zones' in cells for applying 1d profile
    sim_pAmbient [REAL] [1.E-5]
        Valid Values: Unconstrained
        Initial ambient pressure
    sim_rInit [REAL] [0.05]
        Valid Values: Unconstrained
        Radial position of inner edge of grid (for 1D)
    sim_rhoAmbient [REAL] [1.]
        Valid Values: Unconstrained
        Initial ambient density
    sim_xctr [REAL] [0.5]
        Valid Values: Unconstrained
        Explosion center coordinates
    sim_yctr [REAL] [0.5]
        Valid Values: Unconstrained
        Explosion center coordinates
    sim_zctr [REAL] [0.5]
        Valid Values: Unconstrained
        Explosion center coordinates

Simulation/SimulationMain/SedovSelfGravity
    exp_energy [REAL] [1.]
        Valid Values: Unconstrained
        Explosion energy (distributed over 2^dimen central zones)
    p_ambient [REAL] [1.E-5]
        Valid Values: Unconstrained
        Initial ambient pressure
    r_init [REAL] [0.05]
        Valid Values: Unconstrained
        Radial position of the inner edge of the grid
    rho_ambient [REAL] [1.]
        Valid Values: Unconstrained
        Initial ambient density
    sim_nsubzones [INTEGER] [7]
        Valid Values: Unconstrained
        Number of `sub-zones' to break cells into for applying 1d profile
    t_init [REAL] [0.]
        Valid Values: Unconstrained
        Initial time since explosion

Simulation/SimulationMain/Sod
    sim_pLeft [REAL] [1.]
        Valid Values: 0 to INFTY
        Pressure  in the left part of the grid
    sim_pRight [REAL] [0.1]
        Valid Values: 0 to INFTY
        Pressure  in the righ part of the grid
    sim_posn [REAL] [0.5]
        Valid Values: Unconstrained

    sim_rhoLeft [REAL] [1.]
        Valid Values: 0 to INFTY
        Density in the left part of the grid
    sim_rhoRight [REAL] [0.125]
        Valid Values: 0 to INFTY
        Density in the right part of the grid
    sim_uLeft [REAL] [0.]
        Valid Values: Unconstrained
        fluid velocity in the left part of the grid
    sim_uRight [REAL] [0.]
        Valid Values: Unconstrained
        fluid velocity in the right part of the grid
    sim_xangle [REAL] [0.]
        Valid Values: 0 to 360
        Angle made by diaphragm normal w/x-axis (deg)
    sim_yangle [REAL] [90.]
        Valid Values: 0 to 360


Simulation/SimulationMain/SodSpherical
    sim_idir [INTEGER] [1]
        Valid Values: 1, 2
        the direction along which to propagate the shock.  sim_idir = 1 is
        horizontal.  sim_idir = 2 is vertical.
    sim_pLeft [REAL] [1.]
        Valid Values: Unconstrained
        initial pressure on the left side of the interface
    sim_pRight [REAL] [0.1]
        Valid Values: Unconstrained
        initial pressure on the right side of the interface
    sim_rhoLeft [REAL] [1.]
        Valid Values: Unconstrained
        initial density left of the interface
    sim_rhoRight [REAL] [0.125]
        Valid Values: Unconstrained
        initial density right of interface
    sim_shockpos [REAL] [0.4]
        Valid Values: Unconstrained
        distance of the shock plane from y-axis (for sim_idir=1) or x-axis (for
        sim_idir=2)

Simulation/SimulationMain/SodStep
    nblockx [INTEGER] [4]
        Valid Values: Unconstrained
        num initial blocks in x dir
    nblocky [INTEGER] [4]
        Valid Values: Unconstrained
        num initial blocks in y dir
    nblockz [INTEGER] [1]
        Valid Values: Unconstrained
        num initial blocks in z dir
    sim_pLeft [REAL] [1.]
        Valid Values: 0 to INFTY
        Pressure  in the left part of the grid
    sim_pRight [REAL] [0.1]
        Valid Values: 0 to INFTY
        Pressure  in the righ part of the grid
    sim_posn [REAL] [0.5]
        Valid Values: Unconstrained

    sim_rhoLeft [REAL] [1.]
        Valid Values: 0 to INFTY
        Density in the left part of the grid
    sim_rhoRight [REAL] [0.125]
        Valid Values: 0 to INFTY
        Density in the right part of the grid
    sim_stepInDomain [BOOLEAN] [false]
        -- whether there is a missing block in the initial domain
    sim_uLeft [REAL] [0.]
        Valid Values: Unconstrained
        fluid velocity in the left part of the grid
    sim_uRight [REAL] [0.]
        Valid Values: Unconstrained
        fluid velocity in the right part of the grid
    sim_xangle [REAL] [0.]
        Valid Values: 0 to 360
        Angle made by diaphragm normal w/x-axis (deg)
    sim_yangle [REAL] [90.]
        Valid Values: 0 to 360


Simulation/SimulationMain/StirTurb
    c_ambient [REAL] [1.e0]
        Valid Values: Unconstrained
        reference sound speed
    mach [REAL] [0.3]
        Valid Values: Unconstrained
        reference mach number
    rho_ambient [REAL] [1.e0]
        Valid Values: Unconstrained
        reference density

Simulation/SimulationMain/WindTunnel
    sim_pAmbient [REAL] [1.0]
        Valid Values: Unconstrained

    sim_rhoAmbient [REAL] [1.4]
        Valid Values: Unconstrained

    sim_windVel [REAL] [3.0]
        Valid Values: Unconstrained


Simulation/SimulationMain/magnetoHD/BlastBS
    Bx0 [REAL] [100.]
        Valid Values: Unconstrained
        Initial magnitude of Bx
    Radius [REAL] [0.1]
        Valid Values: Unconstrained
        Radius
    tiny [REAL] [1.e-16]
        Valid Values: Unconstrained
        Threshold value used for numerical zero
    xCtr [REAL] [0.]
        Valid Values: Unconstrained
        x center of the computational domain
    yCtr [REAL] [0.]
        Valid Values: Unconstrained
        y center of the computational domain
    zCtr [REAL] [0.]
        Valid Values: Unconstrained
        z center of the computatoinal domain

Simulation/SimulationMain/magnetoHD/BrioWu
    b_normal [REAL] [0.75]
        Valid Values: Unconstrained
        Magnetic field normal component
    by_left [REAL] [1.]
        Valid Values: Unconstrained

    by_right [REAL] [-1.]
        Valid Values: Unconstrained

    bz_left [REAL] [0.]
        Valid Values: Unconstrained

    bz_right [REAL] [0.]
        Valid Values: Unconstrained

    p_left [REAL] [1.]
        Valid Values: Unconstrained

    p_right [REAL] [0.1]
        Valid Values: Unconstrained

    posn [REAL] [0.5]
        Valid Values: Unconstrained
        Point of intersection between the shock plane and the x-axis
    rho_left [REAL] [1.]
        Valid Values: Unconstrained

    rho_right [REAL] [0.125]
        Valid Values: Unconstrained

    rx [REAL] [0.]
        Valid Values: Unconstrained

    ry [REAL] [1.]
        Valid Values: Unconstrained

    tiny [REAL] [1.e-16]
        Valid Values: Unconstrained
        Threshold value used for numerical zero
    u_left [REAL] [0.]
        Valid Values: Unconstrained

    u_right [REAL] [0.]
        Valid Values: Unconstrained

    v_left [REAL] [0.]
        Valid Values: Unconstrained

    v_right [REAL] [0.]
        Valid Values: Unconstrained

    w_left [REAL] [0.]
        Valid Values: Unconstrained

    w_right [REAL] [0.]
        Valid Values: Unconstrained

    xangle [REAL] [0.]
        Valid Values: Unconstrained
        Angle made by diaphragm normal w/x-axis (deg)
    xmax [REAL] [1.]
        Valid Values: Unconstrained

    xmin [REAL] [0.]
        Valid Values: Unconstrained

    yangle [REAL] [90.]
        Valid Values: Unconstrained
        Angle made by diaphragm normal w/y-axis (deg)
    ymax [REAL] [1.]
        Valid Values: Unconstrained

    ymin [REAL] [0.]
        Valid Values: Unconstrained


Simulation/SimulationMain/magnetoHD/CurrentSheet
    B0 [REAL] [1.0]
        Valid Values: Unconstrained
        Magnitude of By
    U0 [REAL] [0.1]
        Valid Values: Unconstrained
        Amplitude of U (x-velocity)
    beta [REAL] [0.2]
        Valid Values: Unconstrained
        Initial beta plasma
    tiny [REAL] [1.e-16]
        Valid Values: Unconstrained
        Threshold value used for a numerical zero

Simulation/SimulationMain/magnetoHD/FieldLoop
    Az_initial [REAL] [0.001]
        Valid Values: Unconstrained
        Strength of initial z-component of magnetic vector potential
    R_fieldLoop [REAL] [0.3]
        Valid Values: Unconstrained
        Radius of field loop
    U_initial [REAL] [2.23606796749979]
        Valid Values: Unconstrained
        Strength of initial vector fields
    rx [REAL] [1.]
        Valid Values: Unconstrained
        Field loop advection angle = atan(rx/ry)
    ry [REAL] [2.]
        Valid Values: Unconstrained

    tiny [REAL] [1.e-16]
        Valid Values: Unconstrained
        Threshold value used for numerical zero
    velz_initial [REAL] [0.0]
        Valid Values: Unconstrained

    xCtr [REAL] [1.]
        Valid Values: Unconstrained
        x center of the computational domain
    yCtr [REAL] [0.5]
        Valid Values: Unconstrained
        y center of the computational domain
    zCtr [REAL] [0.0]
        Valid Values: Unconstrained
        z center of the computatoinal domain

Simulation/SimulationMain/magnetoHD/OrszagTang
    tiny [REAL] [1.e-16]
        Valid Values: Unconstrained
        Threshold value used for numerical zero

Simulation/SimulationMain/magnetoHD/Rotor
    Radius [REAL] [0.115]
        Valid Values: Unconstrained
        Radius
    tiny [REAL] [1.e-16]
        Valid Values: Unconstrained
        Threshold value used for numerical zero
    xCtr [REAL] [0.]
        Valid Values: Unconstrained
        x center of the computational domain
    yCtr [REAL] [0.]
        Valid Values: Unconstrained
        y center of the computational domain
    zCtr [REAL] [0.]
        Valid Values: Unconstrained
        z center of the computatoinal domain

Simulation/SimulationMain/unitTest/Cosmology
    eintSwitch [REAL] [0.0]
        Valid Values: Unconstrained


Simulation/SimulationMain/unitTest/Eos
    eosMode [STRING] ["dens_temp"]
        Valid Values: Unconstrained
        The Mode for applying Eos
    sim_densMax [REAL] [1.e8]
        Valid Values: Unconstrained
        Initial distribution of density, maximum.  Even distribution between
        logarithm of min/max.
    sim_densMin [REAL] [1.e-2]
        Valid Values: Unconstrained
        Initial distribution of density, minimum.  Even distribution between
        logarithm of min/max.
    sim_initialMass [INTEGER] [-1]
        Valid Values: -1 to INFTY
        Distribution of initial mass.  -1 to put gradient in SPEC(1) and
        SPEC(NSPECIES) 0 to divide evenly throughout SPECIES i to put all mass
        on SPECIES i
    sim_presMax [REAL] [1.e7]
        Valid Values: Unconstrained
        Initial distribution of pressure, maximum.  Even distribution between
        logarithm of min/max
    sim_presMin [REAL] [1.e-2]
        Valid Values: Unconstrained
        Initial distribution of pressure, minimum.  Even distribution between
        logarithm of min/max
    sim_tempMax [REAL] [1.e9]
        Valid Values: Unconstrained
        Initial distribution of temperature, maximum.  Even distribution between
        logarithm of min/max
    sim_tempMin [REAL] [1.e5]
        Valid Values: Unconstrained
        Initial distribution of temperature, minimum.  Even distribution between
        logarithm of min/max
    sim_xnMax [REAL] [1.0]
        Valid Values: Unconstrained
        Initial distribution of a single species, maximum.  Even distribution
        between logarithm of min/max
    sim_xnMin [REAL] [1.e-10]
        Valid Values: Unconstrained
        Initial distribution of a single species, minimum.  Even distribution
        between logarithm of min/max
    smallt [REAL] [1.E-10]
        Valid Values: Unconstrained
        Cutoff value for temperature

Simulation/SimulationMain/unitTest/Gravity/Poisson
    sim_subSample [INTEGER] [7]
        Valid Values: 1 to 12
        Reflects the subsampling philosophy of Multipole.  See
        physics/Grid/GridSolvers/Multipole/Config/mpole_subSample

Simulation/SimulationMain/unitTest/Gravity/Poisson2
    convertToConsvdInMeshInterp [BOOLEAN] [FALSE]
        indicates if appropriate variables are converted to conserved form
        during propagation within the interpolation routines invoked by
        Paramesh. No variables should be converted back and forth in this test.
    density [REAL] [10.0]
        Valid Values: Unconstrained

    discRadius [REAL] [1.0]
        Valid Values: Unconstrained


Simulation/SimulationMain/unitTest/Gravity/Poisson3
    angular_velocity [REAL] [0.]
        Valid Values: Unconstrained
        Dimensionless angular velocity (Omega)
    density [REAL] [1.]
        Valid Values: -1.0 to INFTY
        Spheroid density (rho): set to -1 to generate spheroid mass of 1.0
    eccentricity [REAL] [0.]
        Valid Values: 0.0 to 1.0
        Eccentricity of the ellipsoid (e)
    equatorial_semimajor_axis [REAL] [1.]
        Valid Values: 0.0 to INFTY
        Equatorial semimajor axis (a1)
    nsubzones [INTEGER] [2]
        Valid Values: 1 to INFTY
        Number of sub-zones per dimension
    pass_tolerance [REAL] [0.015]
        Valid Values: 0.00000000000001 to 1.0
        Allowed error for testing.  0.015 = 1.5 percent error
    xctr [REAL] [0.5]
        Valid Values: Unconstrained
        X-coordinate of center of spheroid
    yctr [REAL] [0.5]
        Valid Values: Unconstrained
        Y-coordinate of center of spheroid
    zctr [REAL] [0.5]
        Valid Values: Unconstrained
        Z-coordinate of center of spheroid

Simulation/SimulationMain/unitTest/Gravity/Poisson3_active
    angular_velocity [REAL] [0.]
        Valid Values: Unconstrained
        Dimensionless angular velocity (Omega)
    density [REAL] [1.]
        Valid Values: -1.0 to INFTY
        Spheroid density (rho): set to -1 to generate spheroid mass of 1.0
    eccentricity [REAL] [0.]
        Valid Values: 0.0 to 1.0
        Eccentricity of the ellipsoid (e)
    equatorial_semimajor_axis [REAL] [1.]
        Valid Values: 0.0 to INFTY
        Equatorial semimajor axis (a1)
    nsubzones [INTEGER] [2]
        Valid Values: 1 to INFTY
        Number of sub-zones per dimension
    pass_tolerance [REAL] [0.015]
        Valid Values: 0.00000000000001 to 1.0
        Allowed error for testing.  0.015 = 1.5 percent error
    xctr [REAL] [0.5]
        Valid Values: Unconstrained
        X-coordinate of center of spheroid
    yctr [REAL] [0.5]
        Valid Values: Unconstrained
        Y-coordinate of center of spheroid
    zctr [REAL] [0.5]
        Valid Values: Unconstrained
        Z-coordinate of center of spheroid

Simulation/SimulationMain/unitTest/PFFT_BlktriFD
    alpha_x [REAL] [0.]
        Valid Values: Unconstrained

    waven_x [REAL] [1.]
        Valid Values: Unconstrained

    waven_y [REAL] [1.]
        Valid Values: Unconstrained

    waven_z [REAL] [1.]
        Valid Values: Unconstrained


Simulation/SimulationMain/unitTest/PFFT_XYperZneuFD
    alpha_x [REAL] [0.3141592653589793]
        Valid Values: Unconstrained

    alpha_y [REAL] [0.3141592653589793]
        Valid Values: Unconstrained

    waven_x [REAL] [1.]
        Valid Values: Unconstrained

    waven_y [REAL] [1.]
        Valid Values: Unconstrained

    waven_z [REAL] [1.]
        Valid Values: Unconstrained


Simulation/SimulationMain/unitTest/ParticlesAdvance
    sim_maxTolCoeff0 [REAL] [1.0e-8]
        Valid Values: Unconstrained

    sim_maxTolCoeff1 [REAL] [0.0001]
        Valid Values: Unconstrained

    sim_maxTolCoeff2 [REAL] [0.01]
        Valid Values: Unconstrained

    sim_maxTolCoeff3 [REAL] [0.0]
        Valid Values: Unconstrained

    sim_schemeOrder [INTEGER] [2]
        Valid Values: Unconstrained


Simulation/SimulationMain/unitTest/ParticlesAdvance/HomologousPassive
    sim_a0 [REAL] [1.0]
        Valid Values: Unconstrained
        constant component of velocity field factor a(t)
    sim_a1 [REAL] [0.1]
        Valid Values: Unconstrained
        varying part of velocity field factor a(t)
    sim_analyticParticlePositions [BOOLEAN] [FALSE]

    sim_fakeMapMeshToParticles [BOOLEAN] [TRUE]

    sim_p_amb [REAL] [8.e5]
        Valid Values: Unconstrained
        Gas Pressure: Entire domain receives this ambient parameter
    sim_rho_amb [REAL] [0.95e-3]
        Valid Values: Unconstrained
        Gas Density:  Entire domain receives this ambient parameter
    sim_seed [REAL] [1.0]
        Valid Values: Unconstrained
        Random number seed -- NOT USED please ignore
    sim_vx_amb [REAL] [0.5]
        Valid Values: Unconstrained
        Gas x-velocity:  Dominant flow velocity throughout domain
    sim_vx_multiplier [REAL] [1.0]
        Valid Values: Unconstrained
        Half of the domain in y has x-velocity multiplied by this value
    sim_vx_pert [REAL] [0.1]
        Valid Values: Unconstrained
        Scales [-1,1] random number in x direction: set to zero for uniform flow
    sim_vy_pert [REAL] [0.1]
        Valid Values: Unconstrained
        Scales [-1,1] random number in y direction: set to zero for uniform flow
    sim_vz_pert [REAL] [0.1]
        Valid Values: Unconstrained
        Scales [-1,1] random number in z direction: set to zero for uniform flow

monitors/Logfile/LogfileMain
    log_file [STRING] ["flash.log"]
        Valid Values: Unconstrained
        Name of log file to create
    run_comment [STRING] ["FLASH 3 run"]
        Valid Values: Unconstrained
        Comment for run
    run_number [STRING] ["1"]
        Valid Values: Unconstrained
        Identification number for run

monitors/Timers/TimersMain/MPINative
    eachProcWritesSummary [BOOLEAN] [TRUE]
        Should each process write its summary to its own file?  If true, each
        process will write its summary to a file named timer_summary_
    writeStatSummary [BOOLEAN] [TRUE]
        Should timers write the max/min/avg values for timers?

physics/Cosmology/CosmologyMain
    CosmologicalConstant [REAL] [0.7]
        Valid Values: Unconstrained
        Ratio of the mass density equivalent in the cosmological constant (or
        dark energy) to the closure density at the present epoch
    HubbleConstant [REAL] [2.1065E-18]
        Valid Values: Unconstrained
        Value of the Hubble constant (\dot{a}/a) in sec^-1 at the present epoch
    MaxScaleChange [REAL] [HUGE]
        Valid Values: Unconstrained
        Maximum permitted fractional change in the scale factor during each
        timestep
    OmegaBaryon [REAL] [0.05]
        Valid Values: Unconstrained
        Ratio of baryonic mass density to closure density at the present epoch
        (must be <= OmegaMatter!)
    OmegaMatter [REAL] [0.3]
        Valid Values: Unconstrained
        Ratio of total mass density to closure density at the present epoch
    OmegaRadiation [REAL] [5.E-5]
        Valid Values: Unconstrained
        Ratio of total radiation density to closure density at the present epoch
    useCosmology [BOOLEAN] [TRUE]
        Are we using cosmological expansion?

physics/Cosmology/unitTest
    computeDtCorrect [REAL] [169450294720534.7]
        Valid Values: Unconstrained

    massToLengthCorrect [REAL] [4959457362.186973]
        Valid Values: Unconstrained

    redshiftToTimeCorrect [REAL] [1129631001610459.]
        Valid Values: Unconstrained

    solveFriedmannCorrect [REAL] [1.9608074571151239E-002]
        Valid Values: Unconstrained

    utDt [REAL] [10000000000.00000]
        Valid Values: Unconstrained

    utOldScaleFactor [REAL] [1.9607958853385455E-002]
        Valid Values: Unconstrained

    utScaleFactor [REAL] [1.9608074569174569E-002]
        Valid Values: Unconstrained

    utSimTime [REAL] [1129641001610459.]
        Valid Values: Unconstrained


physics/Eos/EosMain
    eintSwitch [REAL] [0.0]
        Valid Values: Unconstrained
        a rarely used switch which ensures that internal energy calculations
        maintain sufficient precision. Important only if energyTotal is
        dominated by energyKinetic. If (energyInternal <
        eintSwitch*energyKinetic) then some routines (Eos/Helmholtz,
        Hydro/hy_updateSoln) will NOT calculate energyInternal by subtraction,
        but rather through direct calculation.

physics/Eos/EosMain/Gamma
    eos_singleSpeciesA [REAL] [1.00]
        Valid Values: 0.0 to INFTY
        Nucleon number for the gas (available ONLY for Eos with single species)
    eos_singleSpeciesZ [REAL] [1.00]
        Valid Values: 0.0 to INFTY
        Proton number for the gas (available ONLY for Eos with single species)
    gamma [REAL] [1.6667]
        Valid Values: 0.0 to INFTY
        Ratio of specific heats for gas (available ONLY for Eos/Gamma)

physics/Eos/EosMain/Helmholtz
    eos_coulombAbort [BOOLEAN] [true]
        Abort if pressures become negative.  Otherwise, issue a warning message
        and continue
    eos_coulombMult [REAL] [1.0]
        Valid Values: Unconstrained
        coulomb correction multiplier
    eos_forceConstantInput [BOOLEAN] [false]
        Helmholtz routines can allow input EINT or PRES to change on output to
        preserve equilibrium.  This switch forces a constant input of EINT or
        PRES
    eos_maxNewton [INTEGER] [50]
        Valid Values: Unconstrained
        maximum number of Newton-Raphson iterations to try.
    eos_tolerance [REAL] [1.e-8]
        Valid Values: Unconstrained
        tolerance for the Newton-Raphson iterations

physics/Eos/EosMain/Helmholtz/SpeciesBased
    eos_singleSpeciesA [REAL] [1.00]
        Valid Values: 0.0 to INFTY
        Single-species nucleon number for the gas (only used by Eos/Helmholtz
        when compiled w/o Multispecies)
    eos_singleSpeciesZ [REAL] [1.00]
        Valid Values: 0.0 to INFTY
        Single-species proton number for the gas (only used Eos/Helmholtz when
        compiled w/o Multispecies)

physics/Gravity
    useGravity [BOOLEAN] [FALSE]
        Whether gravity calculations should be performed.

physics/Gravity/GravityMain
    useGravity [BOOLEAN] [TRUE]
        Should the gravity calculations be performed?

physics/Gravity/GravityMain/Constant
    gconst [REAL] [-981.]
        Valid Values: Unconstrained
        Gravitational acceleration constant
    gdirec [STRING] ["x"]
        Valid Values: Unconstrained
        Direction of acceleration ("x", "y", "z")

physics/Gravity/GravityMain/PlanePar
    gravsoft [REAL] [.0001]
        Valid Values: Unconstrained
        softening length
    ptdirn [INTEGER] [1]
        Valid Values: Unconstrained
        x = 1, y = 2, z = 3
    ptmass [REAL] [10000.]
        Valid Values: Unconstrained
        mass of the point
    ptxpos [REAL] [1.]
        Valid Values: Unconstrained
        location of the point mass, in the ptdirn direction

physics/Gravity/GravityMain/PointMass
    gravsoft [REAL] [0.001]
        Valid Values: Unconstrained

    ptmass [REAL] [10000.]
        Valid Values: Unconstrained

    ptxpos [REAL] [1.]
        Valid Values: Unconstrained

    ptypos [REAL] [-10.]
        Valid Values: Unconstrained

    ptzpos [REAL] [0.]
        Valid Values: Unconstrained


physics/Gravity/GravityMain/Poisson
    grav_temporal_extrp [BOOLEAN] [FALSE]
        extrapolate or otherwise rescale
    point_mass [REAL] [0.e0]
        Valid Values: Unconstrained
        mass of the central point-like object
    point_mass_rsoft [REAL] [0.e0]
        Valid Values: Unconstrained
        softening radius for the point-like mass (in units of
    updateGravity [BOOLEAN] [TRUE]
        allow gravity value to be updated

physics/Hydro/HydroMain
    UnitSystem [STRING] ["none"]
        Valid Values: Unconstrained
        System of Units
    cfl [REAL] [0.8]
        Valid Values: Unconstrained
        Courant factor
    irenorm [INTEGER] [0]
        Valid Values: Unconstrained
        Renormalize the abundances before eos
    use_cma_advection [BOOLEAN] [FALSE]

    use_cma_flattening [BOOLEAN] [FALSE]
        use the flattening procedure for the abundances as described in the CMA
        paper
    use_cma_steepening [BOOLEAN] [FALSE]

    use_steepening [BOOLEAN] [TRUE]


physics/Hydro/HydroMain/split/MHD_8Wave
    irenorm [INTEGER] [0]
        Valid Values: Unconstrained

    killdivb [BOOLEAN] [TRUE]

    small [REAL] [1.E-10]
        Valid Values: Unconstrained
        Cutoff value
    smalle [REAL] [1.E-10]
        Valid Values: Unconstrained
        Cutoff value for energy
    smallp [REAL] [1.E-10]
        Valid Values: Unconstrained
        Cutoff value for pressure
    smallt [REAL] [1.E-10]
        Valid Values: Unconstrained
        Cutoff value for temperature
    smallu [REAL] [1.E-10]
        Valid Values: Unconstrained
        Cutoff value for velocity
    smallx [REAL] [1.E-10]
        Valid Values: Unconstrained
        Cutoff value for abundances
    smlrho [REAL] [1.E-10]
        Valid Values: Unconstrained
        Cutoff value for density

physics/Hydro/HydroMain/split/PPM
    cvisc [REAL] [0.1]
        Valid Values: Unconstrained
        Artificial viscosity constant
    dp_sh [REAL] [0.33]
        Valid Values: Unconstrained

    dp_sh_md [REAL] [0.33]
        Valid Values: Unconstrained
        pressure jump for multi-dimensional shock detection
    epsiln [REAL] [0.33]
        Valid Values: Unconstrained
        PPM shock detection parameter
    hy_fluxRepresentation [STRING] ["fluxes"]
        Valid Values: "hybrid", "fluxes", "auto"
        determines the nature of the data stored in flux arrays. With this
        parameter set to "fluxes", the fluxes and cell volumes used in the Hydro
        method are calculated correctly using geometry measures (in units
        matching those in which coordinates are represented). If
        hy_fluxRepresentation is "hybrid", fluxes are calculated in a simpler
        way; for example, the fluxes in Cartesian coordinates use the convention
        Face Area == 1 (and thus Cell Volume == dx during the X sweep, etc.).
        Both settings lead to a correct algorithm, because what is ultimately
        applied in the Hydro update is of the form fluxes times dt/CellVolume,
        so cell areas (thus fluxes) and volumes can be multiplied by an
        arbitrary constant (as long as it is done consistently) without changing
        results (except for rounding effects). The setting here must match
        Paramesh's understanding of what the "fluxes" are that it is being
        passed if Grid_conserveFluxes is called: If hy_fluxRepresentation is
        "fluxes", then Paramesh4 should have set consv_fluxes==.true., 
        consv_flux_densities==.false. If hy_fluxRepresentation is "hybrid", then
        Paramesh4 should have set consv_fluxes==.false.,
        consv_flux_densities==.true. Hydro_init will try to set Paramesh to the
        right mode if possible, this requires Paramesh to be compiled in LIBRARY
        mode. If this fails, the flux representation will be modified to
        correspond to what the Grid unit supports. A third possible value for
        hy_fluxRepresentation is "auto", in which case the Hydro code unit will
        pick either "fluxes" or "hybrid" based on geometry and support in Grid.
    hybrid_riemann [BOOLEAN] [FALSE]
        use HLLE in shocks to remove odd-even decoupling
    igodu [INTEGER] [0]
        Valid Values: Unconstrained
        Use Godunov method
    iplm [INTEGER] [0]
        Valid Values: Unconstrained
        Use linear profiles
    leveque [BOOLEAN] [FALSE]
        modify states due to gravity -- leveque's way.
    nriem [INTEGER] [10]
        Valid Values: Unconstrained
        No. of iterations in Riemann solver
    omg1 [REAL] [0.75]
        Valid Values: Unconstrained
        PPM dissipation parameter omega1
    omg2 [REAL] [10.]
        Valid Values: Unconstrained
        PPM dissipation parameter omega2
    ppm_modifystates [BOOLEAN] [FALSE]
        modify states due to gravity -- our way.
    rieman_tol [REAL] [1.0e-5]
        Valid Values: Unconstrained
        Converge factor for Riemann solver
    small [REAL] [1.E-10]
        Valid Values: Unconstrained
        Cutoff value ... DEV: for what?
    smalle [REAL] [1.E-10]
        Valid Values: Unconstrained
        Cutoff value for energy
    smallp [REAL] [1.E-10]
        Valid Values: Unconstrained
        Cutoff value for pressure
    smallt [REAL] [1.E-10]
        Valid Values: Unconstrained
        Cutoff value for temperature
    smallu [REAL] [1.E-10]
        Valid Values: Unconstrained
        Cutoff value for velocity
    smallx [REAL] [1.E-10]
        Valid Values: Unconstrained
        Cutoff value for abundances
    smlrho [REAL] [1.E-10]
        Valid Values: Unconstrained
        Cutoff value for density
    vgrid [REAL] [0.]
        Valid Values: Unconstrained
        Scale factor for grid velocity

physics/Hydro/HydroMain/split/RHD
    reconType [INTEGER] [2]
        Valid Values: Unconstrained
        Order of reconstruction
    small [REAL] [1.E-10]
        Valid Values: Unconstrained
        Cutoff value
    smalle [REAL] [1.E-10]
        Valid Values: Unconstrained
        Cutoff value for energy
    smallp [REAL] [1.E-10]
        Valid Values: Unconstrained
        Cutoff value for pressure
    smallt [REAL] [1.E-10]
        Valid Values: Unconstrained
        Cutoff value for temperature
    smallu [REAL] [1.E-10]
        Valid Values: Unconstrained
        Cutoff value for velocity
    smallx [REAL] [1.E-10]
        Valid Values: Unconstrained
        Cutoff value for abundances
    smlrho [REAL] [1.E-10]
        Valid Values: Unconstrained
        Cutoff value for density

physics/Hydro/HydroMain/unsplit/Hydro_MusclHancock
    LimitedSlopeBeta [REAL] [1.0]
        Valid Values: Unconstrained
        Any real value specific for the Limited Slope limiter
    RiemannSolver [STRING] ["Roe"]
        Valid Values: Unconstrained
        Roe, HLL, HLLC or LaxFriedrichs
    charLimiting [BOOLEAN] [TRUE]
        Apply limiting for characteristic variable
    entropy [BOOLEAN] [FALSE]
        Entropy Fix routine for the Roe Riemann solver
    entropyFixMethod [STRING] ["HARTENHYMAN"]
        Valid Values: Unconstrained
        Entropy fix method for the Roe Riemann solver: Harten or HartenHyman
    fullyLimit [BOOLEAN] [FALSE]
        Switch to use a full limiting on transverse flux differencing
    irenorm [INTEGER] [0]
        Valid Values: Unconstrained
        Renormalize abundances
    order [INTEGER] [2]
        Valid Values: Unconstrained
        1st order Godunov scheme/2nd order MUSCL-Hancock scheme
    shockDetect [BOOLEAN] [FALSE]
        Switch to use a strong compressive shock detection
    shockInstabilityFix [BOOLEAN] [FALSE]
        Fix for Roe solver's carbuncle instabilty
    slopeLimiter [STRING] ["vanLeer"]
        Valid Values: Unconstrained
        mc, vanLeer, minmod, hybrid, limited
    small [REAL] [1.E-10]
        Valid Values: Unconstrained
        Cutoff value
    smalle [REAL] [1.E-10]
        Valid Values: Unconstrained
        Cutoff value for energy
    smallp [REAL] [1.E-10]
        Valid Values: Unconstrained
        Cutoff value for pressure
    smallt [REAL] [1.E-10]
        Valid Values: Unconstrained
        Cutoff value for temperature
    smallu [REAL] [1.E-10]
        Valid Values: Unconstrained
        Cutoff value for velocity
    smallx [REAL] [1.E-10]
        Valid Values: Unconstrained
        Cutoff value for abundances
    smlrho [REAL] [1.E-10]
        Valid Values: Unconstrained
        Cutoff value for density
    tiny [REAL] [1.e-16]
        Valid Values: Unconstrained
        A threshold value for an arbitrarily small number

physics/Hydro/HydroMain/unsplit/MHD_StaggeredMesh
    E_modification [BOOLEAN] [TRUE]
        Switch for modified electric fields calculation from flux
    ForceHydroLimit [BOOLEAN] [FALSE]
        Switch to force B=0 limit, i.e., the solver will not update B fields
    LimitedSlopeBeta [REAL] [1.0]
        Valid Values: Unconstrained
        Any real value specific for the Limited Slope limiter
    RiemannSolver [STRING] ["Roe"]
        Valid Values: Unconstrained
        Roe, HLL, HLLC, HLLD or LaxFriedrichs
    charLimiting [BOOLEAN] [TRUE]
        Apply limiting for characteristic variable
    energyFix [BOOLEAN] [FALSE]
        Energy fix routine after updating face magnetic fields
    entropy [BOOLEAN] [FALSE]
        Entropy Fix routine for the Roe Riemann solver
    entropyFixMethod [STRING] ["HARTENHYMAN"]
        Valid Values: Unconstrained
        Entropy fix method for the Roe Riemann solver: Harten or HartenHyman
    facevar2ndOrder [BOOLEAN] [TRUE]
        Switch to use 2nd order data reconstruction-evolution of facevars
    fullyLimit [BOOLEAN] [FALSE]
        Switch to use a full limiting on transverse flux differencing
    irenorm [INTEGER] [0]
        Valid Values: Unconstrained
        Renormalize abundances
    killdivb [BOOLEAN] [TRUE]
        Switch for maintaing solenoidal field
    order [INTEGER] [2]
        Valid Values: Unconstrained
        1st order Godunov scheme/2nd order MUSCL-Hancock scheme
    prolMethod [STRING] ["INJECTION_PROL"]
        Valid Values: Unconstrained
        Injection or Balsara's method in prolongation
    shockDetect [BOOLEAN] [FALSE]
        Switch to use a strong compressive shock detection
    shockInstabilityFix [BOOLEAN] [FALSE]
        Switch to enable a fix for carbuncle instability
    slopeLimiter [STRING] ["vanLeer"]
        Valid Values: Unconstrained
        mc, vanLeer, minmod, hybrid, limited
    small [REAL] [1.E-10]
        Valid Values: Unconstrained
        Cutoff value
    smalle [REAL] [1.E-10]
        Valid Values: Unconstrained
        Cutoff value for energy
    smallp [REAL] [1.E-10]
        Valid Values: Unconstrained
        Cutoff value for pressure
    smallt [REAL] [1.E-10]
        Valid Values: Unconstrained
        Cutoff value for temperature
    smallu [REAL] [1.E-10]
        Valid Values: Unconstrained
        Cutoff value for velocity
    smallx [REAL] [1.E-10]
        Valid Values: Unconstrained
        Cutoff value for abundances
    smlrho [REAL] [1.E-10]
        Valid Values: Unconstrained
        Cutoff value for density
    tiny [REAL] [1.e-16]
        Valid Values: Unconstrained
        A threshold value for an arbitrarily small number

physics/materialProperties/Conductivity
    useConductivity [BOOLEAN] CONSTANT [FALSE]
        flags whether the conductivity material property is being used

physics/materialProperties/Conductivity/ConductivityMain
    useConductivity [BOOLEAN] [TRUE]
        flags whether the conductivity material property is being used

physics/materialProperties/Conductivity/ConductivityMain/Constant
    cond_constantIsochoric [REAL] [1.0]
        Valid Values: Unconstrained


physics/materialProperties/Conductivity/ConductivityMain/Constant-diff
    diff_constant [REAL] [1.0]
        Valid Values: Unconstrained


physics/materialProperties/MagneticResistivity
    useMagneticResistivity [BOOLEAN] CONSTANT [FALSE]
        -- allows the MagneticResisitivity to be turned off at runtime, even if
        the unit is included in the simulation

physics/materialProperties/MagneticResistivity/MagneticResistivityMain
    useMagneticResistivity [BOOLEAN] [TRUE]
        flags whether the magnetic resistivity material property is being used

physics/materialProperties/MagneticResistivity/MagneticResistivityMain/Constant
    resistivity [REAL] [0.0]
        Valid Values: Unconstrained


physics/materialProperties/MassDiffusivity
    useMassDiffusivity [BOOLEAN] CONSTANT [FALSE]
        -- allows the mass diffusivity to be turned off at runtime, even if the
        unit is included in the simulation

physics/materialProperties/Viscosity
    useViscosity [BOOLEAN] CONSTANT [FALSE]
        flags whether the viscosity material property is being used

physics/materialProperties/Viscosity/ViscosityMain
    useViscosity [BOOLEAN] [TRUE]
        flags whether the viscosity material property is being used
    viscSuppressFactor [REAL] [1.0]
        Valid Values: Unconstrained
        -- allows the viscosity to be suppressed
    viscTempHigh [REAL] [1.5e8]
        Valid Values: Unconstrained
        -- turn off viscosity for temps higher than this
    viscTempLow [REAL] [3.0e5]
        Valid Values: Unconstrained
        -- turn off viscosity for temps lower than this

physics/materialProperties/Viscosity/ViscosityMain/Constant
    diff_visc_mu [REAL] [.1]
        Valid Values: Unconstrained
        constant dynamic viscosity (used in Constant Viscosity if
        visc_whichCoefficientIsConst is 1)
    diff_visc_nu [REAL] [.1]
        Valid Values: Unconstrained
        constant kinematic viscosity (used in Constant Viscosity if
        visc_whichCoefficientIsConst is 2)
    visc_whichCoefficientIsConst [INTEGER] [2]
        Valid Values: 1, 2
        which kind of coefficient to keep constant in Constant Viscosity
        implementation; set to 1 for constant dynamic viscosity (the value of
        diff_visc_mu is used); set to 2 for constant kinematic viscosity (the
        value of diff_visc_nu is used).

physics/sourceTerms/Burn
    useBurn [BOOLEAN] [FALSE]
        shall I burn?

physics/sourceTerms/Burn/BurnMain
    enucDtFactor [REAL] [1.e30]
        Valid Values: Unconstrained
        Limit timestep to limit total energy deposited by burning
    useShockBurn [BOOLEAN] [FALSE]
        Is burning allowed within shocks?

physics/sourceTerms/Burn/BurnMain/nuclearBurn
    algebra [INTEGER] [1]
        Valid Values: 1 to 2
        choice of linear algebra package & 1 = MA28 ;  2 = GIFT
    nuclearDensMax [REAL] [1.0E14]
        Valid Values: 0 to INFTY
        Max burning density
    nuclearDensMin [REAL] [1.0E-10]
        Valid Values: 0 to INFTY
        Min burning density
    nuclearNI56Max [REAL] [1.0]
        Valid Values: 0 to INFTY
        Max Ni56 mass frac. for burning
    nuclearTempMax [REAL] [1.0E12]
        Valid Values: 0 to INFTY
        Max burning temperature
    nuclearTempMin [REAL] [1.1E8]
        Valid Values: 0 to INFTY
        Min burning temperature
    odeStepper [INTEGER] [1]
        Valid Values: 1 to 2
        choice of ode time stepper 1 = Bader-Deuflhard variable order 2 =
        Rosenbrock 4th order
    useBurnTable [BOOLEAN] [FALSE]
        choice of rate evaluation FALSE = analytic rates TRUE = table
        interpolation

physics/sourceTerms/Cool
    useCool [BOOLEAN] [FALSE]
        Runtime control for turning off cooling

physics/sourceTerms/Diffuse
    useDiffuse [BOOLEAN] CONSTANT [FALSE]
        flags whether the Diffuse unit is being used

physics/sourceTerms/Diffuse/DiffuseMain
    diffusion_cutoff_density [REAL] [1.e-30]
        Valid Values: Unconstrained
        density below which we no longer diffuse
    dt_diff_factor [REAL] [0.8]
        Valid Values: Unconstrained
        factor that scales the timestep returned by Diffuse_computeDt
    geometric_mean_diff [BOOLEAN] [FALSE]

    thermal_diff_method [INTEGER] [1]
        Valid Values: Unconstrained

    useDiffuse [BOOLEAN] [TRUE]
        whether any method of the Diffuse unit should contribute to fluxes
    useDiffuseSpecies [BOOLEAN] [TRUE]
        whether Diffuse_species [TO BE IMPLEMENTED] should contribute to fluxes
    useDiffuseTherm [BOOLEAN] [TRUE]
        whether Diffuse_therm should contribute to fluxes
    useDiffuseVisc [BOOLEAN] [TRUE]
        whether Diffuse_visc should contribute to fluxes

physics/sourceTerms/Heat
    useHeat [BOOLEAN] [FALSE]
        runtime control for turning the heat on or off

physics/sourceTerms/Ionize/IonizeMain
    dneimax [REAL] [1.0E12]
        Valid Values: Unconstrained
        Max NEI density
    dneimin [REAL] [1.0E0]
        Valid Values: Unconstrained
        Min NEI density
    tneimax [REAL] [1.0E7]
        Valid Values: Unconstrained
        Max NEI temperature
    tneimin [REAL] [1.0E4]
        Valid Values: Unconstrained
        Min NEI temperature
    useIonize [BOOLEAN] [TRUE]
        Use ionization module

physics/sourceTerms/Stir
    useStir [BOOLEAN] [TRUE]


physics/sourceTerms/Stir/StirMain
    st_computeDt [BOOLEAN] [FALSE]

    st_decay [REAL] [.1]
        Valid Values: Unconstrained

    st_energy [REAL] [.01]
        Valid Values: Unconstrained

    st_freq [INTEGER] [1]
        Valid Values: Unconstrained

    st_seed [INTEGER] [2]
        Valid Values: Unconstrained

    st_stirmax [REAL] [62.8]
        Valid Values: Unconstrained

    st_stirmin [REAL] [31.4]
        Valid Values: Unconstrained