Mode analysis for a half-loaded rectangular waveguide
Contents
Mode analysis for a half-loaded rectangular waveguide#
Copyright © 2022 Michele Castriotta, Igor Baratta, Jørgen S. Dokken
This demo is implemented in one file, which shows how to:
Setup an eigenvalue problem for Maxwell’s equations
Use SLEPc for solving eigenvalue problems in DOLFINx
Equations, problem definition and implementation#
In this demo, we are going to show how to solve the eigenvalue problem associated with a half-loaded rectangular waveguide with perfect electric conducting walls.
First of all, let’s import the modules we need for solving the problem:
import numpy as np
from slepc4py import SLEPc
from analytical_modes import verify_mode
from dolfinx import fem, io
from dolfinx.mesh import (CellType, create_rectangle, exterior_facet_indices,
locate_entities)
from ufl import (FiniteElement, MixedElement, TestFunctions, TrialFunctions,
curl, dx, grad, inner)
from mpi4py import MPI
from petsc4py.PETSc import ScalarType
Let’s now define our domain. It is a rectangular domain with width \(w\) and height \(h = 0.45w\), with the dielectric medium filling the lower-half of the domain, with a height of \(d=0.5h\).
w = 1
h = 0.45 * w
d = 0.5 * h
nx = 300
ny = int(0.4 * nx)
domain = create_rectangle(MPI.COMM_WORLD, np.array(
[[0, 0], [w, h]]), np.array([nx, ny]), CellType.quadrilateral)
domain.topology.create_connectivity(
domain.topology.dim - 1, domain.topology.dim)
Now we can define the dielectric permittivity \(\varepsilon_r\) over the domain as \(\varepsilon_r = \varepsilon_v = 1\) in the vacuum, and as \(\varepsilon_r = \varepsilon_d = 2.45\) in the dielectric:
eps_v = 1
eps_d = 2.45
def Omega_d(x):
return x[1] <= d
def Omega_v(x):
return x[1] >= d
D = fem.FunctionSpace(domain, ("DQ", 0))
eps = fem.Function(D)
cells_v = locate_entities(domain, domain.topology.dim, Omega_v)
cells_d = locate_entities(domain, domain.topology.dim, Omega_d)
eps.x.array[cells_d] = np.full_like(cells_d, eps_d, dtype=ScalarType)
eps.x.array[cells_v] = np.full_like(cells_v, eps_v, dtype=ScalarType)
In order to find the weak form of our problem, the starting point are Maxwell’s equation and the perfect electric conductor condition on the waveguide wall:
with \(k_0\) and \(\lambda_0 = 2\pi/k_0\) being the wavevector and the wavelength, that we consider fixed at \(\lambda = h/0.2\). If we focus on non-magnetic material only, we can consider \(\mu_r=1\).
Now we can assume a known dependence on \(z\):
where \(\mathbf{E}_t\) is the component of the electric field transverse to the waveguide axis, and \(E_z\) is the component of the electric field parallel to the waveguide axis, and \(k_z\) represents our complex propagation constant.
In order to pose the problem as an eigenvalue problem, we need to make the following substitution:
The final weak form can be written as:
Or, in a more compact form, as:
A problem of this kind is known as a generalized eigenvalue problem, where our eigenvalues are all the possible \( -k_z^2\). For further details about this problem, check Prof. Jin’s The Finite Element Method in Electromagnetics.
To write the weak form in DOLFINx, we need to specify our function space.
For the \(\mathbf{e}_t\) field, we can use RTCE elements (the equivalent of
Nedelec elements on quadrilateral cells), while for \(e_z\) field we can use
the Lagrange elements. In DOLFINx, this hybrid formulation is
implemented with MixedElement
:
degree = 1
RTCE = FiniteElement("RTCE", domain.ufl_cell(), degree)
Q = FiniteElement("Lagrange", domain.ufl_cell(), degree)
V = fem.FunctionSpace(domain, MixedElement(RTCE, Q))
Now we can define our weak form:
lmbd0 = h / 0.2
k0 = 2 * np.pi / lmbd0
et, ez = TrialFunctions(V)
vt, vz = TestFunctions(V)
a_tt = (inner(curl(et), curl(vt)) - k0
** 2 * eps * inner(et, vt)) * dx
b_tt = inner(et, vt) * dx
b_tz = inner(et, grad(vz)) * dx
b_zt = inner(grad(ez), vt) * dx
b_zz = (inner(grad(ez), grad(vz)) - k0
** 2 * eps * inner(ez, vz)) * dx
a = fem.form(a_tt)
b = fem.form(b_tt + b_tz + b_zt + b_zz)
Let’s add the perfect electric conductor conditions on the waveguide wall:
bc_facets = exterior_facet_indices(domain.topology)
bc_dofs = fem.locate_dofs_topological(V, domain.topology.dim - 1, bc_facets)
u_bc = fem.Function(V)
with u_bc.vector.localForm() as loc:
loc.set(0)
bc = fem.dirichletbc(u_bc, bc_dofs)
Now we can solve the problem with SLEPc. First of all, we need to assemble our \(A\) and \(B\) matrices with PETSc in this way:
A = fem.petsc.assemble_matrix(a, bcs=[bc])
A.assemble()
B = fem.petsc.assemble_matrix(b, bcs=[bc])
B.assemble()
Now, we need to create the eigenvalue problem in SLEPc. Our problem is a
linear eigenvalue problem, that in SLEPc is solved with the EPS
module.
We can call this module in the following way:
eps = SLEPc.EPS().create(domain.comm)
We can pass to the EPS
solver our matrices by using the setOperators
routine:
eps.setOperators(A, B)
If the matrices in the problem have known properties (e.g. hermiticity) we
can use this information in SLEPc to accelerate the calculation with the
setProblemType
function. For this problem, there is no property that can be
exploited, and therefore we define it as a generalized non-Hermitian
eigenvalue problem with the SLEPc.EPS.ProblemType.GNHEP
object:
eps.setProblemType(SLEPc.EPS.ProblemType.GNHEP)
# Next, we need to specify a tolerance for considering a solution
# acceptable:
tol = 1e-9
eps.setTolerances(tol=tol)
Now we need to set the eigensolver for our problem, which is the algorithm
we want to use to find the eigenvalues and the eigenvectors. SLEPc offers
different methods, and also wrappers to external libraries. Some of these
methods are only suitable for Hermitian or Generalized Hermitian problems
and/or for eigenvalues in a certain portion of the spectrum. However, the
choice of the method is a technical discussion that is out of the scope of
this demo, and that is more comprehensively discussed in the
SLEPc documentation.
For our problem, we will use the Krylov-Schur method, which we can set by
calling the setType
function:
eps.setType(SLEPc.EPS.Type.KRYLOVSCHUR)
In order to accelerate the calculation of our solutions,
we can also use spectral transformation, which maps the
original eigenvalues into another position of the spectrum
without affecting the eigenvectors. In our case,
we can use the shift-and-invert transformation with
the SLEPc.ST.Type.SINVERT
object:
# Get ST context from eps
st = eps.getST()
# Set shift-and-invert transformation
st.setType(SLEPc.ST.Type.SINVERT)
The spectral transformation needs a target value for the
eigenvalues we are looking at to perform the
spectral transformation. Since the eigenvalues for our
problem can be complex numbers, we need to specify
whether we are searching for specific values in the real part,
in the imaginary part, or in the magnitude. In our case, we are
interested in propagating modes, and therefore in real \(k_z\). For
this reason, we can specify with the setWhichEigenpairs
function
that our target value will refer to the real part of the eigenvalue,
with the SLEPc.EPS.Which.TARGET_REAL
object:
eps.setWhichEigenpairs(SLEPc.EPS.Which.TARGET_REAL)
For specifying the target value, we can use the setTarget
function.
Even though we cannot know a good target value a priori, we can guess
that \(k_z\) will be quite close to \(k_0\) in value, for instance
\(k_z = 0.5k_0^2\).
Therefore, we can set a target value of \(-(0.5k_0^2)\):
eps.setTarget(-(0.5 * k0)**2)
Then, we need to define the number of eigenvalues we want to calculate.
We can do this with the setDimensions
function, where we specify that
we are searching for just one eigenvalue:
eps.setDimensions(nev=1)
We can finally solve the problem with the solve
function.
To gain a deeper insight over the simulation, we can get an
output message by SLEPc by calling the view
and errorView
function:
eps.solve()
eps.view()
eps.errorView()
EPS Object: 1 MPI processes
type: krylovschur
50% of basis vectors kept after restart
using the locking variant
problem type: generalized non-hermitian eigenvalue problem
selected portion of the spectrum: closest to target: -1.94955 (along the real axis)
number of eigenvalues (nev): 1
number of column vectors (ncv): 16
maximum dimension of projected problem (mpd): 16
maximum number of iterations: 13605
tolerance: 1e-09
convergence test: relative to the eigenvalue
BV Object: 1 MPI processes
type: svec
17 columns of global length 108841
vector orthogonalization method: classical Gram-Schmidt
orthogonalization refinement: if needed (eta: 0.7071)
block orthogonalization method: GS
doing matmult as a single matrix-matrix product
DS Object: 1 MPI processes
type: nhep
ST Object: 1 MPI processes
type: sinvert
shift: -1.94955
number of matrices: 2
nonzero pattern of the matrices: UNKNOWN
KSP Object: (st_) 1 MPI processes
type: preonly
maximum iterations=10000, initial guess is zero
tolerances: relative=1e-08, absolute=1e-50, divergence=10000.
left preconditioning
using NONE norm type for convergence test
PC Object: (st_) 1 MPI processes
type: lu
out-of-place factorization
tolerance for zero pivot 2.22045e-14
matrix ordering: nd
factor fill ratio given 5., needed 7.72513
Factored matrix follows:
Mat Object: 1 MPI processes
type: seqaij
rows=108841, cols=108841
package used to perform factorization: petsc
total: nonzeros=13096891, allocated nonzeros=13096891
using I-node routines: found 86045 nodes, limit used is 5
linear system matrix = precond matrix:
Mat Object: (st_) 1 MPI processes
type: seqaij
rows=108841, cols=108841
total: nonzeros=1695361, allocated nonzeros=1695361
total number of mallocs used during MatSetValues calls=0
not using I-node routines
All requested eigenvalues computed up to the required tolerance:
-1.69240
Now we can get the eigenvalues and eigenvectors calculated by SLEPc:
# Save the eigenvalues i
vals = [(i, np.sqrt(-eps.getEigenvalue(i))) for i in range(eps.getConverged())]
vals.sort(key=lambda x: x[1].real)
eh = fem.Function(V)
kz_list = []
for i, kz in vals:
# Save eigenvector in eh
eps.getEigenpair(i, eh.vector)
# Compute error for i-th eigenvalue
error = eps.computeError(i, SLEPc.EPS.ErrorType.RELATIVE)
# Verify, save and visualize solution
if error < tol and np.isclose(kz.imag, 0, atol=tol):
kz_list.append(kz)
# Verify if kz satisfy the analytical equations for the modes
assert verify_mode(kz, w, h, d, lmbd0, eps_d, eps_v, threshold=1e-4)
print(f"eigenvalue: {-kz**2}")
print(f"kz: {kz}")
print(f"kz/k0: {kz/k0}")
eh.x.scatter_forward()
eth, ezh = eh.split()
# Transform eth, ezh into Et and Ez
eth.x.array[:] = eth.x.array[:] / kz
ezh.x.array[:] = ezh.x.array[:] * 1j
V_dg = fem.VectorFunctionSpace(domain, ("DQ", degree))
Et_dg = fem.Function(V_dg)
Et_dg.interpolate(eth)
with io.VTXWriter(domain.comm, f"sols/Et_{i}.bp", Et_dg) as f:
f.write(0.0)
with io.VTXWriter(domain.comm, f"sols/Ez_{i}.bp", ezh) as f:
f.write(0.0)
eigenvalue: (-1.6924040028257377-5.072606493549373e-15j)
kz: (1.3009242878913967+1.949616338461675e-15j)
kz/k0: (0.46585919476399434+6.981549241475188e-16j)