namespace: maestro

synchronization

parameter

description

default value

reflux_type

Advective synchronization type 0 = do nothing 1 = average down the fluxes (thermo variables) and edge velocities 2 = use Reflux operations (thermo variables) and average down velocities

1

general MAESTRO

parameter

description

default value

maestro_verbose

General verbosity

1

problem initialization

parameter

description

default value

model_file

input model file

“”

perturb_model

Turn on a perturbation in the initial data. Problem specific.

false

print_init_hse_diag

print out HSE diagnostics as a function of r for the initial model

false

basestate_use_pres_model

do we use rho, T or rho, P from the initial model to establish thermodynamics

0

timestepping

parameter

description

default value

stop_time

simulation stop time

-1.0

max_step

Maximum number of steps in the simulation.

-1

cfl

CFL factor to use in the computation of the advection timestep constraint

0.5

init_shrink

the multiplicative factor (\(\le 1\)) to reduce the initial timestep as computed by the various timestep estimators

1.0

small_dt

the minimum allowed timestep – we abort if dt drops below this value

1.e-10

max_dt_growth

The maximum scale factor that the time step is allowed to grow by per time step.

1.1

max_dt

This is the maximum dt that is allowed

1.e33

fixed_dt

Fix the time step. If -1.0, then use the standard time step.

-1.0

nuclear_dt_fac

If \(T_{max}^n > T_{max}^{n-1}\) set the new dt = min[dt, dt*{\tt nuclear\_dt\_fac}*( \(T_{max}^{n-1}\) / \((T_{max}^n-T_{max}^{n-1})\) ) ] for example, {\tt nuclear\_dt\_fac} = 0.01 means don’t let the max temp grow more than approximately 1 percent not checkpoint- compatible yet since it wouldn’t be backwards compatible

-1.0

use_soundspeed_firstdt

Use the soundspeed constraint when computing the first time step.

false

use_divu_firstdt

Use the divu constraint when computing the first time step.

false

grid

parameter

description

default value

spherical

Set to true if you are doing a spherical problem.

false

octant

set octant = T if you just want to model an octant of a sphere (note: only takes effect for spherical geometry)

false

do_2d_planar_octant

Set to true if using the 2D simplified (planar) model of an octant.

false

regrid_int

How often we regrid.

-1

amr_buf_width

the number of buffer zones surrounding a cell tagged for refinement. note that this needs to be >= regrid_int

-1

drdxfac

ratio of radial base state zones to Cartesian full state zones for spherical geometry

1

minwidth

The minimum size on a side for a grid created using make_new_grids.

8

min_eff

parameter for cluster algorithm for making new grids in adaptive problems

0.9

use_tpert_in_tagging

pass \(T'\) into the tagging routines as the auxiliary multifab instead of the default $\rho H_mathrm{nuc}$.

false

output

parameter

description

default value

plot_int

plot interval

0

small_plot_int

small plot interval

0

plot_deltat

rather than use a plot interval, plot a file after the solution has advanced past plot_deltat in time

-1.0

small_plot_deltat

rather than use a plot interval, plot a small plotfile after the solution has advanced past small_plot_deltat in time

-1.0

chk_int

Number of timesteps between writing a checkpoint file

0

chk_deltat

rather than output a checkpoint after a fixed number of timesteps, output after the solution has advanced past chk_deltat in time

-1.0

plot_h_with_use_tfromp

Turn on storing of enthalpy-based quantities in the plotfile when we are running with {tt use_tfromp} NOT IMPLEMENTED YET

true

plot_spec

plot species and omegadot in plotfile

true

plot_omegadot

plot omegadot in plotfile

true

plot_aux

plot auxiliary variables in plotfile

false

plot_Hext

plot external heating (Hext) in plotfile

false

plot_Hnuc

plot nuclear energy generation rate (Hnuc) in plotfile

true

plot_eta

plot \(\etarho\) in plotfile

false

plot_trac

plot tracers in plotfile NOT IMPLEMENTED YET

false

plot_base_state

plot w0_x, w0_y, w0_z, divw0, rho0, rhoh0, h0, and p0 in plotfile

true

plot_gpi

plot pi and grad(pi)

true

plot_cs

plot soundspeed

false

plot_grav

plot gravitational acceleration

false

plot_base_name

prefix to use in plotfile file names

“plt”

small_plot_base_name

prefix to use in small plotfile file names

“smallplt”

check_base_name

prefix to use in checkpoint file names

“chk”

diag_buf_size

number of timesteps to buffer diagnostic output information before writing (note: not implemented for all problems)

10

plot_ad_excess

plot the adiabatic excess

false

plot_processors

create a field in the plotfile storing the processor number for each zone

false

plot_pidivu

plot pi * div(U) – this is a measure of conservation of energy

false

small_plot_vars

small plot file variables

“rho

algorithm initialization

parameter

description

default value

init_iter

Number of initial pressure iterations.

4

init_divu_iter

Number of initial divu iterations.

4

restart_file

Which file to restart from. Empty string means do not restart

“”

restart_into_finer

restart and add a level of refinement

false

do_initial_projection

Do the initial projection.

true

linear solvers

parameter

description

default value

mg_verbose

Verbsoity of the multigrid solver, but not the bottom solver.

1

cg_verbose

Verbosity of bottom solver

0

mg_cycle_type

Type of cycle used in the MAC multigrid – 1 = F-cycle, 2 = W-cycle, 3 = V-cycle

3

hg_cycle_type

Type of cycle used in the nodal multigrid – 1 = F-cycle, 2 = W-cycle, 3 = V-cycle

3

hg_bottom_solver

4 is the fancy agglomerating bottom solver otherwise it uses the default MLMG non-agglomerating

4

mg_bottom_solver

4 is the fancy agglomerating bottom solver otherwise it uses the default MLMG non-agglomerating

4

max_mg_bottom_nlevels

if mg_bottom_solver == 4, then how many mg levels can the bottom solver mgt object have

1000

mg_bottom_nu

number of smoothing iterations to do after the multigrid bottom solver

10

mg_nu_1

number of smoothing iterations to do going down the V-cycle

2

mg_nu_2

number of smoothing iterations to do going up the V-cycle

2

hg_dense_stencil

In hgproject, in 2D, use a 9 point Laplacian (true) or 5-point Laplacian (false). In 3D, use a 27 point Laplacian (true) or 7-point Laplacian (false).

true

hydrodynamics

parameter

description

default value

do_sponge

Use sponging.

false

sponge_kappa

Parameter for sponge. Problem dependent.

10.e0

sponge_center_density

Center of the inner sponge.

3.e6

sponge_start_factor

The sponge begins at sponge_center_density * sponge_start_factor.

3.333e0

plot_sponge_fdamp

plot fdamp rather than sponge assumes sponge has the form 1/(1+dt*{tt sponge_kappa}*fdamp)

false

anelastic_cutoff_density

The density below which we modify the constraint to look like the anelastic constraint, instead of the low Mach constraint. This prevents velocities from getting out of hand at the edge of the star. Refer to Section ref{Sec:Anelastic Cutoff}.

-1.0

base_cutoff_density

The density below which we keep the initial model constant. Refer to Section ref{Sec:Base Cutoff Density}

-1.0

burning_cutoff_density_lo

The density below which we disable burning

-1.0

burning_cutoff_density_hi

The density above which we disable burning

1.e100

heating_cutoff_density_lo

The density below which we disable heating

-1.0

heating_cutoff_density_hi

The density above which we disable heating

1.e100

buoyancy_cutoff_factor

The multiplicative factor (over base_cutoff_density) below which we do zero out the buoyancy term in the momentum equation.

5.0

dpdt_factor

factor in front of the volume discrepancy term (0.0 = off)

0.0

do_planar_invsq_grav

are we doing 1/r\(^2\) gravity for plane-parallel

false

planar_invsq_mass

the point mass for planar 1/r\(^2\) gravity

0.0

evolve_base_state

turn on (true) or off (false) basestate evolution

true

use_exact_base_state

turn on (true) or off (false) irregularly-spaced basestate

false

fix_base_state

if true, don’t call average to reset the base state at all, even during initialization

false

average_base_state

turn on (true) or off (false) basestate evolution that uses averages of cell-centered data instead of advecting

false

do_smallscale

force \(\rho_0 = (\rho h)_0 = 0\), {\tt evolve\_base\_state = F} and {\tt beta\_type} = 3

false

do_eos_h_above_cutoff

After the advective enthalpy update, recompute the enthalpy if we are below the base cutoff density.

true

enthalpy_pred_type

predict_rhoh = 0; predict_rhohprime = 1; predict_h = 2; predict_T_then_rhohprime = 3; predict_T_then_h = 4; predict_hprime = 5; predict_Tprime_then_h = 6.

1

species_pred_type

Which quantities do we predict to the edges for computing the (\(\rho X\)) edge states? {\tt species\_pred\_type} = 1 means predict \(\rho^\prime\) and \(X\) separately. {\tt species\_pred\_type} = 2 means predict the full (\(\rho X\)) itself. {\tt species\_pred\_type} = 3 means predict \(\rho\) and \(X\) separately.

1

use_delta_gamma1_term

turns on second order correction to delta gamma1 term

true

use_etarho

turn on the etarho term as described in flow chart

true

add_pb

turns on pressure correction to make the top an impenetrable boundary

false

slope_order

order of slopes in piecewise linear Godunov algorithm. Options are 0, 2, or 4.

4

grav_const

the gravitational acceleration (cm~s\(^{-2}\)) for plane- parallel geometry

-1.5e10

ppm_type

0 = no ppm (piecewise linear slopes instead) 1 = 1984 ppm 2 = Hybrid Sekora/Colella and McCorquodale/Colella 2009/2010 ppm

1

bds_type

0 = use ppm instead for multi-d integrator 1 = bilinear

0

ppm_trace_forces

if 1, then perform parabolic reconstruction on the forces used in the prediction and trace under the parabola to the interfaces the amount that can reach the interface over dt

0

beta0_type

what type of coefficient to use inside the velocity divergence constraint. {\tt beta0\_type} = 1 uses \(\beta_0\); {\tt beta0\_type} = 2 uses \(\rho_0\) (anelastic); {\tt beta0\_type} = 3 uses 1 (small-scale combustion).

1

use_linear_grav_in_beta0

how to represent gravity in the \(\beta_0\) integration: true = piecewise linear false = piecewise constant

false

rotational_frequency

rotational frequency used for computing centrifugal term in rotation problems.

0.0

co_latitude

latitude, in radians, for problems with rotation where the domain is only a subset of a full star.

0.0

rotation_radius

radius used for computing centrifugal term in rotation problems

1.0e6

use_centrifugal

include (true) or exclude (false) centrifugal term

true

mach_max_abort

maximum mach number before the code aborts

-1.0

drive_initial_convection

freeze the temperature used in the reaction network to the initial value. This is useful for developing an initial convective field to carry away the energy, while preventing the reactions from going nonlinear.

false

stop_initial_convection

timestep beyond which we set {tt drive_initial_convection} = F

-1

restart_with_vel_field

restart the simulation using a result from a {tt drive_initial_convection} = T run note that this uses the restart variable to specify which file to restart from. After reading in the velocity information from the restart file, the time and timestep number are zeroed.

false

use_alt_energy_fix

modify the momentum equation to have \((\beta_0/\rho) \nabla (\pi/\beta_0)\) instead of just \((1/\rho) \nabla (\pi)\)

true

use_omegadot_terms_in_S

do we include the explicit omegadot terms in the constraint RHS source S?

true

thermal diffusion

parameter

description

default value

use_thermal_diffusion

Use thermal diffusion.

false

temp_diffusion_formulation

How to compute the explicit thermal diffusion term. 1 = in terms of \(T\); 2 = in terms of \(\rho,p_0,X\).

2

thermal_diffusion_type

In the thermal diffusion solver, 1 = Crank-Nicholson; 2 = Backward Euler.

1

limit_conductivity

apply the conductivity limiting—if T, then we set the thermal coefficients all to 0 for \(\rho <\) {\tt buoyancy\_cutoff\_factor} * {\tt base\_cutoff\_density}

false

burning

parameter

description

default value

do_burning

turn on (true) or off (false) burning

true

burner_threshold_species

Name of the species to be used in burner threshold

“”

burner_threshold_cutoff

Mass fraction cutoff for burner_threshold_species used in burner threshold

1.e-10

do_subgrid_burning

break a zone into subzones, call the burner in each subzone and then average the result to the original cell

false

reaction_sum_tol

mass fraction sum tolerance (if they don’t sum to 1 within this tolerance, we abort)

1.e-10

EOS

parameter

description

default value

small_temp

5.e6

small_dens

1.e-5

use_tfromp

When updating temperature, use \(T=T(\rho,p_0,X) \) rather than \(T=T(\rho,h,X)\).

false

use_eos_e_instead_of_h

In deriving the temperature from the \(h\), first subtract off \(p_0/\rho\) to define \(e\), and use that as the input to the EOS.

false

use_pprime_in_tfromp

false

base state mapping

parameter

description

default value

s0_interp_type

The interpolation for filling a cell-centered multifab from a 1D bin-centered array. 1 = piecewise constant; 2 = piecewise linear; 3 = quadratic

3

w0_interp_type

The interpolation for filling a cell-centered multifab from a 1D edge-centered array. 1 = piecewise constant; 2 = piecewise linear; 3 = quadratic

2

s0mac_interp_type

The interpolation for filling an edge based multifab from a 1D bin-centered array. 1 = Interpolate s0 to cell centers (with s0_interp_type), then average to edges; 2 = Interpolate s0 to edges directly using linear interpolation; 3 = Interpolate s0 to edges directly using quadratic interpolation.

1

w0mac_interp_type

The interpolation for putting w0 on edges. We only compute the normal component. 1 = Interpolate w0 to cell centers (with w0_interp_type), then average to edges; 2 = Interpolate w0 to edges directly using linear interpolation; 3 = Interpolate w0 to edges directly using quadratic interpolation; 4 = Interpolate w0 to nodes using linear interpolation, then average to edges.

1

diagnostics, I/O

parameter

description

default value

print_update_diagnostics

display information about updates to the state (how much mass, momentum, energy added)

(0, 1)

track_grid_losses

calculate losses of material through physical grid boundaries

0

sum_interval

how often (number of coarse timesteps) to compute integral sums (for runtime diagnostics)

-1

sum_per

how often (simulation time) to compute integral sums (for runtime diagnostics)

-1.0e0

show_center_of_mass

display center of mass diagnostics

0

hard_cfl_limit

abort if we exceed CFL = 1 over the course of a timestep

1

job_name

a string describing the simulation that will be copied into the plotfile’s {tt job_info} file

“”

output_at_completion

write a final plotfile and checkpoint upon completion

1

reset_checkpoint_time

Do we want to reset the time in the checkpoint? This ONLY takes effect if amr.regrid_on_restart = 1 and amr.checkpoint_on_restart = 1, (which require that max_step and stop_time be less than the value in the checkpoint) and you set it to value greater than this default value.

-1.e200

reset_checkpoint_step

Do we want to reset the number of steps in the checkpoint? This ONLY takes effect if amr.regrid_on_restart = 1 and amr.checkpoint_on_restart = 1, (which require that max_step and stop_time be less than the value in the checkpoint) and you set it to value greater than this default value.

-1

particles

parameter

description

default value

use_particles

call the particle initialization, advection, etc. routines.

false

store_particle_vels

store the velocity of the particle?

false

heating

parameter

description

default value

do_heating

use analytic heating

false

GPU

parameter

description

default value

deterministic_nodal_solve

The nodal solve is non-deterministic on the GPU. Should it instead be run on the CPU to give a deterministic solution?

false

solver tolerances

parameter

description

default value

eps_init_proj_cart

tolerances for the initial projection

1.e-12

eps_init_proj_sph

1.e-10

eps_divu_cart

tolerances for the divu iterations

1.e-12

eps_divu_sph

1.e-10

divu_iter_factor

divu_level_factor

eps_mac

tolerances for the MAC projection

1.e-10

eps_mac_max

1.e-8

mac_level_factor

eps_mac_bottom

1.e-3

eps_hg

tolerances for the nodal projection

1.e-12

eps_hg_max

1.e-10

hg_level_factor

eps_hg_bottom

1.e-4