Pseudo-spectral with RK4 integration

In summary, Pseudo-spectral with RK4 integration is a numerical method used to solve differential equations, particularly in the field of computational physics. It combines the advantages of both pseudo-spectral and RK4 methods, allowing for accurate and efficient solutions to complex equations by using fast Fourier transforms and Runge-Kutta algorithms. This method has been successfully applied in various areas of research, including fluid dynamics, astrophysics, and quantum mechanics.
  • #1
Dustinsfl
2,281
5
I using the pseudo-spectral method with RK4 integration to solve the nonlinear KdV equation.

My code works for both the linear KdV and the NLS equation; however, it nots working right for \(u_t + u_{xxx} + 6uu_x = u_t + u_{xxx} + 3(u^2)_x = 0\). I want to view from \(0\leq t\leq 10\) and \(-40\leq x\leq 40\) so \(L = 80\). I want accuracy of \(10^{-5}\) or less. The accuracy of RK4 is of order 4 and the accuracy of the pseudo spectral method is \(e^{-x/(\Delta x)}\).

I used the identity \(\mathcal{F}(u^2) = \mathcal{F}^{-1}(u)\mathcal{F}^{-1}(u)\).
The problem has to be related to the inverse transform setup of \((u^2)_x\).
Below you will see the code work with the plots and the code not work.

Numerical instability occurs at \(\Delta t < \frac{2\sqrt{2}(\Delta x)^2}{\pi^2}\) but if I choose a stable value for \(\Delta t\) the plots don't even come close to correct.


Code in Python linear:
Code:
#!/usr/bin/env ipython 
#  The pseudo-spectral method for solving the Linear KdV equation 
#  u_t + u_{xxx} = 0 
 
import matplotlib.pyplot as plt 
import numpy as np 
 
L = 200.0 
N = 512.0 
dt = 0.005 
tmax = 5 
nmax = int(np.floor(tmax / dt))  #  also try ceiling 
dx = L / N 
x = np.arange(-L / 2.0, L / 2.0 - dx/2., dx) 
k = np.hstack((np.arange(0,N / 2.0 - .1),np.arange(-N/2., 0))).T * 2.0 * np.pi / L 
k3 = k ** 3 
FWHM = 0.3 * np.pi 
alpha = np.sqrt(0.5) 
u = alpha * np.exp(-x ** 2 / (2 * FWHM ** 2)) 
udata = u 
tdata = 0 
 
for nn in range(1, nmax+1): 
    du1 = 1j * np.fft.ifft(k3 * np.fft.fft(u)) 
    v = u + 0.5 * du1 * dt 
    du2 = 1j * np.fft.ifft(k3 * np.fft.fft(v)) 
    v = u + 0.5 * du2 * dt 
    du3 = 1j * np.fft.ifft(k3 * np.fft.fft(v)) 
    v = u + du3 * dt 
    du4 = 1j * np.fft.ifft(k3 * np.fft.fft(v)) 
    u = u + (du1 + 2 * du2 + 2 * du3 + du4) * dt / 6.0 
    if np.mod(nn, np.floor(nmax / 100.0)) == 0: 
        udata = np.vstack([udata, u]) 
        tdata = np.vstack([tdata, nn * dt]) 
 
plt.pcolor(x, tdata.ravel(), np.real(udata)) 
plt.xlabel('$x$') 
plt.ylabel('Time') 
plt.title('Linear Dispersion in the $U_t+U_{xxx}=0$ Equation',fontsize=13) 
plt.show()

http://img14.imageshack.us/img14/5155/raf8.png

Code in Matlab NLS:
Code:
% p2.m: the pseudo-spectral method for solving the NLS equation
% iu_t+u_{xx}+2|u|^2u=0.

  L = 80; 
  N = 256; 
  dt = 0.02;  
  tmax = 20; 
  nmax = round(tmax/dt);
  dx = L/N; 
  x = (-L/2:dx:L/2-dx)'; 
  k = [0:N/2-1 -N/2:-1]'*2*pi/L; 
  k2 = k.^2;
  u = 1.2*sech(1.2*(x + 20)).*exp(1i*x) + 0.8*sech(0.8*x);
  udata = u; 
  tdata = 0;
  
  for nn = 1:nmax                               % integration begins
    du1 = 1i*(ifft(-k2.*fft(u)) + 2*u.*u.*conj(u));  
    v = u + 0.5*du1*dt;
    du2 = 1i*(ifft(-k2.*fft(v)) + 2*v.*v.*conj(v));  
    v=u+0.5*du2*dt;
    du3 = 1i*(ifft(-k2.*fft(v)) + 2*v.*v.*conj(v));  
    v = u + du3*dt;
    du4 = 1i*(ifft(-k2.*fft(v)) + 2*v.*v.*conj(v));
    u = u + (du1 + 2*du2 + 2*du3 + du4)*dt/6;
    if mod(nn, round(nmax/25)) == 0
       udata = [udata u]; 
       tdata = [tdata nn*dt];
    end
  end
  % integration ends
  
  waterfall(x, tdata, abs(udata'));           % solution plotting
  colormap(jet(128)); view(10, 60)
  text(-2,  -6, 'x', 'fontsize', 15)
  text(50, 5, 't', 'fontsize', 15)
  zlabel('|u|', 'fontsize', 15)
  axis([-L/2 L/2 0 tmax 0 2]); grid off
  set(gca, 'xtick', [-40 -20 0 20 40])
  set(gca, 'ytick', [0 10 20])
  set(gca, 'ztick', [0 1 2])

http://img812.imageshack.us/img812/4928/1wur.png


Code in python nonlinear:
Code:
#!/usr/bin/env ipython
#  The pseudo-spectral method for solving the nonLinear KdV equation
#  u_t + u_{xxx} + 6uu_x = 0

import numpy as np
import pylab

L = 80.0
N = 200.0
dt = 0.02   # and 0.05
tmax = 10
nmax = int(np.floor(tmax / dt))  #  also try ceil/floor
dx = L / N
x = np.arange(-L / 2.0, L / 2.0 - dx, dx)
k = np.hstack((np.arange(0, N / 2.0 - 1.0),
               np.arange(-N / 2.0, 0))).T * 2.0 * np.pi / L
k1 = 1j * k
k3 = (1j * k) ** 3
u = 2 * (1 / (np.exp(x + 20.0) + np.exp(-x - 20.0))) ** 2
udata = u
tdata = 0.0

for nn in range(1, nmax + 1):
    du1 = (-np.fft.ifft(k3 * np.fft.fft(u)) -
           3 * np.fft.ifft(k1 * np.fft.ifft(u) * np.fft.ifft(u)))
    v = u + 0.5 * du1 * dt
    du2 = (-np.fft.ifft(k3 * np.fft.fft(v)) -
           3 * np.fft.ifft(k1 * np.fft.ifft(v) * np.fft.ifft(v)))
    v = u + 0.5 * du2 * dt
    du3 = (-np.fft.ifft(k3 * np.fft.fft(v)) -
           3 * np.fft.ifft(k1 * np.fft.ifft(v) * np.fft.ifft(v)))
    v = u + du3 * dt
    du4 = (-np.fft.ifft(k3 * np.fft.fft(v)) -
           3 * np.fft.ifft(k1 * np.fft.ifft(v) * np.fft.ifft(v)))
    u = u + (du1 + 2.0 * du2 + 2.0 * du3 + du4) * dt / 6.0
    if np.mod(nn, np.ceil(nmax / 100.0)) == 0:
        udata = np.vstack((udata, u))
        tdata = np.vstack((tdata, nn * dt))fig = pylab.figure()
ax = fig.add_subplot(111)
ax.pcolor(x, tdata.ravel(), np.real(udata))
pylab.xlim((-40, 40))
pylab.ylim((0, 2))
pylab.show()

Numerical instability plot:
http://img30.imageshack.us/img30/4710/ix0.png
Stable Plot:
http://imageshack.us/a/img4/5729/1rob.th.png


Code in Matlab nonlinear:
Code:
% p2.m: the pseudo-spectral method for solving the KdV equation
% u_t+u_{xxx}+3(u^2)_x=0.

  L = 80; 
  N = 100; 
  dt = 0.02;  % and 0.05
  tmax = 10; 
  nmax = round(tmax/dt);
  dx = L/N; 
  x = (-L/2:dx:L/2-dx)'; 
  k = [0:N/2-1 -N/2:-1]'*2*pi/L; 
  k1 = 1i*k;
  k2 = (1i*k).^2;
  k3 = (1i*k).^3;
  u = 2*sech(x + 20).^2;
  udata = u;
  tdata = 0;
  
  for nn = 1:nmax                               % integration begins
    du1 = -ifft(k3.*fft(u)) - 3*ifft(k1.*ifft(u).*ifft(u));  
    v = u + 0.5*du1*dt;
    du2 = -ifft(k3.*fft(v)) - 3*ifft(k1.*ifft(v).*ifft(v));  
    v = u + 0.5*du2*dt;
    du3 = -ifft(k3.*fft(v)) - 3*ifft(k1.*ifft(v).*ifft(v));  
    v = u + du3*dt;
    du4 = -ifft(k3.*fft(v)) - 3*ifft(k1.*ifft(v).*ifft(v));
    u = u + (du1 + 2*du2 + 2*du3 + du4)*dt/6;
    if mod(nn, round(nmax/15)) == 0
       udata = [udata u]; 
       tdata = [tdata nn*dt];
    end
  end
  % integration ends
  
  waterfall(x, tdata, abs(udata'));           % solution plotting
  colormap(jet(128)); 
  view(10, 60)
  %text(-2,  -6, 'x', 'fontsize', 15)
  axis([-40 40 0 tmax 0 2]); 
  grid off

Numerical unstable plot:
http://img163.imageshack.us/img163/6329/2pj.png
Stable plot:
http://imageshack.us/a/img855/7173/ufvp.th.png
 
Last edited:
Mathematics news on Phys.org
  • #2


I would first look into the stability of the code and make sure that the time step and spatial resolution are appropriate for the given problem. From the plots, it seems like there might be a stability issue with the code. I would try decreasing the time step and increasing the spatial resolution to see if that improves the results.

I would also check the implementation of the inverse transform for the term \((u^2)_x\) to make sure it is correct. It is possible that there is an error in the code that is causing the instability.

Additionally, I would check the convergence of the solution by comparing it to a known analytical solution or by varying the time step and spatial resolution to see if the solution is converging to a stable solution. If it is not, then there might be an issue with the implementation of the method.

I would also check if there are any boundary conditions that need to be included in the code, as they could affect the stability of the solution.

Overall, I would carefully examine the code and make sure all the steps are implemented correctly and that the parameters are appropriate for the given problem. If the issue persists, I would consult with other experts in the field or consider using a different method for solving the problem.
 

1. What is Pseudo-spectral with RK4 integration?

Pseudo-spectral with RK4 integration is a numerical method used for solving differential equations. It combines the spectral method, which utilizes Fourier series to approximate the solution, with the Runge-Kutta 4th order integration method, which uses a set of equations to compute the solution at discrete time steps.

2. What are the advantages of using Pseudo-spectral with RK4 integration?

Some advantages of using this method include its high accuracy and efficiency in solving differential equations, as well as its ability to handle a wide range of problems, including those with highly oscillatory solutions. It also has good stability properties, making it suitable for long-time simulations.

3. What types of problems can Pseudo-spectral with RK4 integration be applied to?

Pseudo-spectral with RK4 integration can be applied to a variety of problems, including fluid dynamics, electromagnetics, quantum mechanics, and many more. It is particularly useful for problems with periodic or highly oscillatory solutions.

4. Are there any limitations of Pseudo-spectral with RK4 integration?

Like any numerical method, Pseudo-spectral with RK4 integration has its limitations. It may not be suitable for problems with discontinuities or sharp gradients, and it can struggle with problems that require high spatial resolution. Additionally, it may be more computationally expensive compared to other methods for certain types of problems.

5. How does Pseudo-spectral with RK4 integration compare to other numerical methods?

Pseudo-spectral with RK4 integration is generally considered to be a highly accurate and efficient method for solving differential equations. It is often compared to other spectral methods and finite difference methods, and its performance will vary depending on the specific problem being solved. In general, it is a good choice for problems with periodic or highly oscillatory solutions.

Similar threads

  • General Math
Replies
1
Views
1K
Replies
1
Views
1K
  • Calculus and Beyond Homework Help
Replies
6
Views
2K
  • MATLAB, Maple, Mathematica, LaTeX
Replies
5
Views
7K
  • MATLAB, Maple, Mathematica, LaTeX
Replies
13
Views
4K
  • Programming and Computer Science
Replies
4
Views
6K
Replies
5
Views
5K
  • Special and General Relativity
3
Replies
75
Views
3K
  • Advanced Physics Homework Help
Replies
1
Views
2K
  • Differential Equations
Replies
1
Views
1K
Back
Top