A Practical Guide to Scanning and Transmission Electron Microscopy Simulations

Electron Scattering Algorithms

Numerical Solutions of the Schrödinger Equation

As discussed in Bound Systems: The Schrödinger Equation, the Schrödinger equation typically cannot be solved analytically in complex systems. Therefore, in order to perform electron scattering simulations, we must calculate numerical solutions of Equation (1.3) for electron waves. First, we define the De Broglie (1925) wavelength of a free electrons (corrected for relativistic effects) as

λ=hceE0(2mc2+eE0),\lambda = \frac{h \, c}{\sqrt{e \, E_0 (2 \, m \, c^2 + e \, E_0)}},

where hh is the Plank constant, cc is the speed of light, ee is the electron charge, and E0E_0 is the accelerating voltage applied to the electron. Using SI units for (1.1) will give the wavelength in units of meters. In practice we typically use length units of for all calculations, and therefore multiple this result by 1010.

Next, we define the electron-potential interaction constant as (the numerical values of these constants can be found in  Unit conventions)

σ=2πmeλh2.\sigma = \frac{2 \pi \, m \, e \, \lambda}{h^2}.

In our simulations, we will assume the zz-position coordinate of the wavefunction ψ(r)\psi(\bm{r}) is alone sufficient to describe its propagation in both time and space. Starting from Equaton (1.3) and assuming steady-state conditions with V(r,t)=V(r)V(\bm{r}, t) = V(\bm{r}), we replace ψ(r,t)\psi(\bm{r}, t) with ψ(r)eiEt/\psi(\bm{r}) e^{-\ii E t / \hbar} and separate the time dependence. This gives the time-independent Schrödinger equation:

[22m2+eV(r)]ψ(r)=Eψ(r),\left[-\frac{\hbar^2}{2m} \nabla^2 + e V(\bm{r}) \right] \psi(\bm{r}) = E \psi(\bm{r}),

where V(r)V(\bm{r}) is the crystal potential, and EE is the total energy of the electron. Substituting λ\lambda and σ into the equation and rearranging in terms of the electron’s wavevector k0=1/λk_0 = 1/\lambda, we obtain:

[2+4π2k02]ψ(r)=4π2σV(r)ψ(r),\left[\nabla^2 + 4\pi^2 k_0^2\right] \psi(\bm{r}) = -4\pi^2 \sigma V(\bm{r}) \psi(\bm{r}),

This 3D time-independent Schrödinger equation serves as the foundation for deriving numerical electron scattering algorithms.

The Multislice Method

By a wide margin, the most common algorithm used for electron scattering simulations is the multislice method, first described by Cowley & Moodie (1957). In this method, we make two assumptions:

  • The 2/z2\partial^2 / \partial z^2 term in the Laplacian can be neglected, as the wavefunction’s variation along the zz-axis is much slower compared to its variation in the transverse (x,y)(x, y) directions.
  • The longitudinal wavevector k0k_0 is much larger than the contributions from transverse components of the wavefunction, i.e., k0xy2k_0 \gg |{\nabla_{xy}}^2|.

With these assumptions, we can substitute Equations (1.1) and (1.2) into Equation (1.4) to obtain Kirkland, 2020

zψ(r)=iλ4πxy2ψ(r)+iσV(r)ψ(r),\frac{\partial }{\partial z} \psi(\bm{r}) = \frac{\ii \lambda}{4 \pi} {\nabla_{xy}}^2 \psi(\bm{r}) + \ii \sigma V(\bm{r}) \psi(\bm{r}),

where xy2=2/x2+2/y2{\nabla_{xy}}^2 = \partial^2/\partial x^2 + \partial^2/\partial y^2.

Equation (1.5) shows the overall numerical recipe we will use; when the wavefunction ψ0(r)\psi_0(\bm{r}) is at position z0z_0, we will evaluate the operators on the right hand side over a distance Δz\Delta z to calculate the new wavefunction ψ(r)\psi(\bm{r}) at position z0+Δzz_0 + \Delta z. Kirkland (2020) gives the formal operator solution to (1.5) as

ψ(r)=exp{z0z0+Δz[iλ4πxy2+iσV(r)]dz}ψ0(r)\psi(\bm{r}) = \exp \left\{ \int_{z_0}^{z_0 + \Delta z} \left[ \frac{\ii \lambda}{4 \pi} {\nabla_{xy}}^2 + \ii \sigma V(\bm{r}) \right] dz \right\} \psi_0(\bm{r})

Assuming Δz\Delta z is small, (1.6) can be simplified to

ψ(r)=exp[iλ4πΔzxy2+iσVΔz(r)]ψ0(r),\psi(\bm{r}) = \exp\left[ \frac{\ii \lambda}{4 \pi} \Delta z {\nabla_{xy}}^2 + \ii \sigma V_{\Delta z}(\bm{r}) \right] \psi_0(\bm{r}),

where

VΔz(r)=z0z0+ΔzV(r)dz,V_{\Delta z}(\bm{r}) = \int_{z_0}^{z_0 + \Delta z} V(\bm{r}) dz,

is a thin slice of the potential as described in Equation or . Unfortunately, even with the above approximations, Equation (1.7) cannot be solved in closed form due to the two non-commuting operators. Instead, we solve it numerically by using a split-step method, where we alternate between solving each operator independently. The steps of the multislice method are detailed below.

Steps of the Multislice Method

1. Atomic Coordinates

We first generate a set of atomic coordinates for our desired sample. The atomic coordinates are placed in a simulation cell, a rectangular cuboid where all edges vectors are 9090^\circ apart. We assume the optic axis of the electron beam is along the zz axis. For each atom, we define the r=(x,y,z)\bm{r}=(x,y,z) position, the atomic number, a thermal vibration parameter, and sometimes the occupancy. Ideally the atomic coordinates will be periodic in the (x,y)(x,y) plane, though this is not always possible.

2. Potential Slices

Next, we calculate the potential V(r)V(\bm{r}) for the sample. We compute this potential numerically, either using the parameterization approach shown in or using a DFT calculation as described in . We divide the atomic potentials into slices, which are thin sections of the sample in the (x,y)(x,y) plane. Thinner slices will produce more accurate simulations, at the cost of longer computation times. Typical slice thicknesses for accurate simulations are 1--2 A˚\rm{\AA}, equal to roughly the atomic spacing of most solid materials.

When using isolated atomic potentials, we can either take the infinite projected potential which places the full scattering cross-section of each into a single slice, or perform numerical integration of a finite 3D projected potential which allows the potential of each atom to be spread into multiple adjacent slices.

We can also add additional electrostatic or electromagnetic fields to the potential slices. Electrostatic fields can be produced by electric fields across the sample or excess charges or holes, and will produce the same phase shifts as the atomic potentials, described by Equation (1.5). The effect of both extrinsic and intrinsic magnetic fields can be calculated using the Aharonov–Bohm equation.

3. Initial Wavefunctions

Next, we define the intitial condition of the electron beam wavefunction ψ(r)\psi(\bm{r}), described in Wave Aberrations. In an ideal plane wave TEM or diffraction pattern simulation, we use only a single initial wavefunction. We can also include spatial coherence in a TEM simulation by performing a multislice simulation where the initial probe is tilted to a range of incident probe angles, which are then summed incoherently to generate the simulation output. For a STEM simulation, we may need to calculate thousands or even millions of initial conditions for the electron probe, as each unique STEM probe position requires another simulation.

4. Transmission Operator

Following Kirkland (2020), if we assume a slice is infinitesimal thickness, we can set the xy2{\nabla_{xy}}^2 term from (1.7) to zero and obtain the solution

ψ(r)=ψ0(r)exp[iσVΔz(r)].\psi(\bm{r}) = \psi_0(\bm{r}) \exp[\ii \sigma V_{\Delta z}(\bm{r})].

We see from this expression that as the electron wavefuncton passes through a given slice, it will pick up a forward phase shift proportional to VΔz(r)V_{\Delta z}(\bm{r}). This first Born approximation is quite accurate for high accelerating voltages, for small-to-intermediate atomic number species, and for thin slices. However we may require a more accurate expansion and / or numerical slicing of individual atomic potentals when using very low accelerating voltages or for calculating scattering from high atomic number species.

5. Propagation Operator

Next, we need to propagate the electron wave from one slice to the next by using the propagation operator in Equation (1.7). We assume empty space between slices, setting V(r)=0V(\bm{r})=0 in (1.7) to get

ψ(r)=exp{iλΔz4πxy2}ψ0(r).\psi(\bm{r}) = \exp \left\{ \frac{\ii \lambda \Delta z}{4 \pi} {\nabla_{xy}}^2 \right\} \psi_0(\bm{r}).

Setting Λ=λΔz/4π\Lambda = \lambda \Delta z / 4 \pi and Taylor expanding this expression gives

ψ(r)=[m=0(iΛ)m2mψ0(r)x2m][n=0(iΛ)n2nψ0(r)y2n].\psi(\bm{r}) = \left[ \sum_{m=0}^\infty (\ii \Lambda)^m \frac{\partial^{2m} \psi_0(\bm{r})}{\partial x^{2m}} \right] \left[ \sum_{n=0}^\infty (\ii \Lambda)^n \frac{\partial^{2n} \psi_0(\bm{r})}{\partial y^{2n}} \right].

Taking the 2D Fourier transform Ψ(k)=Frk{ψ(r)}\Psi(\bm{k}) = \mathscr{F}_{\bm{r} \rightarrow \bm{k}}\{ \psi(\bm{r}) \} of both sides and using the fact that the x and y derivatives are orthogonal, we get

Ψ(k)=[m=0(iΛ)m(i2πkx)2m][n=0(iΛ)n(i2πky)2n]Ψ0(k)=[m=0(i4π2Λkx2)m][m=0(i4π2Λky2)m]Ψ0(k)=[m=0(iπλΔzkx2)m][m=0(iπλΔzky2)m]Ψ0(k)=exp(iπλΔzkx2)exp(iπλΔzky2)Ψ0(k).\begin{aligned} \Psi(\bm{k}) &= \left[ \sum_{m=0}^\infty (\ii \Lambda)^m (\ii 2 \pi k_x)^{2m} \right] \left[ \sum_{n=0}^\infty (\ii \Lambda)^n (\ii 2 \pi k_y)^{2n} \right] \Psi_0(\bm{k}) \\ &= \left[ \sum_{m=0}^\infty (-\ii 4 \pi^2 \Lambda {k_x}^2)^m \right] \left[ \sum_{m=0}^\infty (-\ii 4 \pi^2 \Lambda {k_y}^2)^m \right] \Psi_0(\bm{k}) \\ &= \left[ \sum_{m=0}^\infty (-\ii \pi \lambda \Delta z {k_x}^2)^m \right] \left[ \sum_{m=0}^\infty (-\ii \pi \lambda \Delta z {k_y}^2)^m \right] \Psi_0(\bm{k}) \\ &= \exp\left( -\ii \pi \lambda \Delta z {k_x}^2 \right) \exp\left( -\ii \pi \lambda \Delta z {k_y}^2 \right) \Psi_0(\bm{k}). \end{aligned}

We can now write the final propagation operator by combining kx2+ky2=k2{k_x}^2+{k_y}^2=|\bm{k}|^2 to get

Ψ(k)=exp(iπλΔzk2)Ψ0(k).\Psi(\bm{k}) = \exp\left( -\ii \pi \lambda \Delta z |\bm{k}|^2 \right) \Psi_0(\bm{k}).

If there are still remaining slices that the electron wave has not passed through, we alternate steps 4 and 5 until the prope wavefunction reaches the output surface of the sample, where it is referred to as the exit wave.

6. Transfer Function

After we have calculated the exit wave, we then need to apply the effects of our microscope optics to this wave and reach the detector plane by using a modulation transfer function (MTF). The MTF could be very simple; for example, in either a TEM diffraction simulation or a typical STEM simulation, we assume that the detector is placed at the far field limit and that therefore we only need to Fourier transform the exit wave to reach the detector plane.

For a TEM imaging simulation, we typically use a contrast transfer function (CTF) for the MTF. The CTF can include aplanatic optical aberrations such as defocus, spherical aberration, astigmatism, and higher order coherent wave aberrations. It can also include more complex optical affects such as field distortion, image rotation, or planatic aberrations, where the aberrations vary as a function of position. The CTF equations are described in Wave Aberrations.

7. Detector Functions

Finally, we convert from the complex wavefunction to a real-valued detector measurement. This intensity measurement may be performed in real space for near-field imaging giving I(r)I(\bm{r}), or in Fourier space for far-field diffraction space measurements giving I(k)I(\bm{k}). The measured intensity for a pixelated detector is just the magnitude squared of the wavefunction ψ(r)2|\psi(\bm{r})|^2 or ψ(k)2|\psi(\bm{k})|^2. To simulated an integrating detector intensity ID(k)I_D(\bm{k}), such as those for BF or DF STEM measurements, we apply a detector function D(k)D(\bm{k}) to our measured intensity using the expression

ID(R)=kψ(R,k)2D(k)dk,I_D(\bm{R}) = \int_{\bm{k}} |\psi(\bm{R},\bm{k})|^2 D(\bm{k}) d\bm{k},

where R\bm{R} is the position of the STEM probe, and D(k)D(\bm{k}) is usually an array of zeroes and ones defining the detector shape.

Because we’re performing a simulation, we do not need to used a fixed detector geometry. We could instead define variable detectors such as a set of concentric annular ring detectors with a spacing Δk\Delta k, using the expression

I(R,n)=nΔk(n+1)Δk12π02πψ(R,k)2dθdk,I(\bm{R},n) = \int_{n \Delta k}^{(n+1) \Delta k} \frac{1}{2 \pi} \int_0^{2 \pi} |\psi(\bm{R},\bm{k})|^2 d\theta dk',

where θ is the annular coordinate and kk' is the radial coordinate for k\bm{k}-space.

We will use the multislice method in the rest of this article, so you can proceed to Wave Aberrations, or read below for information on other simulation methods!

Bloch Wave Simulations

While the multislice method is widely used for electron scattering simulations due to its flexibility and scalability, the Bloch wave method provides an alternative approach that is especially efficient for small, periodic structures. The Bloch wave formalism leverages the translational symmetry of the crystal lattice to express the electron wavefunction as a sum of periodic Bloch states, significantly reducing computational effort for crystalline samples. This reduction in computational cost is possible because in a Bloch wave simulation, we only consider a small number of scattering vectors kk, or equivalently to a small number of scattering angles α=λk\alpha = \lambda k

The Bloch wave method is particularly advantageous for periodic systems, as it reduces the computational domain to a single unit cell and directly incorporates crystal symmetry. However, it is less suited for non-periodic systems or those with large-scale defects, where the multislice method is more appropriate. This approach requires careful numerical handling of eigenvalue decomposition and the summation over a sufficiently large number of reciprocal lattice vectors to ensure convergence.

Steps of the Bloch Wave Method

1. Bloch Wave Expansion

The electron wavefunction ψ(r)\psi(\bm{r}) inside a crystal can be expressed as a linear combination of Bloch waves, bj(kj,r)b_j(\bm{k}_j, \bm{r}), which satisfy the periodicity of the crystal potential:

ψ(r)=jαjbj(kj,r),\psi(\bm{r}) = \sum_j \alpha_j b_j(\bm{k}_j, \bm{r}),

where

bj(kj,r)=e2πikjrgcg,je2πigr,b_j(\bm{k}_j, \bm{r}) = e^{2\pi i \bm{k}_j \cdot \bm{r}} \sum_{\bm{g}} c_{\bm{g},j} e^{2\pi i \bm{g} \cdot \bm{r}},

where kj\bm{k}_j are the Bloch wavevectors, g\bm{g} are the reciprocal lattice vectors, cg,jc_{\bm{g},j} are coefficients describing the contribution of each plane wave to the Bloch wave. This expansion allows us to represent the electron wavefunction as a superposition of states that inherently respect the periodicity of the crystal.

2. Schrödinger Equation

We can rewrite Equation (1.4) as:

[2+4π2k02]ψ(r)=4π2σV(r)ψ(r),\left[\nabla^2 + 4\pi^2 k_0^2\right] \psi(\bm{r}) = -4\pi^2 \sigma V(\bm{r}) \psi(\bm{r}),

where we approximate the second zz-derivative term for high-energy electrons using 2z2(2π/λ)2\frac{\partial^2}{\partial z^2} \approx -(2\pi/\lambda)^2. This approximation assumes the electron wavefunction is dominated by a plane wave propagating along zz with wavevector k0=1/λk_0 = 1 / \lambda.

To separate the rapidly oscillating component of the wavefunction, we use the substitution ψ(r)=exp(2πik0z)ϕ(r)\psi(\bm{r}) = \exp(2\pi i k_0 z) \phi(\bm{r}), where ϕ(r)\phi(\bm{r}) represents a slowly varying envelope function. Substituting into the equation yields:

[22m2+eV(r)]ϕ(r)=Eϕ(r),\left[-\frac{\hbar^2}{2m} \nabla^2 + eV(\bm{r})\right] \phi(\bm{r}) = E \phi(\bm{r}),

where E=2k02/2mE = \hbar^2 k_0^2 / 2m is the total energy of the electron. This time-independent Schrödinger equation now describes the interaction of the electron wave with the crystal potential V(r)V(\bm{r}) in all spatial directions. To account for the periodicity of the crystal lattice, we expand ϕ(r)\phi(\bm{r}) as a sum of Bloch waves:

ϕ(r)=gcg,je2πigr,\phi(\bm{r}) = \sum_{\bm{g}} c_{\bm{g},j} e^{2\pi i \bm{g} \cdot \bm{r}},

where g\bm{g} are reciprocal lattice vectors, and cg,jc_{\bm{g},j} are the coefficients of the expansion. Similarly, the crystal potential is expressed as a Fourier series:

V(r)=gVge2πigr.V(\bm{r}) = \sum_{\bm{g}} V_{\bm{g}} e^{2\pi i \bm{g} \cdot \bm{r}}.

Substituting these expansions into the Schrödinger equation results in a set of coupled equations for the plane wave coefficients cg,jc_{\bm{g},j}, which form the basis for Bloch wave simulations.

3. Eigenvalue Problem

Inserting the expansions into the Schrödinger equation yields:

g(k02kj+g2)cg,je2πi(kj+g)r=g,hVghCh,je2πi(kj+g)r.\sum_{\bm{g}} \left(k_0^2 - |\bm{k}_j + \bm{g}|^2\right) c_{\bm{g},j} e^{2\pi i (\bm{k}_j + \bm{g}) \cdot \bm{r}} = -\sum_{\bm{g},\bm{h}} V_{\bm{g} - \bm{h}} C_{\bm{h},j} e^{2\pi i (\bm{k}_j + \bm{g}) \cdot \bm{r}}.

By matching coefficients of exp2πi(kj+g)r\exp^{2\pi i (\bm{k}_j + \bm{g}) \cdot \bm{r}}, we obtain the eigenvalue equation:

[2k0sg2γjk0,z]cg,j+hgVghCh,j=0,\left[2k_0 s_{\bm{g}} - 2\gamma_j k_{0,z}\right] c_{\bm{g},j} + \sum_{\bm{h} \neq \bm{g}} V_{\bm{g} - \bm{h}} C_{\bm{h},j} = 0,

where sg=(k02k0+g2)/2k0s_{\bm{g}} = (k_0^2 - |\bm{k}_0 + \bm{g}|^2) / 2k_0 is the excitation error. We solve this set of linear equations to find the eigenvalues 2γjk0,z2\gamma_j k_{0,z} and eigenvectors cg,jc_{\bm{g},j}, representing the Bloch wave propagation constants and coefficients.

4. Bloch Wave Propagation

The wavefunction ψ(r)\psi(\bm{r}) at depth zz is expressed as:

ψ(r)=gψg(z)e2πi(k0+g)r,\psi(\bm{r}) = \sum_{\bm{g}} \psi_{\bm{g}}(z) e^{2\pi i (\bm{k}_0 + \bm{g}) \cdot \bm{r}},

where ψg(z)\psi_{\bm{g}}(z) propagates according to:

ψg(z)=jαjcg,je2πiγjz.\psi_{\bm{g}}(z) = \sum_j \alpha_j c_{\bm{g},j} e^{2\pi i \gamma_j z}.

The propagation constants γj\gamma_j determine how each Bloch wave evolves through the crystal.

5. Input Wavefunction

At the entrance surface (z=0z=0), the wavefunction at the entrance surface of the crystal ψg(0)\psi_{\bm{g}}(0) is matched to the incident wavefunction just outside of the crystal ψ0(r)\psi_0(\bm{r}),

ψ0(r)=gψg(0)e2πigr,\psi_0(\bm{r}) = \sum_{\bm{g}} \psi_{\bm{g}}(0) e^{2\pi i \bm{g} \cdot \bm{r}},

where ψg(0)\psi_{\bm{g}}(0) represents the Fourier components of the input wavefunction. These Fourier components serve as the basis for expanding ψ0(r)\psi_0(\bm{r}) in terms of Bloch waves.

The expansion of ψ0(r)\psi_0(\bm{r}) into Bloch waves is achieved by determining the weighting coefficients αj\alpha_j, which describe the contribution of each Bloch wave bj(r)b_j(\bm{r}) to the input wavefunction. By solving:

αj=gcg,jψg(0),\alpha_j = \sum_{\bm{g}} c_{\bm{g},j}^* \psi_{\bm{g}}(0),

we relate the Bloch wave expansion coefficients αj\alpha_j to the plane wave coefficients ψg(0)\psi_{\bm{g}}(0) of the input wavefunction and the coupling coefficients cg,jc_{\bm{g},j}, which describe the relationship between the plane wave and Bloch wave bases.

6. Output Wavefunction

At the exit surface (z=zmaxz = z_{\text{max}}, corresponding to the crystal thickness tt), the real-space wavefunction ψ(r)\psi(\bm{r}) is expressed using the Bloch wave expansion. The wavefunction is given by:

ψ(r)=jαj(gcg,je2πigr)e2πiγjt.\psi(\bm{r}) = \sum_{j} \alpha_j \left( \sum_{\bm{g}} c_{\bm{g},j} e^{2\pi i \bm{g} \cdot \bm{r}} \right) e^{2\pi i \gamma_j t}.

where αj\alpha_j are the weighting coefficients determined by the input wavefunction, and cg,jc_{\bm{g},j} are the Bloch wave coefficients that describe the periodic components of the wavefunction. The plane waves e2πigre^{2\pi i \bm{g} \cdot \bm{r}} correspond to reciprocal lattice vectors g\bm{g}, following the lattice periodicity. The term e2πiγjte^{2\pi i \gamma_j t} accounts for the propagation of each Bloch wave through the crystal thickness tt, with γj\gamma_j representing the eigenvalues that describe the wavevector components along zz.

Note in particular how the thickness tt modulates the contribution of each Bloch wave to the final wavefunction at the exit surface, and how the Bloch wave method can be used to quickly compute output wavefunctions for multiple crystal thicknesses.

References
  1. De Broglie, L. (1925). Recherches sur la théorie des quanta, Paris, 1924 (thèse de physique). Ann. de Physique, 3, 10–22.
  2. Cowley, J. M., & Moodie, A. F. (1957). The scattering of electrons by atoms and crystals. I. A new theoretical approach. Acta Crystallographica, 10(10), 609–619.
  3. Kirkland, E. J. (2020). Advanced Computing in Electron Microscopy, Third Edition. Springer Science & Business Media.