Example of Integrating a Networkļƒ

Creating a Networkļƒ

We will start by looking at the CNO network for simplicity. We will first need to import pynucastro, read through the ReacLib library, and pass in the names of the reaction rates we are interested in.

[1]:
import pynucastro as pyna
rl = pyna.ReacLibLibrary()
rate_names = ["c12(p,g)n13",
              "c13(p,g)n14",
              "n13(,)c13",
              "n13(p,g)o14",
              "n15(p,a)c12",
              "o14(,)n14",
              "o15(,)n15"]

rates = rl.get_rate_by_name(rate_names)
rates
[1]:
[C12 + p āŸ¶ N13 + š›¾,
 C13 + p āŸ¶ N14 + š›¾,
 N13 āŸ¶ C13 + eāŗ + šœˆ,
 N13 + p āŸ¶ O14 + š›¾,
 N15 + p āŸ¶ He4 + C12,
 O14 āŸ¶ N14 + eāŗ + šœˆ,
 O15 āŸ¶ N15 + eāŗ + šœˆ]

PythonNetwork has methods to write the RHS of the system of ODEs.

[2]:
pynet = pyna.PythonNetwork(rates=rates)

The write_network() method outputs the Python code that is used to define the RHS for integration to a file you choose.

[3]:
pynet.write_network("cno_test_integrate.py")

Integrating a Networkļƒ

There are a wide variety of ODE integration solvers within the Julia DifferentialEquation package. They can be located at the DifferentialEquation.jl docs along with other useful information about the package.

[4]:
import numba
import numpy as np
from diffeqpy import de
import cno_test_integrate as cno #importing network created

After importing all the necessary libraries and modules, we can intialize the thermodynamic conditions, intial compositions, the time span, and the algorithm or method we will be using to solve with.

[5]:
rho = 150. #g/cm^3
T = 1.5e7  #K
screen_func = None

Y0 = np.zeros((cno.nnuc), dtype=np.float64) #Intialize array of mass fractions

Y0[cno.jp] = 0.7 #Solar mix of mass fractions
Y0[cno.jhe4] = 0.28
Y0[cno.jc12] = 0.02

Y0[:] = Y0[:]/cno.A[:] #Converting to molar fractions

tspan = (0.0, 1.e20)
p = np.array([rho, T]) #Array of initial parameters
alg = de.FBDF() #Choosing integration method

We can then write the functions to return the jacobian and the RHS of the Differential Equations. Numba can be used to do just-in-time compilation of the functions to speed up the code.

[6]:
def f(u, p, t): #u = array of unknowns, p = array of parameters, t = array of time
   rho, T = p
   Y = u
   return cno.rhs_eq(t, Y, rho, T, None) #calling RHS

def f_jac(u, p, t):
   rho, T = p
   Y = u
   return cno.jacobian_eq(t, Y, rho, T, None) #Calling Jacobian

numba_f = numba.njit(f) #Using Numba on functions
numba_jac = numba.njit(f_jac)

ff = de.ODEFunction(numba_f, jac=numba_jac)

We combine the function f(u, p, t) and f_jac(u, p, t) into a single variable ff. The reason for this is because the first parameter in de.ODEProblem() must be a single variable calling the functions.

[7]:
prob = de.ODEProblem(ff, Y0, tspan, p)
sol = de.solve(prob, alg, abstol=1.e-9, reltol=1.e-9)

For more information on ODE Problems visit DifferentialEquation.jl docs

Printing and Plottingļƒ

It is useful to be able to print and plot certain things to gain a better understanding of what is going on with the solver method and the reactions. Below are useful print statements to help you understand what is going on behind the scenes.

[8]:
print(sol.retcode) #Tells you if it successfully solved
<PyCall.jlwrap Success>
[9]:
print(sol.stats) #Gives statistics on what the solver did
<PyCall.jlwrap DiffEqBase.Stats
Number of function 1 evaluations:                  420
Number of function 2 evaluations:                  0
Number of W matrix evaluations:                    140
Number of linear solves:                           277
Number of Jacobians created:                       0
Number of nonlinear solver iterations:             277
Number of nonlinear solver convergence failures:   0
Number of rootfind condition calls:                0
Number of accepted steps:                          137
Number of rejected steps:                          3>
[10]:
print("Final Y =", sol.u[-1]) #prints out final molar fractions
Final Y = [6.96666665e-01 6.99999984e-02 5.05923348e-34 2.21203706e-34
 1.63697507e-44 1.66666668e-03 0.00000000e+00 4.50258027e-58
 0.00000000e+00]
[11]:
import matplotlib.pyplot as plt
fig = plt.figure()
ax = fig.add_subplot(111)

t_dense = np.geomspace(1e1, tspan[-1], num=1000)
species = sol(t_dense)

for i in range(cno.nnuc):
    ax.loglog(t_dense, species[i], label=f"X({cno.names[i].capitalize()})")

#ax.set_xlim(1.e1, 1.e6)
ax.set_ylim(1.e-15, 1.0)
ax.legend(fontsize="small")
ax.set_xlabel("t (s)")
ax.set_ylabel("X")

fig.set_size_inches((8, 6))
_images/Example-Integrating-Network-diffeqpy_23_0.png
[ ]: