Thesis and Viva
It’s been quite a year for me! I got a new job almost a year ago, wrote up my thesis, moved to a new city and I am about to move house again. Oh, and I just ...
Now that we have dealt with the ordinary differential equations we can go one of two ways. We can explore how to solve all types of these ODE’s and keep on solving them until the cows come home……. or we can move onto something a little different. We can extend our understanding of Differential Equations by exploring systems that involve more than one variable and derivative thereof. This path will lead us to much MUCH more interesting things such as Quantum Physics and Fluid Simulation.
We must now begin with a short but needed discussion on what exactly Partial Differential Equations (PDE's) are, this isn't exactly a new thing and something that has been done thousands of times (I shall leave links to other , possibly better, introductions) but for completeness I believe I should put this here. To begin with I shall introduce what is known as the partial derivative (again this can be a huge topic but link link link blah blah blah). When the functions we want to deal with are functions of more than one variable we can take derivatives wrt each of the different variables independently of one another. We do this by keeping the other variables constant and varying the one we are interested in. This is called taking a partial derivative. Partial differentials naturally lead to the idea of partial differential equations, differential equations are the natural extensions of ordinary differential equations to functions of multiple variables. These equations can be solved analytically however much like ODE’s the equations or families of equations that can be solved are usually the exception rather than the rule . The amount of PDEs is also much larger than ODE’s. Hence we need to turn towards numerical methods to solve these equations. PDEs are the most common differential equations which is solved in science and engineering and this class of equations covers most of the important equations in science ( Schroedinger equation, Napier stokes , Burgers equation etc.) hence a lot of work is put into improving the numerical methods for solving these equations.Now that we have the matrix equation we can code this up relatively easily. MATLAB is a perfect language to solve this problem as it is built to handle matrices easily and has very accurate inbuilt Linear Algebra solvers we make use of these solvers to code up this algorithm. To create the Matrix that defines the discrete PDE we have the following.
% A Script to solve the Laplace Equation using a Finite Difference Method
% First need to define the laplacian matrix. We will be turning this into
% a linear algebra problem of solving for x in Ax = B
clear;clc;
N = 60; % Number of points in the grid
L_center = eye(N).*4;
for I = 1:N-1
L_center(i,i+1) = -1;
L_center(i+1,i) = -1;
end
L_offdiag = eye(N) .* -1;
L_Other = zeros(N);
A = zeros(N,N,N,N);
for I = 1:N-1
A(i,i,:,:) = L_center;
A(i,i+1,:,:) = L_offdiag;
A(i+1,i,:,:) = L_offdiag;
end
% reshape:
S = size(A);
L = reshape(permute(A,[1,4,2,3]),N*S(1:2));
Once that is setup we can construct the Initial condition (and Boundary condition) vector
% Now we have the the discretized version of the laplacian we can create
% the vector which describes the initial state of the system.
T = zeros(N*N,1);
for I = 1:N-1
T(i,1) = 100;
T((N-1)*N + i,1) = 100;
end
These initial conditions set the left and right sides of a square to 100 degrees and the other sides to 0. Now we can solve the system we have created using linsolve and plot a 2d colourmap of the result.
tic;
X = linsolve(L,T);
toc;
% now reshape the vector and plot the result
Z = reshape(X,N,N);
[x,y] = meshgrid(1:N, 1:N);
surface(x,y,Z,'EdgeColor', 'black');
colorbar;
These calculations produce
In this simulation the grid was 60x60, we can investigate the scaling of this method by varying this producing the following results.
The logscale on the Y axis shows that this is an exponential scaling, meaning that if we want very accurate results even for this simple system our code will take quite some time to run.
Another Method to solve PDEs is the Method of lines. This method still follows the thinking of discretization however this method relies on discretising only one of the coordinates and leaving the other one in the continuum. This leaves us with an ODE system to solve which is much easier to solve that the PDE that we had before. We know we can solve systems of ODE’s with highly accurate solvers such as RK4 (see previous posts) so these are the solvers that are used here.
To show how this works I shall, as always , show an example. For this example I shall use the diffusion or heat equation
[[ \frac{\partial u}{\partial t} = D \frac{\partial^2 u}{\partial x^2}\]]
Discretising the RHS of the equation using the usual finite difference formula, we now have
\[ \frac{d u_i}{dt} = D \frac{u_{i+1} - 2 u_i + u_{i-1}}{\Delta x^2}\]
Now we have a system of ODEs which we know can be solved using Runge-Kutta Methods from the previous posts. Instead of using python we shall again use MATLAB to show another language but more importantly it has very accurate inbuilt solvers which can handle matrices very well. This helps us immensely since we can formulate the equations above in terms of matrices/vectors again.
Solving this problem in MATLAB we first have to define the problem in a different script.
function du = diff_eqs(t,u)
% parameters
global dx
D = 1;
dx2 = dx^2;
xl=0.0;
xu=1.0;
%
% PDE
n=length(u);
dx2=((xu-xl)/(n-1))^2;
for j = 1:n
if(j==1) du(j)=2.0*(u(j+1)-u(j))/dx2;
elseif(j==n) du(j)=2.0*(u(j-1)-u(j))/dx2;
else du(j) = D * ((u(j+1) - 2.0*u(j) + u(j-1))/dx2);
end
end
du = du';
end
In this file we have defined the differential in the bulk and at the edges. The system will incur some errors at the edges since (as can be seen above) the difference equation is not complete. Now that we have defined the equation to solve we can turn to putting this into MATLABs inbuilt solvers. I use ode45 the workhorse of MATLAB’s ODE library, to solve this equation. This function will use RK4 algorithm like we developed in the last post but with some optimization routines built in such as adaptive step etc.
% A Method of lines algorithm to solve differential equations
% Initial Conditions
clear;clc;
N = 41;
for j=1:N
U0(j) = sin((pi/1.0)*(j-1)/(N-1)); % Initial condition
end
%timing
ti = 0.0;
tf = 1.0;
tout=linspace(ti,tf,N);
% ODE integration
reltol=1.0e-05; abstol=1.0e-05;
options=odeset('RelTol',reltol,'AbsTol',abstol);
[t,u]=ode15s(@diff_eqs,tout,U0,options); %Perform the integration
The result of this code is thus
From this graph we can see ( as you have probably guessed by now) that the Method of Lines is very accurate in time but much less accurate in its discretization of space.
In this last post we have explored some of the more basic algorithms for solving differential equations. However these are only really useful for solving scientific problems, they do not generalise well to higher dimensions and different geometries. Whilst the Finite difference method is fine for square or rectangular lattices different more complex geometries will be problematic to implement with this method. Accuracy at the edges will have to be sacrificed if approximations such as interpolation will need to be made. The Method of lines is also tricky to put onto a complex geometry since it uses basic ODE solvers. It is also only accurate to the first order in the discretized variables meaning that the entire algorithm is this order in error since this is the largest error.
There are many other algorithms that we could discuss for solving scientific ODE’s which often concern simple geometries and limited dimensions. There are more complex algorithms which can be implemented such as the split step Fourier method. I will discuss these in an interim post that will come later. For now I shall move on with discussing algorithms which can handle more complex geometries. These methods will be the Finite Element Method and the Finite Volume Method.
It’s been quite a year for me! I got a new job almost a year ago, wrote up my thesis, moved to a new city and I am about to move house again. Oh, and I just ...
First Quantum Computing Hackathon
A Bog Standard Introdution to Quantum Computing As with most introductions to scientific books and blogs there always has to be sections that are repeated ev...
Now that we have dealt with the ordinary differential equations we can go one of two ways. We can explore how to solve all types of these ODE’s and keep on s...
Quantum Computing is posed to become one of the most useful technologies invented. It boasts algorithms that can outperform some of the best classical algori...
Previously we discussed how to solve some simple ODE’s and looked at coding a simple forward Euler algorithm. However we found that the solution we used does...
Differential equations are central to the study of the natural world. They describe everything from the flow of fluids through pipes to the evolution of elec...