This paper was converted on www.awesomepapers.org from LaTeX by an anonymous user.
Want to know more? Visit the Converter page.

Simulation of Gaussian Wave Packets used to Illustrate Elementary Quantum Mechanics Scenarios

Francisco Guzman-Cajica 2002236d@umich.mx Facultad de Ciencias Físico Matemáticas, Universidad Michoacana de San Nicolás de Hidalgo. Edificio ALFA, Cd. Universitaria, 58040 Morelia, Michoacán, México.    Francisco S. Guzmán francisco.s.guzman@umich.mx Instituto de Física y Matemáticas, Universidad Michoacana de San Nicolás de Hidalgo. Edificio C-3, Cd. Universitaria, 58040 Morelia, Michoacán, México.
(July 27, 2025)
Abstract

In this paper we numerically solve the time dependent Schrödinger equation for scenarios using wave packets. These examples include the free wave packet, which we use to show the difference between group and phase velocities, the packet in a harmonic oscillator potential with non-trivial initial conditions in one and two dimensions, which is compared with their classical analogs to show how Ehrenfest theorem holds. We also include simulations of the diffraction through the single and double slit potentials, the refraction with a step potential and the dispersion by a central potential. The aim of this paper is to illustrate with simulations, nowadays easy to implement, scenarios that can help explaining the basics of the wave-particle duality.

I Introduction

It is common to find illustrative examples of quantum systems in books and courses, mostly concerning stationary scenarios, like the particle in a box, the particle in a harmonic oscillator potential and the Hydrogen atom found in typical text books. Nowadays, with the help of numerical methods and affordable computing power, it is relatively simple to construct non-stationary scenarios with certain dynamics, which help illustrating some basics like the wave-particle duality, understood from solutions of Schrödinger equation.

With this aim we produced a number of programs that solve Schrödinger equation for some interesting scenarios involving modulated wave packets whose dynamics concerns the particle and wave nature described by the wave function. The cases we selected for illustration concern typical problems with nearly trivial potentials, however using non-stationary and non-trivial initial conditions. We also point to supplemental material that includes animations of the problems solved here, that serve as complement of the snapshots included in paper and may help for educational purposes in the classroom Gen . We believe that this work can be a complement of some educative analytical Reyna-Munoz et al. (2024) and numerical Becerril et al. (2008) solutions of Schrödinger equation.

We first present problems defined in one spatial dimension and start with the well studied case of the free wave packet. We use this example to show how a Gaussian packet spreads during the evolution as predicted by the exact solution, and also to point out the difference between group and phase velocities. We evolve a packet subject to the effects of the Harmonic Oscillator potential for non trivial initial conditions, first the quasi-classical state and later a rather arbitrary Gaussian wave packet to show the differences in terms of distortion of the density. We also solve the classical analog to verify that the Ehrenfest theorem holds.

Problems defined on two spatial dimensions are also solved, specifically the evolution of a packet on a two-dimensional harmonic trap, and it is shown how the Ehrenfest theorem holds for a system with two degrees of freedom. In more elaborate scenarios the diffraction of the wave-packet by a single and double slit potentials are studied, for which we calculate the interference pattern. We also present the reflection and refraction by a step potential. This case concerns the deflection of the wave front, and implies the Snell law for the wave packet evolving according to Schrödinger equation. Finally we study the dispersion by a central potential, which according to theory Cohen-Tannoudji et al. (1977) a modulated plane wave interacting with a central potential would produce a spherical wave front.

The paper is organized as follows. We first specify the numerical methods used to solve Schrödinger equation in Section II, then in Sections III and IV we describe the problems in one and two spatial dimensions. Finally in Section V we present some final comments.

II Numerical methods

The fully time-dependent Schrödinger equation for a particle of mass mm subject to the action of a potential UU reads

iΨτ=22mξ2Ψ+U(ξ,τ)Ψ{\rm i}\hbar\frac{\partial\Psi}{\partial\tau}=-\frac{\hbar^{2}}{2m}\nabla_{\xi}^{2}\Psi+U(\vec{\xi},\tau)\Psi (1)

where Ψ=Ψ(ξ,τ)\Psi=\Psi(\vec{\xi},\tau) and i:=1{\rm i}:=\sqrt{-1}; we define this number because, below we will keep the traditional notation of ii for integer labels of the numerical domain and ı^\hat{\textbf{\i }} for the unitary basis vector, both along the xx-direction. In order to solve this equation numerically, we rescale variables according to the transformation:

x=ξa0\displaystyle\vec{x}=\frac{\vec{\xi}}{a_{0}} , t=E0τ,\displaystyle t=\frac{E_{0}}{\hbar}\tau,
V(x,t)\displaystyle V(\vec{x},t) =\displaystyle= 1E0U(ξ,τ),\displaystyle\frac{1}{E_{0}}U(\vec{\xi},\tau),
ψ(x,t)\displaystyle\psi(\vec{x},t) =\displaystyle= a0kΨ(ξ,τ),\displaystyle\sqrt{a_{0}^{k}}\Psi(\vec{\xi},\tau),
p^\displaystyle\hat{p} =\displaystyle= a0pξ^=ix,\displaystyle\frac{a_{0}}{\hbar}\hat{p_{\xi}}=-i\nabla_{x},
a0\displaystyle a_{0} =\displaystyle= Bohr radius,\displaystyle\text{Bohr radius},
E0\displaystyle E_{0} =\displaystyle= 2ma02,\displaystyle\frac{\hbar^{2}}{ma_{0}^{2}}, (2)

where a0a_{0} is a length scale appropriate for each problem to be treated. If we are working with atomic scales, it could be one Angstrom or Bohr’s radius. These new variables are dimensionless and will simplify numerical calculations. In the redefinitions above, the wave function is also rescaled to ensure it has norm one, while kk is the dimension of the spatial domain, in this paper one and two. The resulting equation reads

iψt=12x2ψ+V(x,t)ψ,{\rm i}\frac{\partial\psi}{\partial t}=-\frac{1}{2}\nabla_{x}^{2}\psi+V(\vec{x},t)\psi, (3)

where ψ=ψ(x,t)\psi=\psi(\vec{x},t). We call these dimensionless units code units and they will be used from this point on.

Equation (3) is solved numerically as an initial value problem provided some initial conditions for ψ\psi. The numerical method used for integration is based on Finite Differences defined on a uniformly discrete domain for one and two-dimensional scenarios.

One-dimensional problems.. The space-time domain of solution is D=[xmin,xmax]×[0,tf]D=[x_{min},x_{max}]\times[0,t_{f}]. The numerical domain is the set of points (xi,tn)D(x_{i},t^{n})\in D such that xi=xmin+iΔxx_{i}=x_{min}+i\Delta x, where Δx=(xmaxxmin)/Nx\Delta x=(x_{max}-x_{min})/N_{x} and i=0,1,,Nxi=0,1,...,N_{x} where NxN_{x} is the number of cells along the spatial domain, whereas tn=nΔtt^{n}=n\Delta t with Δt=CFLΔx2\Delta t=CFL\Delta x^{2} and n=0,1,,Nt=tf/Δtn=0,1,...,N_{t}=t_{f}/\Delta t, where CFLCFL stands for the Courant-Friedrichs-Lewy factor between spatial and time resolutions. In this domain the wave function and potential at the arbitrary point (xi,tn)(x_{i},t^{n}) are denoted by ψin\psi^{n}_{i} and VinV^{n}_{i} respectively.

For the evolution from time tnt^{n} to tn+1t^{n+1} we implement the Crank-Nicolson average, which leads to the following second order accurate evolution scheme for Eq. (3):

(α)ψi1n+1\displaystyle(-\alpha)\psi^{n+1}_{i-1} +\displaystyle+ (1+2α+βVin+1)ψin+1+(α)ψi+1n+1\displaystyle(1+2\alpha+\beta V^{n+1}_{i})\psi^{n+1}_{i}+(-\alpha)\psi^{n+1}_{i+1}
=\displaystyle= (α)ψi1n+(12αβVin)ψin+(α)ψi+1n,\displaystyle(\alpha)\psi^{n}_{i-1}+(1-2\alpha-\beta V^{n}_{i})\psi^{n}_{i}+(\alpha)\psi^{n}_{i+1},

where α=14iΔtΔx2\alpha=\frac{1}{4}{\rm i}\frac{\Delta t}{\Delta x^{2}}, β=12iΔt\beta=\frac{1}{2}{\rm i}\Delta t. This scheme defines a tridiagonal linear system that is valid for inner points i=1,,Nx1i=1,...,N_{x}-1, whereas boundary conditions at xmin=x0x_{min}=x_{0} and xmax=xNxx_{max}=x_{N_{x}} determine the equation for space labels i=0i=0 and i=Nxi=N_{x}. In all the examples we use a big enough domain as to impose the zero boundary condition ψ(D,t)=0\psi(\partial D,t)=0, which according to Guzmán (2023) implies the equations (1+2α+βV0n+1)ψ0n+1=(12αβV0n)ψ0n(1+2\alpha+\beta V^{n+1}_{0})\psi^{n+1}_{0}=(1-2\alpha-\beta V^{n}_{0})\psi^{n}_{0} and (1+2α+βVNxn+1)ψNxn+1=(12αβVNxn)ψNxn(1+2\alpha+\beta V^{n+1}_{N_{x}})\psi^{n+1}_{N_{x}}=(1-2\alpha-\beta V^{n}_{N_{x}})\psi^{n}_{N_{x}} at points with labels i=0i=0 and i=Nxi=N_{x} respectively. These two equations complete the system for all i=0,,Nxi=0,...,N_{x} and is then solved for ψin+1\psi^{n+1}_{i} using forward and backward substitution following the recipe in Press et al. (2007).

Two-dimensional problems. In this case the domain of integration is D=[xmin,xmax]×[ymin,ymax]×[0,tf]D=[x_{min},x_{max}]\times[y_{min},y_{max}]\times[0,t_{f}] and the numerical domain is defined by the points (xi,yj,tn)D(x_{i},y_{j},t^{n})\in D such that xi=xmin+iΔxx_{i}=x_{min}+i\Delta x, yj=ymin+jΔyy_{j}=y_{min}+j\Delta y with Δx=(xmaxxmin)/Nx\Delta x=(x_{max}-x_{min})/N_{x}, Δy=(ymaxymin)/Ny\Delta y=(y_{max}-y_{min})/N_{y} with NxN_{x} and NyN_{y} the number of cells along xx and yy directions, i=0,1,,Nxi=0,1,...,N_{x}, j=0,,Nyj=0,...,N_{y}. In all the examples we use Δx=Δy\Delta x=\Delta y, so that time discretization can be defined by tn=nΔtt^{n}=n\Delta t with Δt=CFLΔx2\Delta t=CFL\Delta x^{2} and n=0,1,,Ntn=0,1,...,N_{t}. In this domain at point (xi,yj,tn)(x_{i},y_{j},t^{n}) any involved function ff is denoted by fi,jnf^{n}_{i,j}.

The evolution is carried out using the Crank-Nicolson method as well, along with the Alternating Direction Implicit (ADI) order of integration across spatial directions. With this scheme the evolution from tnt^{n} to tn+1t^{n+1} is implemented in three steps as follows Guzmán (2023):

(1i4Δtδx2)Ri,j\displaystyle\left(1-\frac{\rm i}{4}\Delta t~\delta^{2}_{x}\right)R_{i,j} =\displaystyle= (1+i4Δtδx2)ψi,jn,\displaystyle\left(1+\frac{\rm i}{4}\Delta t~\delta^{2}_{x}\right)\psi^{n}_{i,j},
(1i4Δtδy2)Si,j\displaystyle\left(1-\frac{\rm i}{4}\Delta t~\delta^{2}_{y}\right)S_{i,j} =\displaystyle= (1+i4Δtδy2)Ri,j,\displaystyle\left(1+\frac{\rm i}{4}\Delta t~\delta^{2}_{y}\right)R_{i,j},
(1+i2ΔtVi,j)ψi,jn+1\displaystyle\left(1+\frac{\rm i}{2}\Delta t~V_{i,j}\right)\psi^{n+1}_{i,j} =\displaystyle= (1i2ΔtVi,j)Si,j,\displaystyle\left(1-\frac{\rm i}{2}\Delta t~V_{i,j}\right)S_{i,j}, (5)

where Ri,jR_{i,j} and Si,jS_{i,j} are auxiliary grid functions that update the values of the wave function after applying the derivative operator along each spatial direction δx2,δy2\delta^{2}_{x},~\delta^{2}_{y}, which are the second order derivative discrete operators. In two dimensional problems we only deal with time-independent potentials, thus we omit the superindex on Vi,jV_{i,j} in Eq. (5). These are two tridiagonal and one diagonal systems of linear equations that are formulated likewise in (II), explicitly

(α)Ri1,j\displaystyle(-\alpha)R_{i-1,j} +\displaystyle+ (1+2α)Ri,j+(α)Ri+1,j=\displaystyle(1+2\alpha)R_{i,j}+(-\alpha)R_{i+1,j}=
(α)ψi1,jn+(12α)ψi,jn+(α)ψi+1,jn,\displaystyle(\alpha)\psi^{n}_{i-1,j}+(1-2\alpha)\psi^{n}_{i,j}+(\alpha)\psi^{n}_{i+1,j},
(α)Si,j1\displaystyle(-\alpha)S_{i,j-1} +\displaystyle+ (1+2α)Si,j+(α)Si,j+1=\displaystyle(1+2\alpha)S_{i,j}+(-\alpha)S_{i,j+1}=
(α)Ri,j1+(12α)Ri,j+(α)Ri,j+1,\displaystyle(\alpha)R_{i,j-1}+(1-2\alpha)R_{i,j}+(\alpha)R_{i,j+1},
ψi,jn+1\displaystyle\psi^{n+1}_{i,j} =\displaystyle= 1βVi,j1+βVi,jSi,j,\displaystyle\frac{1-\beta V_{i,j}}{1+\beta V_{i,j}}S_{i,j}, (6)

where α=14iΔtΔx2\alpha=\frac{1}{4}{\rm i}\frac{\Delta t}{\Delta x^{2}} and β=12iΔt\beta=\frac{1}{2}{\rm i}\Delta t. These systems are completed with equations at boundary sides by imposing the boundary condition ψ(D,t)=0\psi(\partial D,t)=0. The boundary conditions on the numerical domain are analogous to those for the one-dimensional for i,j=0i,j=0 and for i=Nx,j=Nyi=N_{x},~j=N_{y}. Once with the complete systems of equations, we solve the two tridiagonal systems following the implementation in Press et al. (2007) of the forward-backward substitution, and the diagonal system is solved using direct substitution.

III Problems in 1D

Beyond stationary problems, time-dependent cases in one spatial dimension are the first scenarios discussed in Quantum Mechanics. Here we elaborate and discuss the simplest ones from a simulation based approach.

III.1 Free Gaussian Wave Packet

Moving free particles in Quantum Mechanics are some times represented by wave packets. Most of the time, the momentum of a particle is not known with complete certainty, it does not have a definite wavelength. Their wave functions are rather a sum of waves which cover a spectrum of wave numbers. A simple way to represent this is through a Gaussian wave packet, which is nothing more than a sum of plane waves with amplitudes that vary according to a Gaussian distribution. If the wave number of maximum amplitude corresponds to k0k_{0} and the standard deviation of the distribution is 2/a\sqrt{2}/a, then the normalized wave function of such particle at t=0t=0 is Cohen-Tannoudji et al. (1977):

ψ(x,0)\displaystyle\psi(x,0) =\displaystyle= a(2π)3/4ea24(kk0)2eikx𝑑k\displaystyle\frac{\sqrt{a}}{(2\pi)^{3/4}}\int_{-\infty}^{\infty}e^{-\frac{a^{2}}{4}(k-k_{0})^{2}}e^{ikx}dk (7)
=\displaystyle= (2πa2)1/4eik0xex2/a2.\displaystyle\left(\frac{2}{\pi a^{2}}\right)^{1/4}e^{ik_{0}x}e^{-x^{2}/a^{2}}.

The time evolution of such packet can be found by summing each plane wave eikxe^{ikx} multiplied by eiw(k)te^{-iw(k)t}, its time evolution. After doing the integral, the probability density of the particle happens to be Cohen-Tannoudji et al. (1977):

|ψ(x,t)|2=2πa211+4t2a4exp(2(xk0t)2a2+4t2a2).|\psi(x,t)|^{2}=\sqrt{\frac{2}{\pi a^{2}}}\frac{1}{\sqrt{1+\frac{4t^{2}}{a^{4}}}}\exp{-\frac{2(x-k_{0}t)^{2}}{a^{2}+\frac{4t^{2}}{a^{2}}}}. (8)

What we do is evolve the initial conditions (7) and illustrate the dynamics of the wave packet in Fig. 1. What happens is that the Gaussian density (8) widens and moves to the right. Fortunately there is an exact solution of this problem to compare with, so that we can show that the error between numerical and exact solution converges to zero with resolution.

This spreading property of particles reminds us of the Quantum Safari, defined by George Gamow in his book Gamow (2012),Gamow and Edwards (1999). When Mr. Tompkins and the professor go on an expedition to this place, they soon face a mosquito. But because of its quantum properties, after being spotted, its position becomes less certain over time. After a while, they are covered by a uniform mosquito probability density. This is exactly what happens with the Gaussian packet, Δx\Delta x grows indefinitely until it covers the entire space.

Another thing that can be done with the evolution is illustrate the difference between group and phase velocities. It is still difficult to explain the difference between the group and phase velocities in a few snapshot, thus we have placed an animation of this effect at Gen .

Refer to caption
Figure 1: At the left, snapshots of ±|ψ|\pm|\psi| and Re{ψ}\Re{\psi} at times t=0,0.01,0.02t=0,0.01,0.02, showing how the wave packet spreads. At the right, convergence of the L1L_{1} norm of the error to zero, of the density with respect to the exact solution (8).

The numerical parameters used for the numerical domain are x[1,3]x\in[-1,3], Nx=2000N_{x}=2000, CFL=0.125CFL=0.125, Nt=40000N_{t}=40000, whereas the initial conditions in (7) are k0=100k_{0}=100 and a=0.1a=0.1.

III.2 1D Harmonic oscillator

We now proceed to evolve a moving Gaussian wave packet subject to the effects of a harmonic oscillator potential. The potential and the initial conditions are:

V(x)\displaystyle V(x) =\displaystyle= 12ω2x2\displaystyle\frac{1}{2}\omega^{2}x^{2}
ψ(x,0)\displaystyle\psi(x,0) =\displaystyle= eip0xe(xx0)2/a2\displaystyle e^{{\rm i}p_{0}x}e^{-(x-x_{0})^{2}/a^{2}} (9)

where p0p_{0} is the initial velocity of the wave packet of width aa initially centered at x0=0x_{0}=0. The classical analog would be a particle of mass mm attached to a spring, whose position and momentum are x(t)x(t) and p(t)p(t). These functions obey the following equations of motion and initial conditions:

Refer to caption
Figure 2: Evolution of the quasi-classical wave packet onto a harmonic oscillator potential. At the top-left there are three representative snapshots, two at turning points and one at x=0x=0, the minimum of the potential. At the top-right we draw the expectation values of the position and momentum as functions of time with continuous lines and the values of the equivalent classical oscillator with points. At the bottom-left we show the uncertainties in position and momentum along with their product for two resolutions, low/high with continuous/dashed lines that are different, which reveals the influence of numerical approximations; nevertheless, the extrapolation of the uncertainties obtained from solutions with low and high resolutions is constant. Finally, at the bottom-right we show the behavior of the expectation values of the energy components as functions of time, where the points correspond to the values of the classical system at a few times.
dxdt\displaystyle\frac{dx}{dt} =\displaystyle= p,\displaystyle p,
dpdt\displaystyle\frac{dp}{dt} =\displaystyle= ω2x,\displaystyle-\omega^{2}x,
x(0)\displaystyle x(0) =\displaystyle= 0,\displaystyle 0,
p(0)\displaystyle p(0) =\displaystyle= p0,\displaystyle p_{0}, (10)

whose solution reads:

x(t)\displaystyle x(t) =\displaystyle= p0ωsin(ωt),\displaystyle\frac{p_{0}}{\omega}\sin(\omega t),
p(t)\displaystyle p(t) =\displaystyle= p0cos(ωt).\displaystyle p_{0}\cos(\omega t). (11)

An interesting theorem that holds for all quantum mechanical systems is Ehrenfest’s theorem; which probes the following equalities between expectation values:

dx^dt\displaystyle\frac{d\langle\hat{x}\rangle}{dt} =\displaystyle= p^,\displaystyle\langle\hat{p}\rangle,
dp^dt\displaystyle\frac{d\langle\hat{p}\rangle}{dt} =\displaystyle= xV^.\displaystyle-\langle\nabla_{x}\hat{V}\rangle. (12)

This set of equations looks very similar to Newton’s second law, it seems like the expectation value of x^\hat{x} follows the trajectory of a classical particle. Nevertheless, this is only true when V^=V(x^)\langle\nabla\hat{V}\rangle=\nabla V(\langle\hat{x}\rangle) Cohen-Tannoudji et al. (1977). In particular, this equality holds for the harmonic oscillator. Therefore, we can expect x^(t)\langle\hat{x}\rangle(t) and p^(t)\langle\hat{p}\rangle(t) to behave like x(t)x(t) and p(t)p(t) respectively if we start with x^(0)=0\langle\hat{x}\rangle(0)=0 and p^(0)=p0\langle\hat{p}\rangle(0)=p_{0}.

This result is independent of the value of aa. Nevertheless, when aa takes on the special value a=2/ωa=\sqrt{2/\omega}, the total energy of the particle is minimum and the wave packet does not spread, a case called quasi-classical state Cohen-Tannoudji et al. (1977). In Fig. 2 we show snapshots of the evolution that illustrate how the pulse oscillates around the minimum. Two snapshots are taken at turning points and the other one at the minimum of the potential. Notice that at turning points the wave function has no nodes, whereas at the center the number of nodes is maximum, which is consistent with the fact that bigger the number of nodes the higher the kinetic energy. Also shown are the expectation values of position x^\langle\hat{x}\rangle and momentum p^\langle\hat{p}\rangle as functions of time, on top of them the points indicate the position and momentum of the classical system (11) at some times. Turning points can be identified as the maximae and minimae of x^\langle\hat{x}\rangle at times 0.08k+0.040.08k+0.04 with kk integer.

Additional information in Fig. 2 are the uncertainties Δx\Delta x and Δp\Delta p. As expected, since the wave packet does not spread, Δx\Delta x remains nearly constant whereas Δp\Delta p seems to change, however we verified that the variations are due to numerical errors, which is why we also show the uncertainties using a higher numerical resolution with dashed lines; in fact a Richardson extrapolation of the momentum uncertainty using the two resolutions reveals that Δp\Delta p is constant. The product ΔxΔp\Delta x\Delta p is also illustrative. Notice that, in agreement with the uncertainty principle, ΔxΔp\Delta x\Delta p is always 1/2\geq 1/2. Since the uncertainty in momentum is affected by numerical errors, then the product is also affected, reason why we also show in dashed line the product using high resolution. The extrapolation corresponds to a constant value in the continuum limit of 1/21/2, which coincides with the theoretical value Cohen-Tannoudji et al. (1977).

Finally, in the figure we also show the conservation of the expectation value of the total energy, whereas the potential T\langle T\rangle and kinetic V\langle V\rangle energies oscillate. Dots indicate the values of these energies in the classical case (11) at various times.

Refer to caption
Figure 3: Evolution of a wave packet different from the quasi-classical case, in a harmonic oscillator potential. At the top-left there are the three representative snapshots at center and turning points. At the top-right the expectation values of the position and momentum as functions of time are drawn with continuous lines and some values of the equivalent classical oscillator with points. At the bottom-left we show the uncertainties in position and momentum along with their product. Finally, at the bottom-right we show the behavior of the expectation values of the energy components as functions of time along with dots corresponding to the classical solution.

In Fig. 3, we present snapshots of the wave packet evolution with a=1/ωa=\sqrt{1/\omega}, different from the quasi-classical profile. It can be seen that the Gaussian spreads as it approaches the turning points. The expectation values of the position and momentum are still the same as the classical analogs, however the uncertainties look very different to the quasi-classical wave packet, for example in this case Δx\Delta x is not constant in time anymore but oscillates. Unlike in the quasi-particle wave packet, the uncertainties genuinely oscillate and an extrapolation of their values using higher resolution does not lead to constant values anymore. The figure shows that the uncertainty principle ΔxΔp1/2\Delta x\Delta p\geq 1/2 holds, as well as the conservation of total energy. An animation of the evolution of this system can be fount in Gen .

The parameters that define the numerical domain are the same for the two wave packets, namely x[2,2]x\in[-2,2], Nx=2000N_{x}=2000, CFL=0.125CFL=0.125, Nt=640000N_{t}=640000, whereas the parameters for the initial conditions are p0=50p_{0}=50 and ω=12.5π\omega=12.5\pi.

III.3 Perturbed harmonic oscillator

A more dynamical scenario that involves a time dependent potential is the forced harmonic oscillator. For this, we perturb the ground state of the harmonic oscillator with a sinusoidal wave, which can correspond to a harmonic trap perturbed with an electromagnetic wave, a case used to illustrate resonance Cohen-Tannoudji et al. (1977). The potential and initial condition used for this scenario are:

V(x,t)\displaystyle V(x,t) =\displaystyle= 12ω2x2+αω2xsin(ωt),\displaystyle\frac{1}{2}\omega^{2}x^{2}+\alpha\omega^{2}x\sin{\omega t},
ψ(x,0)\displaystyle\psi(x,0) =\displaystyle= (ωπ)1/4e12ω2x2.\displaystyle\left(\frac{\omega}{\pi}\right)^{1/4}e^{-\frac{1}{2}\omega^{2}x^{2}}. (13)

Notice that the frequency of the perturbation coincides with the natural frequency of the harmonic potential, which is expected to produce resonance. For comparison we use the solution of the classical problem, given by:

x(t)=α2(ωtcos(ωt)sin(ωt)),x(t)=\frac{\alpha}{2}\left(\omega t\cos{\omega t}-\sin{\omega t}\right), (14)

which is an oscillation of the particle with linearly growing amplitude.

We solve Schrödinger equation for the evolution of this system with α=0.2\alpha=0.2 and ω=12.5π\omega=12.5\pi, on the numerical domain defined by x[2,2]x\in[-2,2], Nx=2000N_{x}=2000, CFL=0.125CFL=0.125 and Nt=640000N_{t}=640000. The results are shown in Fig. 4. The wave packet oscillates with increasing amplitude, so that turning points are each time further out from the center. The amplitude growth reflects the resonance caused by the sinusoidal perturbation with the appropriate frequency ω\omega. The right graph of Fig. 4 also shows that the Ehrenfest theorem continues to hold for this time dependent potential. Notice that the Gaussian packet preserves its shape during the evolution because the width used corresponds to the quasi-classical packet. For visual grasp we show the animation of this problem at Gen .

Refer to caption
Figure 4: On the left, snapshots of the probability density of the perturbed ground state taken every t=0.032t=0.032, earliest at the bottom and latest on top. On the right, the expectation value of x^\hat{x} with continuous line and the classical solution x(t)x(t) indicated with dots for a few values of time that coincide with those of the snapshots in the left graph.

Finally, as far as we can tell, there is no exact solution to compare these results with.

IV Problems in 2D

In this section we solve Schrödinger equation on two space dimensions that help illustrating the dynamics of wave-packets in widely used scenarios in basic Quantum Mechanics.

IV.1 2D Harmonic oscillator

Our first example is the quasi-classical analog of the one-dimensional case above, which does not show dispersion of the density of probability. The potential and wave function profile we use are the following:

V(x,y)\displaystyle V(x,y) =\displaystyle= 12ω2(x2+y2)\displaystyle\frac{1}{2}\omega^{2}(x^{2}+y^{2})
ψ(x,y,0)\displaystyle\psi(x,y,0) =\displaystyle= 2πa2eip0xe((xx0)2+(yy0)2)/a2,\displaystyle\sqrt{\frac{2}{\pi a^{2}}}e^{{\rm i}\vec{p_{0}}\cdot\vec{x}}e^{-((x-x_{0})^{2}+(y-y_{0})^{2})/a^{2}}, (15)

which corresponds to a circularly symmetric wave packet with momentum po\vec{p_{o}}. The classical analog of this problem is a particle in the central potential:

V(r)=12ω2r2,V(r)=\frac{1}{2}\omega^{2}r^{2}, (16)

where r2=x2+y2r^{2}=x^{2}+y^{2}. We also use the solution of the classical version of the problem and set initial conditions suitable for the particle’s trajectory to be a circle. We do this by equating the centripetal acceleration to the force:

p2r=ω2rp=ωr,p=p.\frac{p^{2}}{r}=\omega^{2}r~~\Rightarrow~~p=\omega r,~~p=||\vec{p}||. (17)

We define initial conditions for the circular trajectory with ω=12.5π\omega=12.5\pi and r=0.2r=0.2, then p\vec{p}, with magnitude of 2.5π2.5\pi, is chosen perpendicular to the position vector. The period of this trajectory would be:

T=2πrp=2πω=0.16,T=\frac{2\pi r}{p}=\frac{2\pi}{\omega}=0.16, (18)

which is independent of the radius of the trajectory.

Quasi-classical case. In Fig. 5 we illustrate the result of the evolution of this wave packet. The wave packet indeed moves on a circle of radius 0.20.2 with a period of 0.160.16 in the clockwise direction. The shape of the packet does not change because the width of the packet is set to the special value a=2/ωa=\sqrt{2/\omega}. This width is that of the ground state of the two-dimensional harmonic potential. For these reasons, we call this packet the quasi-classical solution. The circle in this Figure corresponds to the trajectory of a classical particle with the same initial conditions under the influence of the classical potential described by Eqs. (17) and (18), and also corresponds to the trayectory of the expectation value of the position x(t)\langle\vec{x}\rangle(t). This solution of Schrödinger equation was calculated in the numerical domain defined by x[1,1]x\in[-1,1], y[1,1]y\in[-1,1], Nx=Ny=200Nx=Ny=200, CFL=0.125CFL=0.125 and Nt=12800Nt=12800, which corresponds to tf=Tt_{f}=T

Refer to caption
Figure 5: Snapshots of the evolution for the wave packet corresponding to the quasi-classical solution on a two-dimensional harmonic oscillator travelling on a circular trajectory. The initial position and momentum are 0.2ı^-0.2\hat{\textbf{\i }} and 0.2ωȷ^0.2\omega\hat{\textbf{\j }} respectively. The dotted circle is the trajectory formed by the expectation value of the position x^\langle\hat{\vec{x}}\rangle, which describes a circle of radius 0.20.2. In fact, the solution of the classical problem would be exactly on top of this circle as well. The shape of the wave packet does not disperse away while it orbits around the origin.

Another case. Likewise in the 1D scenario we also present the case with a non-educated Gaussian pulse with a=1/ωa=\sqrt{1/\omega}. The evolution is very interesting and the density appears in Fig. 6. The pulse evolves in clockwise direction. It starts with a concentrated probability distribution and like in the one dimensional case, it starts spreading as can be seen in the second snapshot, until it crosses the yy-axis; afterwards, the packet begins to compress again until it acquires its original shape at the xx-axis again in the third snapshot. The evolution repeats itself with the pulse compressing at the xx-axis and most expanded at the yy-axis.

The circle in this Figure corresponds to the expectation value x(t)\langle\vec{x}\rangle(t) as well as the trajectory of the classical particle with the same initial conditions under the influence of the classical potential. One takeaway from this exercise is that the Ehrenfest theorem still holds, that is, the expectation value of the position keeps behaving like that of the equivalent classical particle when we jump to two dimensions.

An animation of the quasi-classical state and one with crazy initial conditions can be seen at Gen .

Refer to caption
Figure 6: Evolution of the wave packet on the two-dimensional harmonic oscillator potential with a=1/ωa=\sqrt{1/\omega}. The initial position and momentum are the same as for the quasi-classical state. The expectation value of the position follows the same trajectory as the classical analog likewise in the quasi-classical particle case. The wave packet widens when it crosses the yy-axis and recovers its initial shape when it crosses the xx-axis during the evolution.

IV.2 Diffraction by a single slit

This problem is defined on a two space dimensions domain as follows. A Gaussian wave packet is launched towards a potential wall with a “hole”. The wave function partly bounces from the potential wall and partly passes through. What is illustrative is the well known diffraction pattern that has to be detected beyond the wall.

The initial condition for the wave function is ψ(x,y,0)=2πa2eip0xe((xx0)2+y2)/a2\psi(x,y,0)=\sqrt{\frac{2}{\pi a^{2}}}e^{{\rm i}p_{0}x}e^{-((x-x_{0})^{2}+y^{2})/a^{2}}, which has a Gaussian profile with a momentum along the xx-direction. The potential wall is centered at the yaxisy-axis and technically has a finite thickness of five domain cells. The slit is implemented as a segment of the yy-axis where the potential is zero. This potential can be expressed as follows:

V(x,y)={V0(x,y)[0.025,0.025]×([1,0.15)(0.15,1])0elseV(x,y)=\left\{\begin{array}[]{ll}V_{0}&(x,y)\in[-0.025,0.025]\times\\ &([-1,-0.15)\cup(0.15,1])\\ &\\ 0&{\rm else}\end{array}\right.

The potential barrier is high enough, with V0=4000V_{0}=4000, as to mimic an infinite potential. Technically this avoids one the need to implement zero boundary conditions on the wave function at the boundary of the wall. The domain parameters used for the numerical solution are x[1,1]x\in[-1,1], y[1,1]y\in[-1,1], Nx=Ny=200N_{x}=N_{y}=200, CFL=0.125CFL=0.125 and Nt=1950Nt=1950, whereas the initial conditions are defined by x0=0.4x_{0}=-0.4, p0=12.5πp_{0}=12.5\pi, a=0.25a=0.25.

Refer to caption
Figure 7: Three snapshots of the density at different times prior and post interaction with the slit of width 0.30.3. In the third snapshot we show the location of a detector at the line x=0.35x=0.35, where we measure the density at time t=0.0244t=0.0244 and show the resulting diffraction pattern in the fourth plot. This pattern resembles part of the sinc function, expected for monochromatic light.

In Fig. 7, one can see the evolution of the wave packet during and after passing through the slit. When the packet arrives at the slit, it starts interfering with itself and then a major part of the wave passes through. The reflected pulse looks interesting, with various fringes although not very well discussed in books. Concerning the pulse that passes through, the pattern forward is the one most analyzed. In order to picture this pattern, we implemented a detector screen placed at x=0.35x=0.35, where we measure the probability density, shown on the fourth image of Fig. 7, measured at the time of the third snapshot. The pattern is composed of three intensity peaks and two minima located at y=±0.22y=\pm 0.22. This result can be compared with the Fraunhofer diffraction of a wave going through a slit, which is sin(u)/u\sin(u)/u function with minima located at the following positions Hecht (2012):

asinθ=mλ,m=±1,±2,a\sin\theta=m\lambda,~~m=\pm 1,\pm 2,... (19)

where aa is the width of the slit, λ\lambda the wave length, θ\theta the deflection output angle and mm the label of the minima Hecht (2012). If we substitute the values from our simulation, we find that the first minima should be located at:

sinθ=λa=2π/p00.3=815,\sin\theta=\frac{\lambda}{a}=\frac{2\pi/p_{0}}{0.3}=\frac{8}{15}, (20)

which, in the case of a screen located 0.350.35 units of length away from the slit, corresponds to a yy value of 0.22060.2206. This corresponds to an error of 0.3%0.3\% which can be attributed to factors like the non monochromatic nature of the wave packet, and the fact that the distance between the slit and the screen is too small to be considered in the Fraunhofer regime. The important result is that, before the slit, the particle was not completely localized, but we knew that its momentum was around a specific value with Δp=contant\Delta p={\rm contant}. However, after the slit, the particle could be directed towards any of the diffracted rays, and there is no a priori clue of which path it might have taken until we measure it. One interesting fact is that we can be sure that it will not be detected at angles like ±32o\pm 32{}^{o} because of its wave-like properties.

IV.3 Experiment of the double slit

One of the most used examples of Quantum Mechanics is the experiment of the double slit. A single particle governed by Schrödinger equation is thrown against a barrier with two slits. After the barrier, a screen detector is placed to measure the position of the particle. The experiment is performed multiple times and a detecting plate records the distribution of arriving positions. If the particle were to behave classically, one should only see two spots in the screen, each one associated to the pass of the particle through each of the slits. Nevertheless, what is observed is a set of stripes that reassembles an interference pattern produced by a wave. This is what we will reproduce.

The particle state will be represented by the wave function ψ\psi on a two-dimensional space. The barrier with two slits will be represented by a potential barrier of height V0V_{0} and 0.050.05 units thick. The two slits are separated by the distance d=0.4d=0.4 and 0.10.1 units wide. The explicit potential is:

V(x,y)={V0(x,y)[0.025,0.025]×([1,0.25)(0.15,0.15)(0.25,1])0elseV(x,y)=\left\{\begin{array}[]{ll}V_{0}&(x,y)\in[-0.025,0.025]\times\\ &([-1,-0.25)\cup(-0.15,-0.15)\cup(0.25,1])\\ &\\ 0&{\rm else}\end{array}\right.

The initial value of ψ\psi will be that of a Gaussian wave packet: ψ(x,y,0)=2πa2eip0xe((xx0)2+y2)/a2\psi(x,y,0)=\sqrt{\frac{2}{\pi a^{2}}}e^{{\rm i}p_{0}x}e^{-((x-x_{0})^{2}+y^{2})/a^{2}} with a=0.3a=0.3, x0=0.4x_{0}=-0.4, p0=12.5πp_{0}=12.5\pi and V0=6000V_{0}=6000. Finally, the domain parameters are the following: x[1.5,1.5]x\in[-1.5,1.5], y[1.5,1.5]y\in[-1.5,1.5], Nx=Ny=300Nx=Ny=300, CFL=0.125CFL=0.125 and Nt=2000Nt=2000.

Figure 8 illustrates the behavior during the evolution of the wave packet. After the barrier, the expected interference pattern is formed. The location of the intensity peaks can be compared with the ones predicted by the Young interferometer, originally designed for electromagnetic waves Hecht (2012). According to Young, the intensity peaks are located at the angles given by the formula

dsinθ=mλ,m=0,±1,±2,.d\sin\theta=m\lambda,~~m=0,\pm 1,\pm 2,.... (21)

In our case, d=0.4d=0.4 and λ=0.16\lambda=0.16, thus the zero-th order peak should be at y=0y=0, the first order peak should be located at θ=±23.57o\theta=\pm 23.57{}^{o} and the second order peak at θ=±53.13o\theta=\pm 53.13{}^{o}. We measure the density at a screen located at the line x=0.4x=0.4, where the first and second order peaks would be centered at y=±0.1745y=\pm 0.1745 and y=±0.5333y=\pm 0.5333 respectively. From our simulations these peaks are centered at y=±0.18y=\pm 0.18 and y=±0.43y=\pm 0.43. The error between the prediction and our measurements are 3.1%3.1\% and 19.32%19.32\% respectively, that we attribute to both, the approximations of Young formula and the non-monochromatic nature of the Gaussian packet.

The appealing interference pattern seen in the third snapshot of Fig. 8 reminds again of the Quantum Safari Gamow (2012),Gamow and Edwards (1999). In one of the scenes described, a flock of gazelles grazed peacefully when a lioness suddenly appeared. The gazelles ran scared against a row of trees with two small gaps. After crossing the trees, the gazelles divided in columns each one headed directly against a group of hungry lionesses. The gazelles were actually behaving like the quantum particle of Fig. 8, and the lionesses where position in the intensity peaks of the interference pattern.

Refer to caption
Figure 8: Snapshots of the evolution of the Gaussian packet initially moving to the right and colliding against the potential barrier with two slits. Part of the packet is reflected and part of it goes through, creating an interference pattern. On the third snapshot, a screen detector is placed along the line x=0.4x=0.4. The density measured along such line is shown on the fourth figure that records the interference pattern, which reassembles that of Young interferometer.

Animations of the single and double slit problems are found at Gen .

IV.4 Reflection and Refraction

In this example we illustrate what happens when a wave packet collides against a finite height step potential in two dimensions:

V(x,y)={0x0,yDV0x>0,yD.V(x,y)=\left\{\begin{array}[]{ll}0&x\leq 0,~y\in D\\ &\\ V_{0}&x>0,~y\in D\end{array}\right.. (22)

This setting is just like the case when light changes from one medium to another, in the quantum case, particle-waves get reflected and refracted when they face a step potential. For a plane monochromatic wave, the laws that rule this phenomenon are the reflection and refraction laws:

θi\displaystyle\theta_{i} =\displaystyle= θr,\displaystyle\theta_{r},
ksinθi\displaystyle k\sin\theta_{i} =\displaystyle= k2k02sinθt,\displaystyle\sqrt{k^{2}-k_{0}^{2}}\sin\theta_{t}, (23)

where θi\theta_{i}, θr\theta_{r} and θt\theta_{t} are the angles of incidence, reflection and transmission, considering the same conventions used in optics Hecht (2012); kk is the wave number and k02=2mV0/2k_{0}^{2}=2mV_{0}/\hbar^{2} or 2V02V_{0} in code units. One very interesting fact is that a classical particle that goes through the same potential follows the refraction law when its horizontal velocity is greater or equal to 2V0\sqrt{2V_{0}}; and follows the reflection law when the horizontal velocity is not big enough.

Refer to caption
Figure 9: Evolution of a Gaussian wave packet moving with oblique incidence against the step potential (22). In this case, k=15πk=15\pi, V0=750V_{0}=750 and θi=34o\theta_{i}=34{}^{o}. The numerically calculated reflection and transmission angles are: θr=38.93o\theta_{r}=38.93{}^{o} and θt=52.13o\theta_{t}=52.13{}^{o}. The dashed paths are the trajectories followed by the expectation value x(t)\langle\vec{x}\rangle(t) of the initial and the two resulting pulses, reason why they are not quite straight lines.

In Fig. 9 appears the density of a Gaussian wave packet initially located at (0.6,1.2)(-0.6,-1.2) with momentum p0=15π||\vec{p_{0}}||=15\pi heading towards the potential step with an incidence angle of 34o34{}^{o}. In the second snapshot, the wave packet hits the interface and interferes with itself. In the third snapshot the packet splits into two as the result of the interaction with the step: one bump reflected and another one refracted. Notice that the black dashed line indicates the trajectory of x(t)\langle\vec{x}\rangle(t) of the packet prior to the collision. Finally, in the last snapshot, we indicate with red and blue dashed lines the trajectory that x(t)\langle\vec{x}\rangle(t) follows for each of the two wave packets. From these expectation values, we find that the reflection and transmission angles are approximately θr=38.93º\theta_{r}=38.93\textordmasculine and θt=52.13º\theta_{t}=52.13\textordmasculine respectively. A classical particle, as well as a monochromatic wave, would refract with an angle of 80o80{}^{o}. We can see that the value obtained numerically doesn’t match the theoretical one very well. This is because the refraction angle depends on the wave number, not only on θi\theta_{i}. Since the wave packet is a sum of plane waves with different momentum, each of the plane waves refracts at a different angle, changing the shape of the packet and the refraction angle of x\langle\vec{x}\rangle.

The domain parameters used for this simulations are x[2,2]x\in[-2,2], y[2,2]y\in[-2,2], Nx=Ny=400Nx=Ny=400, CFL=0.125CFL=0.125 and Nt=3900Nt=3900, and the initial conditions are set to x0=0.6ı^1.2ȷ^\vec{x}_{0}=-0.6\hat{\textbf{\i }}-1.2\hat{\textbf{\j }}, p0=15π(cos(34o)ı^+sin(34o)ȷ^)\vec{p}_{0}=15\pi(\cos(34{}^{o})\hat{\textbf{\i }}+\sin(34^{o})\hat{\textbf{\j }}), packet width a=0.15a=0.15 and V0=750V_{0}=750.

siddh

IV.5 Dispersion by a central potential

As a final example, we look at a case of dispersion by a central potential. In this experiment, a particle (or wave packet) is directed against a potential that is spherically symmetric. One not so obvious assumption that is made by Cohen-Tannoudji et al. (1977) for the treatment of this problem, is that after the plane wave interacts with the potential, the wave function becomes the sum of a plane wave that goes through and a spherical wave front with nonuniform amplitude. The objective of this section is to show numerically that the outgoing wave function truly has a spherical component.

We threat the two dimensional case, with potential and initial conditions as follows:

V(x,y)\displaystyle V(x,y) =\displaystyle= V0e(x2+y2)/2σ2,\displaystyle V_{0}e^{-(x^{2}+y^{2})/2\sigma^{2}},
ψ(x,y,0)\displaystyle\psi(x,y,0) =\displaystyle= 2πa2eip0xe((xx0)2+y2)/a2.\displaystyle\sqrt{\frac{2}{\pi a^{2}}}e^{{\rm i}p_{0}x}e^{-((x-x_{0})^{2}+y^{2})/a^{2}}. (24)
Refer to caption
Figure 10: Evolution of a Gaussian wave packet directed against the origin of the central potential of equation (24). In this case p0=5πp_{0}=5\pi, V0=120V_{0}=120 and a=0.15a=0.15. After the interaction with the potential, the wave function appears to have a circular wave front. In the last two snapshots, the black spot grows in size in all directions. A map of the probability current vector field is on top. The current emerges radially from the center, suggesting a circular but nonuniform wavefront.

In Fig. 10, one can see the outcome of the interaction between the wave packet and the central potential, which in this case is repulsive. The packet starts moving to the right, but as it approaches the origin it slows down and deforms to avoid the potential peak. The particle then becomes a blur that starts spreading in all directions. In the last two snapshots, the probability current is mapped on top of ρ\rho. The vector field looks almost radial, evidence of the particle spreading in all directions as predicted Cohen-Tannoudji et al. (1977).

The domain parameters used for this simulations were: x[1.5,1.5]x\in[-1.5,1.5], y[1.5,1.5]y\in[-1.5,1.5], Nx=Ny=300Nx=Ny=300, CFL=0.125CFL=0.125 and Nt=3900Nt=3900, and initial conditions x0=0.7x_{0}=-0.7, p0=5πp_{0}=5\pi, a=0.15a=0.15, V0=120V_{0}=120 and σ=0.3\sigma=0.3.

V Final comments

We have solved the time dependent Schrödinger equation using numerical methods in scenarios involved with the wake-particle duality.

We expect these examples help illustrating the robustness of Schrödinger equation solutions in the wave and particle interpretation of elementary Quantum Mechanics. More detailed pictures and animations corresponding to the examples described in this paper are available at Gen , which can be useful for teaching purposes. Finally, we want to stress that also for educational purposes, the codes needed for the reproduction of these results can be available under request.

Acknowledgments

This work is supported by grant CIC-UMSNH-4.9.

References

  • (1) “Time-dependent schroedinger equation,” https://servicio-social.gitbook.io/computational-physics/time-dependent-schroedinger-equation.
  • Reyna-Munoz et al. (2024) D. M. Reyna-Munoz, M. A. Reyes,  and A. Fernandez Tellez, “On the quantum problem with harmonic, stark, coulombian and centrifugal barrier potential terms, and biconfluent heun functions,” Revista Mexicana de Física E’ 21, 010209 (2024).
  • Becerril et al. (2008) R. Becerril, F.S. Guzman, A. Rendon-Romero,  and S. Valdez-Alvarado, “Solving the time-dependent schroedinger equation using finite difference methods,” Revista Mexicana de Fisica E 54, 120–132 (2008).
  • Cohen-Tannoudji et al. (1977) C. Cohen-Tannoudji, B. Diu,  and F. Laloë, Quantum Mechanics, A Wiley - Interscience publication No. v. 1 (Wiley, 1977).
  • Guzmán (2023) F. S. Guzmán, Numerical Methods for Initial Value Problems in Physics, 1st ed. (Springer, 2023).
  • Press et al. (2007) William H. Press, Saul A. Teukolsky, William T. Vetterling,  and Brian P. Flannery, Numerical Recipes 3rd Edition: The Art of Scientific Computing, 3rd ed. (Cambridge University Press, 2007).
  • Gamow (2012) George Gamow, El Nuevo Breviario Del Señor Tompkins, 2nd ed. (Fondo de Cultura Económica, 2012).
  • Gamow and Edwards (1999) George Gamow and Michael Edwards, The New World of Mr Tompkins: George Gamow, edited by Stannard RussellEditor (Cambridge University Press, 1999).
  • Hecht (2012) E. Hecht, Optics (Pearson, 2012).