Binder

Example: Planetary Gaps

In this example we demonstrate how to add gaps carved by planets into the gas.
There are in principal three ways to achieve this: setting the gas surface density to the desired gap profile and not evolving it, adding torques to the gas evolution, or changing the viscosity.
In this example we focus on adding a torque profile.

The torque profile that is needed to impose a gap on the gas is given by Lau (2024):

Λ=32νΩK(12flogflogr12),

where f is the pertubation in the gas surface density

f=Σg(r)Σ0.

Gap Profiles

Since we are not self-consistently creating gaps, we have to impose a known gap profile. In this demonstration we are using the numerical fits to hydrodynamical simulations found by Kanagawa et al. (2017):

Σg(r)={Σminfor|rap|<Δr1,Σgap(r)forΔr1<|rap|<Δr2,Σ0for|rap|>Δr2,

where ap is the semi-major axis of the planet and Σ0 is the unperturbed surface density, and

Σgap(r)Σ0=4K4 |rap|ap  0.32

Σmin=Σ01 + 0.04 K

Δr1=(Σmin4Σ0+0.08) K4 ap

Δr2=0.33 K4 ap

K=(MpM)2(Hpap)5α1

K=(MpM)2(Hpap)3α1

Mp and M are the masses of the planet and the star, Hp the pressure scale height at the planet location, and α the viscosity parameter.

We therefore need to write a function that calculates the pertubation f=Σg(r)/Σ0.

[1]:
import numpy as np

def Kanagawa2017_gap_profile(r, a, q, h, alpha):
    """Function calculates the gap profile according Kanagawa et al. (2017).

    Parameters
    ----------
    r : array
        Radial grid
    a : float
        Semi-majo axis of planet
    q : float
        Planet-star mass ratio
    h : float
        Aspect ratio at planet location
    alpha : float
        alpha viscosity parameter

    Returns
    -------
    f : array
        Pertubation of surface density due to planet"""

    # Unperturbed return value
    ret = np.ones_like(r)

    # Distance to planet (normalized)
    dist = np.abs(r-a)/a

    K = q**2 / (h**5 * alpha) # K
    Kp = q**2 / (h**3 * alpha) # K prime
    Kp4 = Kp**(0.25) # Fourth root of K prime
    SigMin = 1. / (1 + 0.04*K) # Sigma minimum
    SigGap = 4 / Kp4 * dist - 0.32 # Sigma gap
    dr1 = (0.25*SigMin + 0.08) * Kp**0.25 # Delta r1
    dr2 = 0.33 * Kp**0.25 # Delta r2

    # Gap edges
    mask1 = np.logical_and(dr1<dist, dist<dr2)
    ret = np.where(mask1, SigGap, ret)
    # Gap center
    mask2 = dist < dr1
    ret = np.where(mask2, SigMin, ret)

    return ret

A planet of 30 Earth masses at 10 AU and the following parameters would induce the following pertubation onto the gas surface density.

[2]:
import dustpy.constants as c

rp = 10. * c.au
h = 0.05
q = 30. * c.M_earth / c.M_sun
alpha = 1.e-3
[3]:
r = np.geomspace(1.e0, 1.e3, 1000) * c.au
[4]:
import matplotlib.pyplot as plt
plt.rcParams["figure.dpi"] = 150.
[5]:
fig, ax = plt.subplots()
ax.semilogx(r/c.au, Kanagawa2017_gap_profile(r, rp, q, h, alpha))
ax.axvline(rp/c.au, ls="--", c="C7", lw=1)
ax.set_xlim(1., 1000.)
ax.set_xlabel("Distance from star [AU]")
ax.set_ylabel(r"$f = \Sigma_\mathrm{g} \left( r \right)\ /\ \Sigma_0$")
fig.set_layout_engine("tight")
_images/example_planetary_gaps_8_0.png

Adding planets

For this example we want to add two planets: Jupiter and Saturn. We therefore add new groups and subgroups to organize them.

In addition to that we want to refine the grid close to the planet locations. For this we use the function similar to the one discussed in an earlier chapter.

[6]:
def refinegrid(ri, r0, num=3):
    ind = np.argmin(r0 > ri) - 1
    indl = ind-num
    indr = ind+num+1
    ril = ri[:indl]
    rir = ri[indr:]
    N = (2*num+1)*2
    rim = np.empty(N)
    for i in range(0, N, 2):
        j = ind-num+int(i/2)
        rim[i] = ri[j]
        rim[i+1] = 0.5*(ri[j]+ri[j+1])
    return np.concatenate((ril, rim, rir))
[7]:
from dustpy import Simulation
[8]:
sim = Simulation()
[9]:
ri = np.geomspace(1.e0, 1.e3, 100) * c.au
ri = refinegrid(ri, 5.2*c.au)
ri = refinegrid(ri, 9.6*c.au)
sim.grid.ri = ri
[10]:
sim.initialize()
[11]:
sim.addgroup("planets")
sim.planets.addgroup("jupiter")
sim.planets.addgroup("saturn")
[12]:
sim.planets.jupiter.addfield("a", 5.2*c.au, description="Semi-major axis [cm]")
sim.planets.jupiter.addfield("M", 1.*c.M_jup, description="Mass [g]")
[13]:
sim.planets.saturn.addfield("a", 9.6*c.au, description="Semi-major axis [cm]")
sim.planets.saturn.addfield("M", 95*c.M_earth, description="Mass [g]")

The planets are now set up.

[14]:
sim.planets.toc
Group
    - jupiter: Group
        - a: Field (Semi-major axis [cm])
        - M: Field (Mass [g])
    - saturn: Group
        - a: Field (Semi-major axis [cm])
        - M: Field (Mass [g])

Adding torque profile

We now have to write a funtion that returns the Λ torque profile that imposes the desired gap profile onto the gas surface density from those two planets.

[15]:
from scipy.interpolate import interp1d

def Lambda_torque(sim, return_profile=False):
    f = np.ones(sim.grid.Nr)
    fi = np.ones(sim.grid.Nr+1)
    for name, planet in sim.planets:
        q = planet.M/sim.star.M
        _h = interp1d(sim.grid.r, sim.gas.Hp/sim.grid.r)
        h = _h(planet.a)
        _alpha = interp1d(sim.grid.r, sim.gas.alpha)
        alpha = _alpha(planet.a)
        f *= Kanagawa2017_gap_profile(sim.grid.r, planet.a, q, h, alpha)
        fi *= Kanagawa2017_gap_profile(sim.grid.ri, planet.a, q, h, alpha)
    grad = np.diff(np.log10(fi)) / np.diff(np.log10(sim.grid.ri))
    Lambda = -1.5 * sim.grid.OmegaK * sim.gas.nu * (1./(2.*f) - grad - 0.5)
    if return_profile:
        return Lambda, f
    return Lambda

This function now produces the α viscosity profile that creates planetary gaps in the gas surface density.

[16]:
fig, ax = plt.subplots()
_, f = Lambda_torque(sim, return_profile=True)
ax.loglog(sim.grid.r/c.au, f)
ax.set_xlim(sim.grid.r[0]/c.au, sim.grid.r[-1]/c.au)
ax.set_ylim(1.e-3, 2.)
ax.vlines(sim.grid.r/c.au, 1.e-3, 2., lw=0.5, color="C7")
ax.set_xlabel("Distance from star [AU]")
ax.set_ylabel(r"$f$ profile")
fig.set_layout_engine("tight")
_images/example_planetary_gaps_23_0.png

We could now assign this profile to the Λ torque parameter.

[17]:
sim.gas.torque.Lambda[:] = Lambda_torque(sim)

Growing planets

Right now we could already start the simulation. But in this demonstration we want to let the planets grow linearly to their final mass. we therefore write a function that returns the planetary mass as a function of time.

[18]:
def Mplan(t, tini, tfin, Mini, Mfin):
    """Function returns the planetary mass.

    Parameters
    ----------
    t : float
        Current time
    tini : float
        Time of start of growth phase
    tfin : float
        Time of end of growth phase
    Mini : float
        Initial planetary mass
    Mfin : float
        Final planetary mass"""
    if t<=tini:
        return Mini
    elif t>=tfin:
        return Mfin
    else:
        return (Mfin-Mini)/(tfin-tini)*(t-tini) + Mini

We want to start with planet masses of 1 Earth mass and they should reach their final masses after 100000 years. We have to write functions for each planet that returns their mass as a function of time.

[19]:
def Mjup(sim):
    return Mplan(sim.t, 0., 1.e5*c.year, 1.*c.M_earth, 1.*c.M_jup)

def Msat(sim):
    return Mplan(sim.t, 0., 1.e5*c.year, 1.*c.M_earth, 95.*c.M_earth)

These functions have to be assigned to the updaters of their respective fields.

[20]:
sim.planets.jupiter.M.updater.updater = Mjup
sim.planets.saturn.M.updater.updater = Msat

We also have to oragnize the update structure of the planets.

[21]:
sim.planets.jupiter.updater = ["M"]
sim.planets.saturn.updater = ["M"]
sim.planets.updater = ["jupiter", "saturn"]

And we have to tell the main simulation frame to update the planets group. This has to be done before the gas quantities, since Simulation.gas.alpha needs to know the planetary masses. So we simply update it in the beginning.

[22]:
sim.updater = ["planets", "star", "grid", "gas", "dust"]

Since the Λ torque profile is not constant now, we have assign our Λ function to its updater.

[23]:
sim.gas.torque.Lambda.updater.updater = Lambda_torque

To bring the simulation frame into consistency we have to update it.

[24]:
sim.update()

The planetary masses are now set to their initial values.

[25]:
msg = "Masses\nJupiter: {:4.2f} M_earth\nSaturn:  {:4.2f} M_earth".format(sim.planets.jupiter.M/c.M_earth, sim.planets.saturn.M/c.M_earth)
print(msg)
Masses
Jupiter: 1.00 M_earth
Saturn:  1.00 M_earth

We can now start the simulation.

[26]:
sim.writer.datadir = "example_planetary_gaps"
[27]:
sim.run()
DustPy v1.0.8

Documentation: https://stammler.github.io/dustpy/
PyPI:          https://pypi.org/project/dustpy/
GitHub:        https://github.com/stammler/dustpy/

Please cite Stammler & Birnstiel (2022).

Checking for mass conservation...

    - Sticking:
        max. rel. error:  2.81e-14
        for particle collision
            m[114] =  1.93e+04 g    with
            m[116] =  3.73e+04 g
    - Full fragmentation:
        max. rel. error:  6.66e-16
        for particle collision
            m[90] =  7.20e+00 g    with
            m[95] =  3.73e+01 g
    - Erosion:
        max. rel. error:  1.78e-15
        for particle collision
            m[110] =  5.18e+03 g    with
            m[118] =  7.20e+04 g

Creating data directory example_planetary_gaps.
Writing file example_planetary_gaps/data0000.hdf5
Writing dump file example_planetary_gaps/frame.dmp
Writing file example_planetary_gaps/data0001.hdf5
Writing dump file example_planetary_gaps/frame.dmp
Writing file example_planetary_gaps/data0002.hdf5
Writing dump file example_planetary_gaps/frame.dmp
Writing file example_planetary_gaps/data0003.hdf5
Writing dump file example_planetary_gaps/frame.dmp
Writing file example_planetary_gaps/data0004.hdf5
Writing dump file example_planetary_gaps/frame.dmp
Writing file example_planetary_gaps/data0005.hdf5
Writing dump file example_planetary_gaps/frame.dmp
Writing file example_planetary_gaps/data0006.hdf5
Writing dump file example_planetary_gaps/frame.dmp
Writing file example_planetary_gaps/data0007.hdf5
Writing dump file example_planetary_gaps/frame.dmp
Writing file example_planetary_gaps/data0008.hdf5
Writing dump file example_planetary_gaps/frame.dmp
Writing file example_planetary_gaps/data0009.hdf5
Writing dump file example_planetary_gaps/frame.dmp
Writing file example_planetary_gaps/data0010.hdf5
Writing dump file example_planetary_gaps/frame.dmp
Writing file example_planetary_gaps/data0011.hdf5
Writing dump file example_planetary_gaps/frame.dmp
Writing file example_planetary_gaps/data0012.hdf5
Writing dump file example_planetary_gaps/frame.dmp
Writing file example_planetary_gaps/data0013.hdf5
Writing dump file example_planetary_gaps/frame.dmp
Writing file example_planetary_gaps/data0014.hdf5
Writing dump file example_planetary_gaps/frame.dmp
Writing file example_planetary_gaps/data0015.hdf5
Writing dump file example_planetary_gaps/frame.dmp
Writing file example_planetary_gaps/data0016.hdf5
Writing dump file example_planetary_gaps/frame.dmp
Writing file example_planetary_gaps/data0017.hdf5
Writing dump file example_planetary_gaps/frame.dmp
Writing file example_planetary_gaps/data0018.hdf5
Writing dump file example_planetary_gaps/frame.dmp
Writing file example_planetary_gaps/data0019.hdf5
Writing dump file example_planetary_gaps/frame.dmp
Writing file example_planetary_gaps/data0020.hdf5
Writing dump file example_planetary_gaps/frame.dmp
Writing file example_planetary_gaps/data0021.hdf5
Writing dump file example_planetary_gaps/frame.dmp
Execution time: 0:15:08

This is the result of our simulation.

[28]:
from dustpy import plot
[29]:
plot.panel(sim)
_images/example_planetary_gaps_47_0.png

As can be seen, the core of Jupiter and Saturn carved gaps in the gas disk, which in turn affected the dust evolution.

To see that the planetary masses actually changed we can plot them over time.

[30]:
t = sim.writer.read.sequence("t")
Mjup = sim.writer.read.sequence("planets.jupiter.M")
Msat = sim.writer.read.sequence("planets.saturn.M")
[31]:
fig, ax = plt.subplots()
ax.plot(t/c.year, Mjup/c.M_earth, label="Jupiter")
ax.plot(t/c.year, Msat/c.M_earth, label="Saturn")
ax.legend()
ax.set_xlim(t[0]/c.year, t[-1]/c.year)
ax.grid(visible=True)
ax.set_xlabel(r"Time [years]")
ax.set_ylabel(r"Mass [$M_\oplus$]")
fig.set_layout_engine("tight")
_images/example_planetary_gaps_50_0.png