Governing Equations

The equation set and solution procedure used by MAESTROeX has changed and improved over time. In this chapter, we outline the model equations and algorithmic options in the code. The latest published references for MAESTROeX are the multilevel paper [NonakaAlmgrenBell+10] and the more recent [FanNonakaAlmgren+19]. These two papers use the same model equations, however the more recent paper, in addition to retaining the original algorithmic capability of the previous code, includes an option to use a new, simplified temporal integration scheme. We distinguish between the two temporal integration strategies by referring to them as the “original temporal scheme” and “new temporal scheme”. In this description, we make frequent reference to papers I-IV and the multilevel paper (see § Introduction to MAESTROeX), which describe the developments of the original temporal scheme.

Summary of the MAESTROeX Equation Set

Here we summarize the equations solved by MAESTROeX. We refer the reader to papers I through IV for the derivation and motivation of the equation set. We take the standard equations of reacting, compressible flow, and recast the equation of state (EOS) as a divergence constraint on the velocity field. The resulting model is a series of evolution equations for mass, energy, and momentum, subject to an additional constraint on velocity, with a base state density and pressure linked via hydrostatic equilibrium:

(14)ρXkt+(ρUXk)=ρω˙k
(15)(ρh)t=(ρhU)+Dp0Dt+ρHnuc+ρHext,
(16)Ut+UU+β0ρ(pβ0)=ρρ|g|er
(17)(β0U)=β0(S1Γ1p0p0t)
(18)p0=ρ0|g|er

We discuss each of these equations in further detail below.

Lateral Average

A key concept in the MAESTROeX equation set and algorithm is the lateral average. The lateral average represents the average value of a quantity at a given radius in spherical simulations (or a given height in planar simulations). We denote the lateral average of a quantity with an overline, e.g., for any quantity ϕ, we denote the average of ϕ over a layer at constant radius as ϕ. For planar problems this routine is a trivial average of all the values at a given height. For spherical problems there is a novel interpolation routine we use to average 3D data representing a full spherical star into a 1D array representing the average. Details can be found in [NonakaAlmgrenBell+10] and [FanNonakaAlmgren+19].

For the velocity field, we can decompose the full velocity field into a base state velocity and a local velocity,

(19)U=w0(r,t)er+U~(x,t).

where r is a 1D radial coordinate, x is a 3D Cartesian grid coordinate, and er is the unit vector in the outward radial direction. Note that (U~er)=0 and w0=(Uer). In other words, the base state velocity can be thought of as the lateral average of the outward radial velocity. For the velocity decompsotion, we do not use the same spatial averaging operators used for all other variables; instead we derive an analytic expression for the average expansion velocity and numerically integrate this expression to obtain w0.

Mass

Conservation of mass gives the same continuity equation we have with compressible flow:

(20)ρt+(ρU)=0,

where ρ is the total mass density. Additionally, we model the evolution of individual species that advect and react. The creation and destruction of the species is described by their create rate, ω˙k, and the species are defined by their mass fractions, Xkρk/ρ, giving

(21)ρXkt+(ρUXk)=ρω˙k

and

(22)kXk=1

In the original temporal scheme, we need to model the evolution of a base state density, ρ0. The governing equation can be obtained by laterally averaging the full continuity equation, giving:

(23)ρ0t=(ρ0w0er),

Subtracting these two yields the evolution equation for the perturbational density, ρρρ0:

(24)ρt=UρρU(ρ0U~)

As first discussed in paper III and then refined in the multilevel paper, we capture the changes that can occur due to significant convective overturning by imposing the constraint that ρ=0 for all time. This gives

(25)ρt=(ηρer).

where

(26)ηρ=(ρUer)

In practice, we correct the drift by simply setting ρ0=ρ after the advective update of ρ. However we still need to explicitly compute ηρ since it appears in other equations.

Energy

We model the evolution of specific enthalpy, h. Strictly speaking this is not necessary to close the system, but a user can enable the option to couple the energy with the rest of the system by using the enthalpy to define the temperature. The advantages of this coupling is an area of active research. The evolution equation is

(27)(ρh)t=(ρhU)+Dp0Dt+ρHnuc+ρHext,

where p0 is the 1D base state pressure, Hnuc and Hext are energy sources due to reactions and user-defined external heating.

When we are using thermal diffusion, there will be an additional term in the enthalpy equation (see § Thermal Diffusion Changes).

In the original temporal scheme, we utilized a base state enthlpy that effectively represents the average over a layer; its evolution equation can be found by laterally averaging Eq.27

(28)(ρh)0t=[(ρh)0w0er]+ψ+ρHnuc+ρHext.

We will often expand Dp0/Dt as

(29)Dp0Dt=ψ+(U~er)p0r

where we defined

(30)ψp0t+w0p0r

In paper III, we showed that for a plane-parallel atmosphere with constant gravity, ψ=ηρg

At times, we will define a temperature equation by writing h=h(T,p,Xk) and differentiating:

(31)DTDt=1ρcp{(1ρhp)[ψ+(U~er)p0r]kρξkω˙k+ρHnuc+ρHext}.

Subtracting it from the full enthalpy equation gives:

(32)(ρh)t=U(ρh)(ρh)U[(ρh)0U~]+U~p0+(ρHnucρHnuc)+(ρHextρHext)

Base State

The stratified atmosphere is characterized by a one-dimensional time-dependent base state, defined by a base state density, ρ0, and a base state pressure, p0, in hydrostatic equilibrium:

(33)p0=ρ0|g|er

The gravitational acceleration, g is either constant or a point-mass with a 1/r2 dependence (see § Modifications for a 1/r^2 Plane-Parallel Basestate) for plane-parallel geometries, or a monopole constructed by integrating the base state density for spherical geometries.

For the time-dependence, we will define a base state velocity, w0, which will adjust the base state from one hydrostatic equilibrium to another in response to heating.

For convenience, we define a base state enthalphy, h0, as needed by laterally averaging the full enthalpy, h.

Base State Expansion

In practice, we calculate w0 by integrating the one-dimensional divergence constraint. For a plane-parallel atmosphere, the evolution is:

(34)w0r=S1Γ1p0ηρg

Then we define

(35)β0ρ0(π0/β0)r=w0t+w0w0r,

once w0 at the old and new times is known, and the advective term is computed explicitly. Then we can include this for completeness in the update for u~.

Momentum

The compressible momentum equation (written in terms of velocity is):

(36)ρUt+ρUU+p=ρ|g|er

Subtracting off the equation of hydrostatic equilibrium, and defining the perturbational pressure (sometimes called the dynamic pressure) as πpp0, and perturbational density as ρρρ0, we have:

(37)ρUt+ρUU+π=ρ|g|er

or

(38)Ut+UU+1ρπ=ρρ|g|er

This is the form of the momentum equation that we solved in papers I–IV and in the multilevel paper.

Several authors [KP12, VLB+13] explored the idea of energy conservation in a low Mach number system and found that an additional term (which can look like a buoyancy) is needed in the low Mach number formulation, yielding:

(39)Ut+UU+β0ρ(pβ0)=ρρ|g|er

This is the form that we enforce in MAESTROeX, and the choice is controlled by use_alt_energy_fix.

We decompose the full velocity field into a base state velocity, w0, that governs the base state dynamics, and a local velocity, U~, that governs the local dynamics, i.e.,

(40)U=w0(r,t)er+U~(x,t).

with (U~er)=0 and w0=(Uer)—the motivation for this splitting was given in paper II. The velocity evolution equations are then

(41)w0t=w0w0rβ0ρ0(π0/β0)r
(42)U~t=(U~+w0er)U~(U~er)w0rerβ0ρ(πβ0)+β0ρ0(π0/β0)rerρρ0ρger.

where π0 is the base state component of the perturbational pressure. By laterally averaging to Eq.45, we obtain a divergence constraint for w0:

(43)(β0w0er)=β0(S1Γ1p0p0t).

The divergence constraint for U~ can be found by subtracting Eq.43 into Eq.45, resulting in

(44)(β0U~)=β0(SS).

Velocity Constraint

The equation of state is cast into an elliptic constraint on the velocity field by differentiating p0(ρ,s,Xk) along particle paths, giving:

(45)(β0U)=β0(S1Γ1p0p0t)

where β0 is a density-like variable that carries background stratification, defined as

(46)β0(r,t)=ρ0(0,t)exp(0r1Γ1p0p0rdr),

and

(47)S=σkξkω˙k+1ρpρkpXkω˙k+σHnuc+σHext+σρkthT

where pXkp/Xk|ρ,T,Xj,jk, ξkh/Xk|p,T,Xj,jk,pρp/ρ|T,Xk, and σpT/(ρcppρ), with pTp/T|ρ,Xk and cph/T|p,Xk is the specific heat at constant pressure. The last term is only present if we are using thermal diffusion (use_thermal_diffusion = T). In this term, kth is the thermal conductivity.

In this constraint, Γ1 is the lateral average of Γ1dlogp/dlogρ|s. Using the lateral average here makes it possible to cast the constraint as a divergence. [KP12] discuss the general case where we want to keep the local variations of Γ1 (and we explored this in paper III). We also look at this in § \Gamma_1 Variation Changes

Notation

Throughout the papers describing MAESTROeX, we’ve largely kept our notation consistent. The table below defines the frequently-used quantities and provides their units.

Table 1 Definition of symbols.

symbol

description

units

cp

specific heat at constant pressure (cph/T|p,Xk)

erg g 1 K 1

f

volume discrepancy factor (0f1)

g

gravitational acceleration

cm s 2

h

specific enthalpy

erg g 1

Hext

external heating energy generation rate

erg g 1 s 1

Hnuc

nuclear energy generation rate

erg g 1 s 1

hp

hph/p|T,Xk

cm 3 g 1

kth

thermal conductivity

erg cm 1 s 1 K 1

p0

base state pressure

erg cm 3

pT

pTp/T|ρ,Xk

erg cm 3 K 1

pXk

pXkp/Xk|p,T,Xj,jk

erg cm 3

pρ

pρp/ρ|T,Xk

erg g 1

qk

specific nuclear binding energy

erg g1

r

radial coordinate (direction of gravity)

cm

s

specific entropy

erg g 1 K 1

S

source term to the divergence constraint

s 1

t

time

s

T

temperature

K

U

total velocity (U=U~+w0er

cm s 1

U~

local velocity

cm s 1

U~ADV

advective velocity (edge-centered)

cm s 1

w0

base state expansion velocity

cm s1

Xk

mass fraction of the species (kXk=1)

β0

coefficient to velocity in velocity constraint equation

g cm 3

Γ1

first adiabatic exponent (Γ1dlogp/dlogρ|s)

ηρ

ηρ(ρUer)

g cm 2 s 1

ξk

ξkh/Xk|p,T,Xj,jk

erg g 1

π

dynamic pressure

erg cm 3

π0

base state dynamic pressure

erg cm 3

ρ

mass density

g cm 3

ρ0

base state mass density

g cm 3

ρ

perturbational density (ρ=ρρ0)

g cm 3

(ρh)0

base state enthalpy density

erg cm 3

(ρh)

perturbational enthalpy density [(ρh)=ρh(ρh)0]

erg cm 3

σ

σpT/(ρcppρ)

erg 1 g

ψ

ψD0p0/Dt=p0/t+w0p0/r

erg cm 3

ω˙k

creation rate for species k (ω˙kDXk/Dt)

s 1

Time Advancement Algorithm Ingredients

The full time advancement algorithm is detailed in [NonakaAlmgrenBell+10] for the original algorithm and [FanNonakaAlmgren+19] for the new, simplified algorithm. We do not repeat that here.

The overall flow of the algorithm is depicted in the following flowcharts:

_images/flowchart.png

Fig. 1 A flowchart of the algorithm. The thermodynamic state variables, base state variables, and local velocity are indicated in each step. Red text indicates that quantity was updated during that step. The predictor-corrector steps are outlined by the dotted box. The blue text indicates state variables that are the same in Step 6 as they are in Step 2, i.e., they are unchanged by the predictor steps. The diffusion steps (4a and 8a) are optional, depending on use_thermal_diffusion.

_images/flowchart_4_8.png

Fig. 2 A flowchart for Steps 4 and 8. The thermodynamic state variables and base state variables are indicated in each step. Red text indicates that quantity was updated during that step. Note, for Step 4, the updated quantities should also have a superscript, e.g., Step 8I defines T(2) while Step 4I defines T(2),.

Here are some of the basic ingredients to the solver:

Definitions

Below we define operations that will be referenced in § Volume Discrepancy Changes.

React State[ρin,(ρh)in,Xkin,Tin,(ρHext)in,p0in][ρout,(ρh)out,Xkout,Tout,(ρω˙k)out,(ρHnuc)out] evolves the species and enthalpy due to reactions through Δt/2 according to:

(48)dXkdt=ω˙k(ρ,Xk,T);dTdt=1cp(kξkω˙k+Hnuc).

Here the temperature equation comes from Eq.31 with Dp0/Dt=0 for the burning part of the evolution.

Full details of the solution procedure can be found in Paper III. We then define:

(49)(ρω˙k)out=ρout(XkoutXkin)Δt/2,(ρh)out=(ρh)in+Δt2(ρHnuc)out+Δt2(ρHext)in.

where the enthalpy update includes external heat sources (ρHext)in. As introduced in Paper IV, we update the temperature using Tout=T(ρout,hout,Xkout) for planar geometry or Tout=T(ρout,p0in,Xkout) for spherical geometry, with this behavior controlled by use_tfromp. Note that the density remains unchanged within React State, i.e., ρout=ρin.

The source code for this operation can be found in react_state.f90.

Advect Base Density

[ρ0in,w0in][ρ0out,ρ0out,n+12] is the process by which we update the base state density through Δt in time. We keep the time-centered edge states, ρ0out,n+12, since they are used later in discretization of ηρ for planar problems.

  • planar:

    We discretize equation Eq.23 to compute the new base state density,

    (50)ρ0,jout=ρ0,jinΔtΔr[(ρ0out,n+12w0in)j+12(ρ0out,n+12w0in)j12].

    We compute the time-centered edge states, ρ0j±12out,n+12, by discretizing an expanded form of Eq.23:

    (51)ρ0t+w0ρ0r=ρ0w0r,

    where the right hand side is used as the force term.

  • spherical:

    The base state density update now includes the area factors in the divergences:

    (52)ρ0,jout=ρ0,jin1rj2ΔtΔr[(r2ρ0out,n+12w0in)j+12(r2ρ0out,n+12w0in)j12].

    In order to compute the time-centered edge states, an additional geometric term is added to the forcing, due to the spherical discretization of Eq.23:

    (53)ρ0t+w0ρ0r=ρ0w0r2ρ0w0r.

Enforce HSE

[p0in,ρ0in][p0out] has replaced Advect Base Pressure from Paper III as the process by which we update the base state pressure. Rather than discretizing the evolution equation for p0, we enforce hydrostatic equilibrium directly, which is numerically simpler and analytically equivalent. We first set p0,j=0out=p0,j=0in and then update p0out using:

(54)p0,j+1out=p0,jout+Δrgj+12(ρ0,j+1in+ρ0,jin)2,

where g=g(ρ0in). As soon as ρ0,jin<ρcutoff, we set p0,j+1out=p0,jout for all remaining values of j. Then we compare p0,jmaxout with p0,jmaxin and offset every element in p0out so that p0,jmaxout=p0,jmaxin. We are effectively using the location where the ρ0in drops below ρcutoff as the starting point for integration.

Advect Base Enthalpy

[(ρh)0in,w0in,ψin][(ρh)0out] is the process by which we update the base state enthalpy through Δt in time.

  • planar:

    We discretize Eq.28, neglecting reaction source terms, to compute the new base state enthalpy,

    (55)(ρh)0,jout=(ρh)0,jinΔtΔr{[(ρh)0n+12w0in]j+12[(ρh)0n+12w0in]j12}+Δtψjin.

    We compute the time-centered edge states, (ρh)0n+12, by discretizing an expanded form of Eq.28:

    (56)(ρh)0t+w0(ρh)0r=(ρh)0w0r+ψ.
  • spherical:

    The base state enthalpy update now includes the area factors in the divergences:

    (57)(ρh)0,jout=(ρh)0,jin1rj2ΔtΔr{[r2(ρh)0n+12w0in]j+12[r2(ρh)0n+12w0in]j12}+Δtψin,n+12.

    In order to compute the time-centered edge states, an additional geometric term is added to the forcing, due to the spherical discretization of Eq.28:

    (58)(ρh)0t+w0(ρh)0r=(ρh)0w0r2(ρh)0w0r+ψ.

Computing w0

Here we describe the process by which we compute w0. The arguments are different for planar and spherical geometries.

  • planar:

    [Sin,Γ1in,p0in,ψin][w0out]:

    In Paper III, we showed that ψ=ηρg for planar geometries, and derived derived Eq.34 as an alternate expression for eq:eq:w0 divergence. We discretize this as:

    (59)w0,j+12outw0,j12outΔr=(Sin1Γ1inp0inψin)j,

    with w0,12=0.

  • spherical:

    [Sin,Γ1in,ρ0in,p0in,ηρin][w0out]:

    We begin with Eq.43 written in spherical coordinates:

    (60)1r2r(r2β0w0)=β0(S1Γ1p0p0t).

    We expand the spatial derivative and recall from Paper I that

    (61)1Γ1p0p0r=1β0β0r,

    giving:

    (62)1r2r(r2w0)=S1Γ1p0(p0t+w0p0r)ψ.

    We solve this equation for w0 as described in Appendix B of the multilevel paper.

Volume Discrepancy Changes

Chapter [ch:volume] describes the reasoning behind the volume discrepancy term—a forcing term added to the constraint equation to bring us back to the equation of state. This addition of this term (enabled with dpdt_factor= T) modifies our equation set in the following way:

  • In Step 2B, to compute w0, we need to account for the volume discrepancy term by first defining pEOSn=p(ρ,h,Xk)n, and then using:

    (63)w0n+12,r=Sn+12,1Γ1np0nψn12fΓ1np0n(p0npEOSnΔt)δχw0.
  • In Step 3, the MAC projection should account for the volume discrepancy term:

    (64)(β0nU~ADV,)=β0n[(Sn+12,Sn+12,)+fΓ1np0n(pEOSnpEOSnΔtn)δχ].
  • In Step 6B, to compute w0, we need to account for the volume discrepancy term by first defining pEOSn+1,=p(ρ,h,Xk)n+1,, Γ1n+12,=(Γ1n+Γ1n+1,)/2, and pn+12,=(pn+pn+1,)/2, and then using:

    (65)w0n+12r=Sn+12,1Γ1n+12,p0n+12,ψn+12,fΓ1n+1,p0n+1,(p0n+1,pEOSn+1,Δt)δχw0
  • In Step 7, the MAC projection should account for the volume discrepancy term:

    (66)(β0n+12,U~ADV)=β0n+12,[(Sn+12,Sn+12,)+fΓ1n+1,p0n+1,(pEOSn+1,pEOSn+1,Δtn)+δχ],

    where p(ρ,h,Xk)n+12,=[p(ρ,h,Xk)n+p(ρ,h,Xk)n+1,]/2.

  • In Step 11, the approximate projection should account for the volume discrepancy term:

    (67)(β0n+12U~n+1)=β0n+12{(Sn+1Sn+1)+fΓ1n+1p0n+1[p(ρ,h,Xk)n+1p(ρ,h,Xk)n+1Δtn]}.

Γ1 Variation Changes

The constraint we derive from requiring the pressure to be close to the background hydrostatic pressure takes the form:

(68)U+1Γ1p0Dp0Dt=S.

The default MAESTROeX algorithm replaces Γ1 with Γ1, allowing us to write this as a divergence constraint. In paper III, we explored the effects of localized variations in Γ1 by writing Γ1=Γ1+δΓ1. This gives us:

(69)U+1(Γ1+δΓ1)p0Up0=S1(Γ1+δΓ1)p0p0t.

Assuming that δΓ1Γ1, we then have

(70)U+1Γ1p0Up0[1δΓ1Γ1+(δΓ1)2Γ12]=S1Γ1p0p0t[1δΓ1Γ1+(δΓ1)2Γ12]

Grouping by order of the correction, we have

(71)U+1Γ1p0Up0=S1Γ1p0p0t+δΓ1Γ12p0[p0t+Up0]first order corrections(δΓ1)2Γ13p0[p0t+Up0]second order corrections

Keeping to First Order in δΓ1

The base state evolution equation is the average of Eq.71 over a layer

(72)w0er+1Γ1p0w0erp0=S1Γ1p0p0t+(δΓ1Γ12p0U~p0).

where we see that the [δΓ1/(Γ12p0)]p0/t terms averages to zero, since the average of δΓ1 term is zero. Subtracting this from Eq.71, we have

(73)U~+1Γ1p0U~p0=SS+δΓ1Γ12p0(ψ+U~p0)(δΓ1Γ12p0U~p0).

These can be written more compactly as:

(74)w0r=S1Γ1p0ψ+(δΓ1Γ12p0U~p0),

for plane-parallel geometries (analogous to Eq.34, and

(75)(β0U~)=β0[SS+δΓ1Γ12p0ψ+δΓ1Γ12p0U~p0(δΓ1Γ12p0U~p0) ]

This constraint is not in a form that can be projected. To solve this form, we need to use a lagged U~ in the righthand side.

This change comes into MAESTROeX in a variety of steps, summarized here. To enable this portion of the algorithm, set use_delta_gamma1_term = T.

  • In Step 3, we are doing the “predictor” portion of the MAESTROeX algorithm, getting the MAC velocity that satisfies the constraint, so we do not try to incorporate the δΓ1 effect. We set all the δΓ1 terms in Eq.75 to zero.

  • In Step 6, we are computing the new time-centered source, Sn+12, and the base state velocity, w0n+12. Now we can incorporate the δΓ1 effect. First we construct:

    (76)δΓ1Γ12p0U~p0Γ1n+1,Γ1n+1,Γ1n+1,21p0nU~np0n

    Then we call average to construct the lateral average of this

    (77)δΓ1Γ12p0U~p0=Avg(Γ1n+1,Γ1n+1,Γ1n+1,21p0nU~np0n)

    Since the average of this is needed in advancing w0, we modify S to include this average:

    (78)Sn+12,Sn+12,+δΓ1Γ12p0U~p0
  • In Step 7, we now include the δΓ1 term in the righthand side for the constraint by solving:

    (79)(β0n+12,U~ADV)=β0n+12,(Sn+12,Sn+12,+Γ1n+1,Γ1n+1,Γ1n+1,21p0n(ψn+12,+U~np0n))

    We note that this includes the average of the correction term as shown in Eq.75 because we modified S¯ to include this already.

  • In Step 10, we do a construction much like that done in Step 6, but with the time-centerings of some of the quantities changed. First we construct:

    (80)δΓ1Γ12p0U~p0Γ1n+1Γ1n+1Γ1n+121p0n+1U~np0n+1

    Then we call average to construct the lateral average of this

    (81)δΓ1Γ12p0U~p0=Avg(Γ1n+1Γ1n+1Γ1n+121p0n+1U~np0n+1)

    Again we modify S to include this average:

    (82)Sn+1Sn+1+δΓ1Γ12p0U~p0
  • In Step 11, we modify the source of the constraint to include the δΓ1 information. In particular, we solve:

    (83)(β0n+12U~n+1)=β0n+12(Sn+1Sn+1+Γ1n+1Γ1n+1Γ1n+121p0n+1(ψn+12+U~np0n+1))

Thermal Diffusion Changes

Thermal diffusion was introduced in the XRB [MaloneNonakaAlmgren+11]. This introduces a new term to S as well as the enthalpy equation. Treating the enthalpy equation now requires a parabolic solve. We describe that process here.

Immediately after Step 4H, diffuse the enthalpy through a time interval of Δt. First, define (ρh)(1a),=(ρh)(2),. We recompute (ρh)(2), to account for thermal diffusion. Here we begin with the enthalpy equation, but consider only the diffusion terms,

(84)(ρh)t=kthT.

We can recast this as an enthalpy-diffusion equation by applying the chain-rule to h(p0,T,Xk),

(85)h=hpp0+cpT+kξkXk,

giving

(86)(ρh)t=kthcphkξkkthcpXkhpkthcpp0.

Compute kth(1),cp(1), and ξk(1) from ρ(1),T(1), and Xk(1) as inputs to the equation of state. The update is given by

(87)(ρh)(2),=(ρh)(1a),+Δt2(kth(1)cp(1)h(2),+kth(1)cp(1)h(1))Δt2k(ξk(1)kth(1)cp(1)Xk(2),+ξk(1)kth(1)cp(1)Xk(1))Δt2(hp(1)kth(1)cp(1)p0n+1,+hp(1)kth(1)cp(1)p0n),

which is numerically implemented as a diffusion equation for h(2),,

(88)(ρ(2),Δt2kth(1)cp(1))h(2),=(ρh)(1a),+Δt2kth(1)cp(1)h(1)Δt2k(ξk(1)kth(1)cp(1)Xk(2),+ξk(1)kth(1)cp(1)Xk(1))Δt2(hp(1)kth(1)cp(1)p0n+1,+hp(1)kth(1)cp(1)p0n),

Immediately after Step 8H, diffuse the enthalpy through a time interval of Δt. First, define (ρh)(1a)=(ρh)(2). We recompute (ρh)(2) to account for thermal diffusion. Compute kth(2),,cp(2),, and ξk(2),, from ρ(2),,T(2),, and Xk(2), as inputs to the equation of state. The update is given by

(89)(ρh)(2)=(ρh)(1a)+Δt2(kth(2),cp(2),h(2)+kth(1)cp(1)h(1))Δt2k(ξk(2),kth(2),cp(2),Xk(2)+ξk(1)kth(1)cp(1)Xk(1))Δt2(hp(2),kth(2),cp(2),p0n+1+hp(1)kth(1)cp(1)p0n),

which is numerically implemented as a diffusion equation for h(2).

(90)(ρ(2)Δt2kth(2),cp(2),)h(2)=(ρh)(1a)+Δt2kth(1)cp(1)h(1)Δt2k(ξk(2),kth(2),cp(2),Xk(2)+ξk(1)kth(1)cp(1)Xk(1))Δt2(hp(2),kth(2),cp(2),p0n+1+hp(1)kth(1)cp(1)p0n),

Initialization

We start each calculation with user-specified initial values for ρ, Xk and T, as well as an initial background state. In order for the low Mach number assumption to hold, the initial data must be thermodynamically consistent with the initial background state. In addition, the initial velocity field must satisfy an initial approximation to the divergence constraint. We use an iterative procedure to compute both an initial right-hand-side for the constraint equation and an initial velocity field that satisfies the constraint. The user specifies the number of iterations, NitersS, in this first step of the initialization procedure.

The initial perturbational pressure also needs to be determined for use in Steps 3, 7, and 11. This is done through a second iterative procedure which follows the time advancement algorithm as described in Steps 1-11 in §2. The user specifies the number of iterations, Nitersπ, in this second step of the initialization procedure. The details for both iterations are given below.

First, we need to construct approximations to S0,w012,Δt0, and U0. Start with initial data Xkinit,ρinit, Tinit, an initial base state, and an initial guess for the velocity, Uinit. Set w00=0 as an initial approximation. Use the equation of state to determine (ρh)init. Compute β00 as a function of the initial data. The next part of the initialization process proceeds as follows.

  1. Initial Projection: if do_initial_projection = T, then we first project the velocity field with ρ=1 and β00. The initial projection does not see reactions or external heating, and thus we set ω˙=Hnuc=Hext=0 in S. The reason for ignoring reactions and heating is that we need some kind of time scale over which to compute the effect of reactions, but we first need an estimate of the velocity field in order to derive the time step that will be used as a time scale. The elliptic equation we solve is

    (91)β00ϕ=β00(SS)0 except for diffusion(β00Uinit)

    This ϕ is then used to correct the velocity field to obtain U0,0. If do_initial_projection = F, set U0,0=Uinit.

  2. “Divu” iterations: Next we do init_divu_iter iterations to project the velocity field using a constraint that sees reactions and external heating. The initial timestep estimate is provided by firstdt and U0,0, to allow us to compute the effect of reactions over Δt/2.

    Do ν=1,...,NitersS.

    1. Estimate Δtν using U0,ν1 and w0ν1.

    2. React State[ρinit,(ρh)init,Xkinit,Tinit,(ρinitHext),p0init][ρout,(ρh)out,Xkout,Tout,(ρω˙k)0,ν].

    3. Compute S0,ν using (ρω˙k)0,ν and the initial data.

    4. Compute S0,ν=Avg(S0,ν).

    5. Compute w0ν as in Step 2B using S0,ν and ψ=0.

    6. Project U0,ν1 using β00 and (S0,νS0,ν) as the source term. This yields U0,ν. In this projection, again the density is set to 1, and the elliptic equation we solve is:

      (92)β00ϕ=β0(SS)(β00U0,ν1)

    End do.

    Define S0=S0,NitersS, w012=w0NitersS, Δt0=ΔtNitersS, and U0=U0,NitersS.

Next, we need to construct approximations to ηρ12,ψ12,S1, and π12. As initial approximations, set ηρ12=0,ψ12=0,S1,0=S0, and π12=0.

  1. Pressure iterations: Here we do init_iter iterations to get an approximation for the lagged pressure:

    Do ν=1,...,Nitersπ.

    1. Perform Steps 1-11 as described above, using S12,=(S0+S1,ν1)/2 in Step 2 as described. The only other difference in the time advancement is that in Step 11 we define V=(U~1,U~0) and solve

      (93)Lβρϕ=D(β012V)β012[(S1S1)(S0S0)].

      (The motivation for this form of the projection in the initial pressure iterations is discussed in [ABC00].) We discard the new velocity resulting from this, but keep the new value for π12=π12+(1/Δt)ϕ. These steps also yield new scalar data at time Δt, which we discard, and new values for ηρ12 (Step 8C), ψ12 (Step 8F), S1,ν (Step 10A), and π12 (Step 11), which we keep.

    2. Set π12=π12, ηρ12=ηρ12, and ψ12=ψ12.

    End do.

    Finally, we define S1=S1,Nitersπ.

The tolerances for these elliptic solves are described in § Multigrid.

Changes from Earlier Implementations

Changes Between Paper 3 and Paper 4

  1. We defined the mapping of data between a 1D radial array and the 3D Cartesian grid for spherical problems (which we improve upon in the multilevel paper).

  2. We update T after the call to React State.

  3. We have created a burning_cutoff_density, where the burning does not happen below this density. It is presently set to base_cutoff_density.

  4. Use corner coupling in advection.

  5. We have an option, controlled by use_tfromp, to update temperature using T=T(ρ,Xk,p0) rather than T=T(ρ,h,Xk). The former completely decouples enthalpy from our system. For spherical problems, we use use_tfromp = TRUE, for planar problems, we use use_tfromp = FALSE.

  6. For spherical problems, we have changed the discretization of U~p0 in the enthalpy update to (U~p0)p0U~.

  7. In paper III we discretized the enthalpy evolution equation in terms of T. Since then we have discovered that discretizing the enthalpy evolution in perturbational form, (ρh), leads to better numerical properties. We use enthalpy_pred_type= 1. This is more like paper II.

  8. We have turned off the evolution of h above the atmosphere and instead compute h with the EOS using do_eos_h_above_cutoff = T.

Changes Between Paper 4 and the Multilevel Paper

See the multilevel paper for the latest.

Changes Between the Multilevel Paper and Paper 5

  1. Added rotation.

Changes Between Paper 5 and the XRB Paper

  1. We have added thermal diffusion, controlled by use_thermal_diffusion, temp_diffusion_formulation, and thermal_diffusion_type.

  2. We added the volume discrepancy term to the velocity constraint equation, controlled by the input parameter, dpdt_factor.

  3. For certain problems, we need to set do_eos_h_above_cutoff = F to prevent large, unphysical velocities from appearing near the edge of the star.

Changes Since the XRB Paper

  1. We switched to the new form of the momentum equation to Eq.39 to conserve the low-Mach number form of energy.

  2. We changed the form of the volume discrepancy term to get better agreement between the two temperatures.

Future Considerations

  • We are still exploring the effects of use_tfromp = F for spherical problems. We would eventually like to run in this mode, but T=T(ρ,Xk,p0) and T=T(ρ,h,Xk) drift away from each other more than we would like. Our attempts at incorporating a dpdt_factor for spherical problems have not been successful.

Numerical Methodology

We give an overview of the original MAESTRO algorithm [NonakaAlmgrenBell+10], as well as the recently introduced new temporal integration scheme [FanNonakaAlmgren+19]. These schemes share many of the same algorithmic modules, however the new scheme is significantly simpler.

To summarize, in the original scheme we integrated the base state evolution over the time step, which requires splitting the velocity equation into more complicated average and perturbational equations. In the new temporal integrator, we eliminated much of this complication by introducing a predictor-corrector approach for the base state. The key observation is that the base state density is simply the lateral average of the full density, so we simply update the base state density through averaging routines, rather than predicting the evolution with a split velocity formulation, only to have to correct it with the averaging operator in the end regardless.

Original Temporal Integrator

New Temporal Integrator