Systems of first-order differential equations¶

  • KEYWORDS: solve_ivp, meshgrid, quiver

Families of solutions to FODEs¶

Consider \(y' = x - y\).

We can interpret this equation as one that defines a direction field. That is, at any given point (x, y) we can compute the derivative of a solution at that point. We will consider how to make a plot that shows this field, and that will help us estimate what solutions to the ODE might look like for different initial values.

To do this, we should compute the derivative on an array of regularly spaced points in both \(x\) and \(y\), and then making a plot of that data.

We need to see a couple of new ideas to make this plot efficiently. What we want is a 2-d plot of a regular grid of (x, y) points, and at each of those points the derivative (dx/dx, dy/dx).

First, we will need to create four arrays:

  1. a 2d array of all the x-positions

  2. a 2d array of all the y-positions

  3. a 2d array of the dx/dx = 1 values

  4. a 2d array of the dy/dx values.

We want to generate the x, y arrays. We use np.meshgrid for this. The simplest way to do it is to use np.linspace to create 1-D arrays with the spacing we want, and then use np.meshgrid to generate the 2D arrays. Let’s say we want a uniform grid over the range of x from 0 to 1, and over the range of y from 0 to 3, with 5 points in each direction.

import numpy as np

x = np.linspace(0, 1, 5)  # 1d arrays
y = np.linspace(0, 3, 5)  # 1d arrays

X, Y = np.meshgrid(x, y)   # 2d arrays
X, Y
(array([[0.  , 0.25, 0.5 , 0.75, 1.  ],
        [0.  , 0.25, 0.5 , 0.75, 1.  ],
        [0.  , 0.25, 0.5 , 0.75, 1.  ],
        [0.  , 0.25, 0.5 , 0.75, 1.  ],
        [0.  , 0.25, 0.5 , 0.75, 1.  ]]),
 array([[0.  , 0.  , 0.  , 0.  , 0.  ],
        [0.75, 0.75, 0.75, 0.75, 0.75],
        [1.5 , 1.5 , 1.5 , 1.5 , 1.5 ],
        [2.25, 2.25, 2.25, 2.25, 2.25],
        [3.  , 3.  , 3.  , 3.  , 3.  ]]))

Now, we have X, Y arrays that map out all the (x, y) pairs we want to consider. So, the (x, y) pair in the second row and third column of the array is:

(X[1, 2], Y[1, 2])
(0.5, 0.75)
X[0, :]
array([0.  , 0.25, 0.5 , 0.75, 1.  ])
X[:, 1]
array([0.25, 0.25, 0.25, 0.25, 0.25])

These are arrays, so we can do math with them.

X - Y
array([[ 0.  ,  0.25,  0.5 ,  0.75,  1.  ],
       [-0.75, -0.5 , -0.25,  0.  ,  0.25],
       [-1.5 , -1.25, -1.  , -0.75, -0.5 ],
       [-2.25, -2.  , -1.75, -1.5 , -1.25],
       [-3.  , -2.75, -2.5 , -2.25, -2.  ]])
np.sqrt(X**2 + Y**2)  # Another example of math
array([[0.        , 0.25      , 0.5       , 0.75      , 1.        ],
       [0.75      , 0.79056942, 0.90138782, 1.06066017, 1.25      ],
       [1.5       , 1.52069063, 1.58113883, 1.67705098, 1.80277564],
       [2.25      , 2.26384628, 2.30488611, 2.37170825, 2.46221445],
       [3.        , 3.01039864, 3.04138127, 3.09232922, 3.16227766]])
X**0
array([[1., 1., 1., 1., 1.],
       [1., 1., 1., 1., 1.],
       [1., 1., 1., 1., 1.],
       [1., 1., 1., 1., 1.],
       [1., 1., 1., 1., 1.]])

Now we are ready to compute a distance field for the FODE. We will consider the range from -1 to 1 in both x and y, and then plot the results with matplotlib.pyplot.quiver.

import matplotlib.pyplot as plt

We define the ode function, create the grids, and then make the plot.

def yprime(x, y):
    return x - y

x = np.linspace(-1, 1, 20)
y = np.linspace(-1, 1, 20)

X, Y = np.meshgrid(x, y)
U = np.ones(X.shape)  # dx/dx
V = yprime(X, Y)  # dy/dx

# This normalizes the arrows so they are all the same length
N = np.sqrt(U**2 + V**2)
U /= N  # equivalent to U = U / N
V /= N

plt.quiver(X, Y, U, V)
plt.xlabel('x')
plt.ylabel('y');
../_images/04-fode-2_15_0.png

If you pick a point, the arrows show you which way the solution goes from there. You just follow the arrows to get an approximate solution to this equation. Let’s consider some specific solutions. Suppose we start with the initial condition that \(y(-1) = 0\). You can trace the arrows to estimate where the solution goes.

Let us use a numerical solver to see how it works.

from scipy.integrate import solve_ivp

sol = solve_ivp(yprime, (-1, 1), (0,), t_eval=np.linspace(-1, 1))
sol.message  # you should at least check this message to see if it worked.
'The solver successfully reached the end of the integration interval.'

Now, we plot the solution

plt.plot(sol.t, sol.y[0], 'r', lw=2)
plt.quiver(X, Y, U, V)
plt.plot(-1, 0, 'ks')
plt.xlabel('x')
plt.ylabel('y')
Text(0, 0.5, 'y')
../_images/04-fode-2_19_1.png

Here are some more examples.

sol2 = solve_ivp(yprime, (-0.5, 1), (0.5,), t_eval=np.linspace(-0.5, 1))
sol3 = solve_ivp(yprime, (0.0, 1), (-1,), t_eval=np.linspace(0.0, 1))
sol4 = solve_ivp(yprime, (0.0, 1), (1,), t_eval=np.linspace(0.0, 1))

plt.plot(sol2.t, sol2.y[0], 'r', lw=2)
plt.plot(sol3.t, sol3.y[0], 'g', lw=2)
plt.plot(sol4.t, sol4.y[0], 'b', lw=2)

# overlay the direction field
plt.quiver(X, Y, U, V)
plt.xlabel('x')
plt.ylabel('y');
../_images/04-fode-2_21_0.png

You can see the solution looks different depending on the initial condition, but in each case the solution follows the direction field.

Direction field plots can be very helpful to visualize what nearby solutions might look like, or to get a qualitative idea of what a solution might look like, or to see if anything unusual happens in the solution space. We will see them again when we consider systems of differential equations.

Exercise: Make a direction field plot for \(y'=-y\) for the range of x from 0 to 4. What does the direction field tell you? How does this compare to what you know from the solution?

x1 = np.linspace(0, 4, 15)
y1 = np.linspace(0, 4, 15)
X1, Y1 = np.meshgrid(x1, y1)
U = X1**0
V = -Y1
N = np.sqrt(U**2 + V**2)
U /= N
V /= N
plt.quiver(X1, Y1, U, V);
../_images/04-fode-2_23_0.png

Systems of first-order differential equations¶

Many engineering systems are governed by systems of coupled differential equations. This usually means there are two or more independent variables and outputs, and the rate of change of the outputs depends on two or more of the independent variables.

Let’s consider the following tank mixing problem. You have two tanks: Tank A has 30 gallons containing 55 ounces of dissolved salt, and Tank B has 20 gallons containing 26 ounces of salt. Additionally,

  • Water with a salt concentration of 1 oz/gal flows into Tank A at a rate of 1.5 gal/min.

  • Water with a salt concentration of 3 oz/gal flows into Tank B at a rate of 1 gal/min

  • Water flows from Tank A to Tank B at a rate of 3 gal/min.

  • Water flows from Tank B to Tank A at a rate of 1.5 gal/min

  • Water drains from Tank B at a rate of 2.5 gal/min.

two-tank-mixing.png

Plot the concentration of salt in Tank A and B as a function of time.

First, we can define initial conditions.

V_A = 30 # gal
V_B = 20 # gal

S_A0 = 55 / V_A # oz/gallon in Tank A at T=0
S_B0 = 26 / V_B # oz/gallon in Tank B at T=0

S_A0, S_B0
(1.8333333333333333, 1.3)

Now, let’s define the flow rates and check the net volumetric flow into each tank.

f_A = 1.5 # volumetric flow into A gal/min
C_A = 1   # salt concentration in flow oz/gal

f_B = 1.0 # volumetric flow into B, gal/min
C_B = 3   # salt concentration into B, oz/gal

f_AB = 3 # flow from A to B, gal/min
f_BA = 1.5 # flow from B to A, gal/min

f_Bexit = 2.5  # flow out of B

print(f'Net flow into A = {f_A - f_AB + f_BA} gal/min')
print(f'Net flow into B = {f_B + f_AB - f_BA - f_Bexit} gal/min')
Net flow into A = 0.0 gal/min
Net flow into B = 0.0 gal/min

You can see the net volumetric flow in each tank is 0, so we do not have to worry about the volumes changing.

We seek solutions for \(S_A(t)\) and \(S_B(t)\) where \(S_x(t)\) represents the concentration (in oz/gal). Since these change with time, we need to solve the mass balances:

\(\frac{dS_A}{dt} = \frac{1}{V_A}(f_A C_A - f_{AB} S_A(t) + f_{BA} S_B(t))\)

and

\(\frac{dS_B}{dt} = \frac{1}{V_B}(f_B C_B + f_{AB} S_A(t) - F_{BA} S_B(t) - F_{Bexit} S_B(t))\)

Before we get into the solution, what should we expect to happen here? The concentration of salt into tank A is less than the initial concentration, and the initial concentration in Tank B is also lower than in Tank A, so we expect the concentration in Tank A to start decreasing. Similarly, we expect the concentration in Tank B to start rising since the concentration in each incoming stream is higher than the initial concentration.

At some point, the two tanks will reach a steady state, but it is not evident how we will approach that steady state. Since the concentration of one stream is higher than all the other concentrations, it is possible for the concentration to go up and then down.

def dSdt(t, S):
    S_A = S[0]
    S_B = S[1]  # split out for readability
    dSadt = (f_A * C_A - f_AB * S_A + f_BA * S_B) / V_A
    dSbdt = (f_B * C_B + f_AB * S_A - f_BA * S_B - f_Bexit * S_B) / V_B
    return np.array([dSadt, dSbdt])

dSdt(0, [1.8, 2.0])
array([-0.03,  0.02])
from scipy.integrate import solve_ivp

S0 = np.array([S_A0, S_B0])  # initial conditions
tspan = np.array([0, 200])

# there is a new syntax here. *tspan means to "unpack" tspan into this position
# it is equivalent to:
# teval = np.linspace(tspan[0], tspan[1], 100)
teval = np.linspace(*tspan, 50)

sol = solve_ivp(dSdt, tspan, S0, t_eval=teval)
sol.message
'The solver successfully reached the end of the integration interval.'

The shape of our solution is two rows by 50 columns.

sol.y.shape
(2, 50)

One way to plot these solutions is this, where we extract out each row of the solution:

import matplotlib.pyplot as plt
plt.plot(sol.t, sol.y[0] * V_A, label='Tank A')
plt.plot(sol.t, sol.y[1] * V_B, label='Tank B')
plt.xlabel('t (min)')
plt.ylabel('Mass of salt (oz)')
plt.legend();
../_images/04-fode-2_35_0.png

Another way is to convert the solution to an array where the data we want to plot is in columns. We can achieve this by transposing the array to convert it from 2 rows with 50 columns to 50 rows with 2 columns.

sol.y.T
array([[1.83333333, 1.3       ],
       [1.64695817, 1.71144196],
       [1.56328585, 1.84203854],
       [1.51939197, 1.87552988],
       [1.49244192, 1.87631636],
       [1.4734642 , 1.86796457],
       [1.45940047, 1.85692514],
       [1.44806492, 1.84752295],
       [1.43920511, 1.83871313],
       [1.43189836, 1.83177174],
       [1.42587515, 1.82630199],
       [1.42125427, 1.820987  ],
       [1.41737466, 1.81698638],
       [1.41353536, 1.81572909],
       [1.41093864, 1.81311318],
       [1.40976045, 1.80818399],
       [1.40845254, 1.80520558],
       [1.40621031, 1.80628913],
       [1.40517716, 1.80478864],
       [1.4044699 , 1.80316002],
       [1.40334083, 1.80348781],
       [1.402842  , 1.80249061],
       [1.40235092, 1.80193034],
       [1.40162308, 1.80245462],
       [1.40145916, 1.80159464],
       [1.4015339 , 1.80026888],
       [1.40085462, 1.80140733],
       [1.4005072 , 1.80171624],
       [1.40096288, 1.79975191],
       [1.40078697, 1.79979238],
       [1.39990787, 1.80203193],
       [1.40028779, 1.80056815],
       [1.40109182, 1.79789203],
       [1.40008248, 1.80070447],
       [1.39983766, 1.8012632 ],
       [1.40084644, 1.79809363],
       [1.40035133, 1.79946213],
       [1.39990725, 1.80069907],
       [1.40050318, 1.79883362],
       [1.40020394, 1.79966799],
       [1.39991442, 1.80048488],
       [1.40031617, 1.79923755],
       [1.40009526, 1.79986591],
       [1.39978364, 1.80077275],
       [1.40019437, 1.79951776],
       [1.40027104, 1.79926913],
       [1.39958516, 1.80131159],
       [1.39985385, 1.80049314],
       [1.40067115, 1.79803115],
       [1.40032191, 1.79907064]])

Now, we can also multiply each row by the volumes to get the mass of salt in each tank.

plt.plot(sol.t, sol.y.T * [V_A, V_B])
plt.xlabel('t (min)')
plt.ylabel('Mass of salt (oz)')
plt.legend(['Tank A', 'Tank B']);
../_images/04-fode-2_39_0.png

This works because you can plot an array where the values to be plotted are all in columns.

Brief review¶

For systems of first order differential equations, you need to:

  1. Define a function \(y'(t, y)\) where \(y\) will be an array of values. The function must return an array that is the same shape as \(y\). For example, if you have two equations, \(y\) will contain the two function values, and \(y'\) must return two derivative values.

  2. You also need two initial conditions, one for each function, at the same value of \(t\).

  3. The solution from solve_ivp will return an array for the y-values, with each function in a row of that array. You can either extract the rows to plot them, or transpose the array and plot them all.

Predator-prey model example¶

The Lotka-Volterra model can be used to simulate predator-prey populations. Suppose we have \(u\) preys (e.g. rabbits) and \(v\) predators (e.g. foxes). Then, we can do a “mass balance” on each species as

\(\frac{du}{dt} = a u - b u v\)

\(\frac{dv}{dt} = -c v + d b u v\)

Here \(a\) is the natural growth rate of rabbits with no foxes. \(b\) is the rate that foxes eat rabbits. \(c\) is the rate that foxes die, and \(d\) describes how many new foxes result from the rabbits that are eaten. Suppose we start with 10 rabbits and 5 foxes. Plot the number of each species from t=0 to t=15.

a = 1.
b = 0.1
c = 1.5
d = 0.75

Y0 = np.array([0.01, 0.01]) # initial conditions
tspan = (0, 15000) # timespan to integrate over
teval = np.linspace(*tspan, 15000) # points to evaluate the solution on

def dXdt(t, X):
    rabbits, foxes = X
    drabbitdt = a * rabbits - b * rabbits * foxes
    dfoxesdt = -c * foxes + d * b * rabbits * foxes
    return np.array([drabbitdt, dfoxesdt])

# hard to read alternative : Please do not do this.
def ode(t, X):
    return [a * X[0] - b * X[0]*X[1],
           -c * X[1] + d * b * X[0]*X[1]]

from scipy.integrate import solve_ivp
sol = solve_ivp(dXdt, tspan, Y0, t_eval=teval)
sol.message
'The solver successfully reached the end of the integration interval.'
plt.plot(sol.t, sol.y.T)
plt.legend(['rabbits', 'foxes'], loc='upper right')
plt.xlabel('t')
plt.ylabel('count')
plt.xlim(tspan);
../_images/04-fode-2_46_0.png

This is a classic boom/bust cycle of predator/prey.

Qualitative method for systems of ODEs¶

We can consider direction fields for systems of ODEs to examine the qualitative behavior of solutions when there are two equations. The key here is to compute for each point (rabbit, fox) we compute (drabbit/dt, dfox/dt), and then plot these.

r = np.linspace(0.01, 240, 20) # rabbit grid
f = np.linspace(0.01, 240, 20) # fox grid

R, F = np.meshgrid(r, f) # 2D arrays of (rabbit, fox) points

DR, DF = dXdt(None, [R, F]) # These are dR/dt and dF/dt

# This normalizes the arrows so they are all the same length and just show the direction
N = np.sqrt(DR**2 + DF**2)

DR /= N
DF /= N

plt.quiver(R, F, DR, DF)
plt.xlabel('Number of rabbits')
plt.ylabel('Number of foxes')
plt.plot(sol.y[0], sol.y[1], 'b.');
../_images/04-fode-2_50_0.png

In this view, we have a limit cycle which just shows the number of rabbits and foxes goes up and down periodically as you travel around the solution curve. Time is parametric in this plot. It starts at t=0 at the initial state, and increases as you go around the cycle.

Summary¶

Systems of first order differential equations are solved the same way as single first order differential equations. The main difference is the system must be defined as:

\(Y'(t) = f(x, Y)\)

where \(Y'\) is a vector/array of first derivatives, and \(Y\) is a vector/array of function values.

You still use scipy.integrate.solve_ivp to solve the equations, but you need an initial condition for each equation.

There are other ode integrators in scipy that have different function signatures than `scipy.integrate.solve_ivp`.

For example, scipy.integrate.odeint requires functions like \(y' = f(y, t)\) which is the opposite of scipy.integrate.solve_ivp. You have to keep track of which one you are using.

scipy.integrate.odeint is older than scipy.integrate.solve_ivp, but it has fewer features (e.g. no events, fewer solver options).