Photonic crystal waveguide polarization filter

Photonic crystal waveguide polarization filter#

Polarization control is one of the central themes in integrated silicon photonics. Different polarization modes not only allow for more information-carrying channels but also enable a wide range of applications given their different characteristics. For example, waveguide TE modes usually have better confinement and thus they are less prone to sidewall roughness. TM modes, on the other hand, have a larger penetration depth into the top and bottom claddings, which makes them suitable for sensing applications. As a result, integrated silicon photonic filters that selectively transmit or block certain polarization are very useful.

This notebook demonstrates the modeling of a compact TM-pass polarization filter based on photonic crystal waveguide. The photonic crystal is an air-bridged silicon slab with periodic air holes arranged in a triangular lattice. It is possible to achieve a TM-pass but TE-block device within a frequency range by utilizing bandgap engineering and index guiding mechanism. The design parameters adopted from Chandra Prakash and Mrinal Sen , β€œOptimization of silicon-photonic crystal (PhC) waveguide for a compact and high extinction ratio TM-pass polarization filter”, Journal of Applied Physics 127, 023101 (2020) are optimized for the telecom frequency to have a ~-0.5 dB TM transmission and ~-40 dB TE transmission.

Schematic of the polarization filter

For more integrated photonic examples such as the 8-Channel mode and polarization de-multiplexer, the broadband bi-level taper polarization rotator-splitter, and the broadband directional coupler, please visit our examples page. If you are new to the finite-difference time-domain (FDTD) method, we highly recommend going through our FDTD101 tutorials. FDTD simulations can diverge due to various reasons. If you run into any simulation divergence issues, please follow the steps outlined in our troubleshooting guide to resolve it.

[1]:
import numpy as np
import matplotlib.pyplot as plt

import tidy3d as td
import tidy3d.web as web
from tidy3d.plugins.mode import ModeSolver
from tidy3d.plugins.mode.web import run as run_ms

Simulation Setup#

This device is designed to work in a wide frequency range from 1480 nm to 1620 nm.

[2]:
lda0 = 1.55  # central wavelength
freq0 = td.C_0 / lda0  # central frequency
ldas = np.linspace(1.48, 1.62, 100)  # wavelength range of interest
freqs = td.C_0 / ldas  # frequency range of interest

Since the photonic crystal slab is air-bridged, we only need to define two materials: silicon and air. The frequency dispersion of the silicon refractive index in the frequency range of interest is quite small. Therefore, in this notebook, we model it as non-dispersive and lossless.

[3]:
n_si = 3.47  # silicon refractive index
si = td.Medium(permittivity=n_si**2)

n_air = 1  # air refractive index
air = td.Medium(permittivity=n_air)

For the photonic crystal to work as a filter, the geometric parameters need to be carefully chosen such that bandgap lies within the frequency range of interest. The design process would require the calculation of band structures. In this notebook, we will skip the band structure calculation and only model the optimized device. For band diagram simulation, refer to the photonic crystal slab band structure calculation notebook.

Define the geometric parameters for the photonic crystal as well as the input and output straight waveguides.

[4]:
a = 0.42  # lattice constant
t = 0.75 * a  # slab thickness
r = 0.3 * a  # radius of air holes
w = 0.73 * a  # width of the photonic crystal waveguide section

N_holes = 11  # number of holes in each row
N_rows = 7  # number of rows of holes on each side of the waveguide
L = N_holes * a  # length of the photonic crystal waveguide

D = 0.4  # width of the input and output waveguides

inf_eff = 1e3  # effective infinity of the model

To build the device, we define the silicon slab, input and output straight waveguides, and air holes. The air holes are systematically defined using a nested for loop. Due to the mirror symmetry of the device with respect to the \(xz\) plane, We only define the air holes in \(y>0\). Later, we will define the symmetry condition in the simulation.

[5]:
# define the silicon slab
si_slab = td.Box.from_bounds(
        rmin=(-L / 2, -N_rows * np.sqrt(3) * a / 2 - w / 2, 0),
        rmax=(L / 2, N_rows * np.sqrt(3) * a / 2 + w / 2, t),
    )

# define the input and output straight waveguides
si_wg = td.Box.from_bounds(
        rmin=(-inf_eff, -D / 2, 0),
        rmax=(inf_eff, D / 2, t),
    )

# get the union with both silicon geometries
phc_geometry = si_slab + si_wg

# group all air holes
holes = []
for i in range(N_rows):
    if i % 2 == 0:
        shift = a / 2
        N = N_holes
    else:
        shift = 0
        N = N_holes + 1

    for j in range(N):
        holes.append(
            td.Cylinder(
                center=(
                    (j - (N_holes) / 2) * a + shift,
                    (w / 2 + r) + (i) * np.sqrt(3) * a / 2,
                    t / 2,
                ),
                radius=r,
                length=t,
            )
        )

# remove holes from the si geometry

phc_geometry -= sum(holes)

phc_structure = td.Structure(geometry=phc_geometry, medium=si)

A ModeSouce is defined at the input waveguide to launch either the fundamental TE or TM mode. A FluxMonitor is defined at the output waveguide to measure the transmission. In addition, we define a FieldMonitor to visualize the field propagation and scattering in the \(xy\) plane.

[6]:
# simulation domain size
Lx = 1.5 * L
Ly = 2 * N_rows * a + lda0
Lz = 7 * t
sim_size = (Lx, Ly, Lz)

# define a mode source at the input waveguide
fwidth = 0.5 * (np.max(freqs) - np.min(freqs))
mode_spec = td.ModeSpec(num_modes=1, target_neff=n_si)
mode_source = td.ModeSource(
    center=(-Lx / 2 + lda0 / 2, 0, t / 2),
    size=(0, 4 * D, 5 * t),
    source_time=td.GaussianPulse(freq0=freq0, fwidth=fwidth),
    direction="+",
    mode_spec=mode_spec,
    mode_index=0,
)

# define a flux monitor at the output waveguide
flux_monitor = td.FluxMonitor(
    center=(Lx / 2 - lda0 / 2, 0, t / 2),
    size=mode_source.size,
    freqs=freqs,
    name="flux",
)

# define a field monitor in the xy plane
field_monitor = td.FieldMonitor(
    center=(0, 0, t / 2),
    size=(td.inf, td.inf, 0),
    freqs=[freq0],
    name="field",
)

[15:15:32] WARNING: Default value for the field monitor           monitor.py:261
           'colocate' setting has changed to 'True' in Tidy3D                   
           2.4.0. All field components will be colocated to the                 
           grid boundaries. Set to 'False' to get the raw fields                
           on the Yee grid instead.                                             

For periodic structures, it is better the define a grid that is commensurate with the periodicity. Therefore, we use UniformGrid in the \(x\) and \(y\) directions. In the \(z\) direction, a nonuniform grid can be used.

[7]:
# define grids
steps_per_unit_cell = 20
grid_spec = td.GridSpec(
    grid_x=td.UniformGrid(dl=a / steps_per_unit_cell),
    grid_y=td.UniformGrid(dl=a / steps_per_unit_cell * np.sqrt(3) / 2),
    grid_z=td.AutoGrid(min_steps_per_wvl=steps_per_unit_cell),
)

Since the TE and TM modes share different symmetry with respect to the \(xz\) plane, we can selectively launch them by setting the appropriate symmetry condition. The simulation for TE incidence is done by setting the symmetry condition to (0,-1,0) while the TM incidence corresponds to (0,1,0).

For this simulation, we set a relatively long run time of 20 ps to ensure the field decays sufficiently such that the simulation result is accurate.

[8]:
# define the te incidence simulation
run_time = 2e-11  # simulation run time

sim_te = td.Simulation(
    center=(0, 0, 0),
    size=sim_size,
    grid_spec=grid_spec,
    structures=[phc_structure],
    sources=[mode_source],
    monitors=[flux_monitor, field_monitor],
    run_time=run_time,
    boundary_spec=td.BoundarySpec.all_sides(boundary=td.PML()),
    symmetry=(0, -1, 0),
    medium=air,
)

To quickly check if the structures, source, and monitors are correctly defined, use the plot method to visualize the simulation.

[9]:
sim_te.plot(z=t / 2)
plt.show()

../_images/notebooks_PhotonicCrystalWaveguidePolarizationFilter_19_0.png

To further investigate the grids, we overlay the grid on top of the structures and zoom in on a small area. The grid looks sufficiently fine.

[10]:
fig, ax = plt.subplots()
sim_te.plot(z=t / 2, ax=ax)
sim_te.plot_grid(z=t / 2, ax=ax)
ax.set_xlim(-0.5, 0.5)
ax.set_ylim(0, 1)
plt.show()

../_images/notebooks_PhotonicCrystalWaveguidePolarizationFilter_21_0.png

Lastly, we use the ModeSolver plugin to visualize the mode profile launched by the mode source. The mode field confirms that we are launching the fundamental TE mode at the input waveguide.

[11]:
# define mode solver
mode_solver = ModeSolver(
    simulation=sim_te,
    plane=td.Box(center=mode_source.center, size=mode_source.size),
    mode_spec=mode_spec,
    freqs=[freq0],
)
mode_data = run_ms(mode_solver)

# visualize mode fields
f, (ax1, ax2, ax3) = plt.subplots(1, 3, tight_layout=True, figsize=(10, 3))
abs(mode_data.Ex.isel(mode_index=0)).plot(x="y", y="z", ax=ax1, cmap="magma")
abs(mode_data.Ey.isel(mode_index=0)).plot(x="y", y="z", ax=ax2, cmap="magma")
abs(mode_data.Ez.isel(mode_index=0)).plot(x="y", y="z", ax=ax3, cmap="magma")

ax1.set_title("|Ex(x, y)|")
ax1.set_aspect("equal")
ax2.set_title("|Ey(x, y)|")
ax2.set_aspect("equal")
ax3.set_title("|Ez(x, y)|")
ax3.set_aspect("equal")
plt.show()

[15:15:33] Mode solver created with                                    web.py:80
           task_id='fdve-b6495524-ed64-4e68-8763-3d614ee04460v1',               
           solver_id='mo-3de831e1-776f-4abe-bc44-4ef655acbe2b'.                 
[15:15:35] Mode solver status: queued                                  web.py:93
[15:15:39] Mode solver status: running                                 web.py:93
[15:15:51] Mode solver status: success                                web.py:103
../_images/notebooks_PhotonicCrystalWaveguidePolarizationFilter_23_13.png

The TM incidence simulation can be made simply by copying the TE simulation while updating the symmetry condition to (0,1,0). Then a simulation batch consisting of both simulations is defined. This way, both simulations will be running in parallel on the server, which will substantially save the total simulation time.

[12]:
# copy the te simulation to make the tm simulation
sim_tm = sim_te.copy(update={"symmetry": (0, 1, 0)})

# define simulation batch
sims = {"TE": sim_te, "TM": sim_tm}

Submit the simulation batch to the server.

[13]:
batch = web.Batch(simulations=sims, verbose=True)
batch_results = batch.run(path_dir="data")

[15:15:52] Created task 'TE' with task_id                          webapi.py:188
           'fdve-c1d741a1-81e8-477e-b272-86ac7cee9e58v1'.                       
           Created task 'TM' with task_id                          webapi.py:188
           'fdve-f796df4e-ec07-42f2-ba48-f1237108e7ecv1'.                       
[15:15:58] Started working on Batch.                            container.py:475
[15:16:26] Maximum FlexCredit cost: 1.745 for the whole batch.  container.py:479
           Use 'Batch.real_cost()' to get the billed FlexCredit                 
           cost after the Batch has completed.                                  
[15:21:14] Batch complete.                                      container.py:522

Postprocessing and Result Visualization#

After the batch of simulations is complete, we first visualize the field intensity distributions in both cases. As expected, the TE mode is blocked and the TM mode transmits through the photonic crystal region.

[14]:
# get individual simulation data from batch result
sim_data_te = batch_results["TE"]
sim_data_tm = batch_results["TM"]

# plot the field intensities in the te and tm cases
fig, (ax1, ax2) = plt.subplots(1, 2, tight_layout=True, figsize=(9, 4))
sim_data_te.plot_field(
    field_monitor_name="field", field_name="E", val="abs^2", ax=ax1, vmin=0, vmax=4000
)
sim_data_tm.plot_field(
    field_monitor_name="field", field_name="E", val="abs^2", ax=ax2, vmin=0, vmax=4000
)
plt.show()

[15:21:21] loading SimulationData from                             webapi.py:590
           data/fdve-c1d741a1-81e8-477e-b272-86ac7cee9e58v1.hdf5                
           loading SimulationData from                             webapi.py:590
           data/fdve-f796df4e-ec07-42f2-ba48-f1237108e7ecv1.hdf5                
../_images/notebooks_PhotonicCrystalWaveguidePolarizationFilter_30_8.png

To quantify the filter performance, we plot the transmission in both simulations. The result shows a good transmission (about -0.5 dB) for the TM mode and a low transmission (about -40 dB) for the TE mode. That is, the designed filter functions well while being very compact in size.

[15]:
T_te = sim_data_te["flux"].flux
T_tm = sim_data_tm["flux"].flux

# plot the transmissions in the te and tm cases
plt.plot(ldas, 10 * np.log10(T_te), label="TE")
plt.plot(ldas, 10 * np.log10(T_tm), label="TM")
plt.xlim(1.48, 1.62)
plt.ylim(-50, 0)
plt.xlabel("Wavelength ($\mu m$)")
plt.ylabel("Transmission (dB)")
plt.legend()
plt.show()

../_images/notebooks_PhotonicCrystalWaveguidePolarizationFilter_32_0.png
[ ]: