import numpy as np
import os
from solcore.structure import Layer
from solcore import material, si
from rayflare.structure import Interface, BulkLayer, Structure
from rayflare.matrix_formalism import process_structure, calculate_RAT, get_savepath
from rayflare.transfer_matrix_method import tmm_structure
from rayflare.angles import theta_summary, make_angle_vector
from rayflare.textures import regular_pyramids
from rayflare.options import default_options
import matplotlib.pyplot as plt
from sparse import load_npz
import seaborn as sns
import matplotlib as mpl
Example 6b: Angular redistribution matrix method
In Example 6a, we looked at a silicon heterojunction cell using integrated ray-tracing and TMM to calculate the optical behaviour of each surface, and using the angular redistribution matrix method (ARMM) to combine the surfaces and calculate overall reflection, transmission, absorption per layer and absorption profiles. However, ARMM is not limited to treating surfaces with ray-tracing; it is also possible to use the TMM by itself (for planar layers), RCWA (for gratings/periodic structutes) or ideal analytic cases (perfect mirrors and Lambertian reflectors are currently implemented) to generate the angular redistribution matrices. In this example we will replicate simulation results shown in the paper on OPTOS, looking at the effect of planar surfaces, regular pyramids, and a diffraction grating on absorption in a silicon wafer.
Setting up
We have encountered most of these options in the previous examples. Previously, we have mostly simulated optical behaviour for light at normal incidence but in this case, to match the results from the OPTOS paper, we will look at an incidence angle of 8\(^\circ\). Other relevant options are c_azimuth
, which controls how fine the spacing of the angular bins in the azimuthal directions is, and pol
, the polarization of the incident light.
= 8
angle_degrees_in
= np.linspace(900, 1180, 30)*1e-9
wavelengths
= material('Si')()
Si = material('Air')()
Air
= default_options()
options = wavelengths
options.wavelengths = angle_degrees_in*np.pi/180
options.theta_in = 50
options.n_theta_bins = 0.25
options.c_azimuth = 200000 # increase to reduce noise, decrease for faster execution
options.n_rays = 'compare_surfaces'
options.project_name = np.pi/2
options.phi_symmetry = 0.005
options.I_thresh = 5
options.nx = 5
options.ny = False options.bulk_profile
Structures and Interfaces
We will consider three structures:
- Planar front, crossed grating (Si/air) at rear
- Regular pyramids on the front, planar rear
- Regular pyramids on the front, crossed grating at rear.
This means we have four different surfaces to consider across all structures: a. Planar front b. Pyramidal front c. Planar rear d. Grating rear
For structure 1 (a + d), we define the grating (surface d) in the same we would if using rcwa_structure
(Example 5a). The grating period in this case is 1000 nm with a feature height of 120 nm.
= 1000
x
= ((x, 0),(0,x))
d_vectors = 0.36
area_fill_factor = np.sqrt(area_fill_factor)*500
hw
= []
front_materials = [Layer(si('120nm'), Si, geometry=[{'type': 'rectangle', 'mat': Air, 'center': (x/2, x/2),
back_materials 'halfwidths': (hw, hw), 'angle': 45}])]
Create the texture for the pyramidal front surface (b):
= regular_pyramids(elevation_angle=55, upright=False) surf
Now we define the four Interface
s we need for the three Structure
s; using the numbering above, that is:
- Structure 1 = a + d
- Structure 2 = b + c
- Structure 3 = b + d
For each Interface, we have to specify the method we want to use, a name, the surface layers (or lack therof). For the RT (ray-tracing) surfaces, we need to specify the texture
and for the RCWA surfaces we need to specify the unit cell lattice vectors d_vectors
and the number of rcwa_orders
to use. We also define the bulk, 200 \(\mu\)m of Si.
= Interface('RT_Fresnel', texture=surf, layers=[],
front_surf_pyramids = 'inv_pyramids_front_' + str(options['n_rays']))
name = Interface('TMM', layers=[], name='planar_front')
front_surf_planar = Interface('RCWA', layers=back_materials, name='crossed_grating_back',
back_surf_grating =d_vectors, rcwa_orders=15) # increase orders for betting convergence (calculation takes longer!)
d_vectors= Interface('TMM', layers=[], name = 'planar_back')
back_surf_planar
= BulkLayer(200e-6, Si, name = 'Si_bulk') # bulk thickness in m bulk_Si
Now we define the three structures listed above. For reference, we also define a fully planar structure (a + c).
= Structure([front_surf_planar, bulk_Si, back_surf_grating], incidence=Air, transmission=Air)
SC_fig6 = Structure([front_surf_pyramids, bulk_Si, back_surf_planar], incidence=Air, transmission=Air)
SC_fig7 = Structure([front_surf_pyramids, bulk_Si, back_surf_grating], incidence=Air, transmission=Air)
SC_fig8 = Structure([front_surf_planar, bulk_Si, back_surf_planar], incidence=Air, transmission=Air) planar
Now, as in Example 6a, we process the structures (to generate the matrices) and then use calculate_rat
to obtain the final results. Note that it is not necessary to call process_structure
for the planar structure, because the redistribution matrices for both of its interfaces will have already been calculated when considering structures 1 and 2.
# Process structures (step 1)
="current")
process_structure(SC_fig6, options, save_location="current")
process_structure(SC_fig7, options, save_location="current")
process_structure(SC_fig8, options, save_location
# Calculate RAT (step 2)
= calculate_RAT(SC_fig6, options, save_location="current")
results_fig6= calculate_RAT(SC_fig7, options, save_location="current")
results_fig7 = calculate_RAT(SC_fig8, options, save_location="current")
results_fig8 = calculate_RAT(planar, options, save_location="current")
results_planar
# Get RAT results
= results_fig6[0]
RAT_fig6 = results_fig7[0]
RAT_fig7 = results_fig8[0]
RAT_fig8
= results_planar[0] RAT_planar
Of course, it is not necessary to use the ARMM to calculate the optics of a simple planar slab of Si; we could have done this simply with an (incoherent) TMM calculation. We will do this to compare the results:
= tmm_structure([Layer(si('200um'), Si)], Air, Air)
struc = False
options.coherent = ['i']
options.coherency_list = tmm_structure.calculate(struc, options) RAT
Results
PLOT 1: Absorption in Si for the four different structures.
= sns.color_palette("hls", 4)
palhf
= plt.figure()
fig *1e9, RAT_fig6['A_bulk'][0], '-o', color=palhf[0], label='Rear grating', fillstyle='none')
plt.plot(wavelengths*1e9, RAT_fig7['A_bulk'][0], '-o', color=palhf[1], label= 'Front pyramids', fillstyle='none')
plt.plot(wavelengths*1e9, RAT_fig8['A_bulk'][0], '-o', color=palhf[2], label= 'Grating + pyramids', fillstyle='none')
plt.plot(wavelengths*1e9, RAT['A_per_layer'][:,0], '-k', label='Planar')
plt.plot(wavelengths*1e9, RAT_planar['A_bulk'][0], '--r')
plt.plot(wavelengths='lower left')
plt.legend(loc'Wavelength (nm)')
plt.xlabel('Absorption in Si')
plt.ylabel(900, 1200])
plt.xlim([0, 1])
plt.ylim([ plt.show()
We can see that both the rear grating and front surface pyramid texture increase absorption in the Si. The rear grating does not affect the front surface reflection, while the pyramid texture does, which increases absorption over the whole wavelength range. The two methods for calculating absorption in the planar structure are in agreement as expected.
Visualizing the redistribution matrices
RayFlare has built-in functions to make it easier to load and plot the redistribution matrices you have generated. First, based on the options we set, we generate the angle_vector
which lists the \(\theta\) (polar angle) and \(\phi\) (azimuthal angle) values in each bin of the angular redistribution matrices.
= make_angle_vector(options['n_theta_bins'], options['phi_symmetry'],
theta_intv, phi_intv, angle_vector 'c_azimuth'])
options[
= sns.cubehelix_palette(256, start=.5, rot=-.9)
palhf
palhf.reverse()= mpl.colors.ListedColormap(palhf) seamap
Now we find the path
where the matrices are stored. We calculated the redistribution matrices at different wavelengths, but we are just going to plot them at a single wavelength, so we find which index in the matrix that wavelength corresponds to.
= get_savepath('current', options.project_name)
path
= 1100e-9
wl_to_plot
= np.argmin(np.abs(wavelengths-wl_to_plot)) wl_index
The redistribution matrices are stored in a sparse matrix format (this is much more efficient, since usually many matrix entries will be zero. A sparse matrix format lists only the non-zero entries). Using the path
we found above and the name of the surface, we load the sparse matrix, select only the wavelength we are interested in, and convert it to a normal NumPy array (a “dense” matrix):
= load_npz(os.path.join(path, SC_fig8[2].name + 'frontRT.npz'))
sprs # Load the redistribution matrices for the bottom surface in SC_fig8 (this is the grating)
= sprs[wl_index].todense()
full # Convert from sparse format to normal numpy array
The indexing of the sparse array is (wavelength, angular bin out, angular bin in). To make the information easier to interpret, RayFlare has the theta_summary
function which will sum over all the azimuthal bins at a certain \(\theta\), and returns the results in xarray format. We then select only the first half of the matrix; the data for reflection and transmission are stored in the same array (0 to \(2 \pi\) radians), but we pick out only the reflection part.
= theta_summary(full, angle_vector, options['n_theta_bins'], front_or_rear='front')
summat # Front or rear refers to front or rear incidence on the surface, rather than the front or rear surface of the
# whole structure
= summat[:options['n_theta_bins'], :]
summat_g # We select the FIRST half of the matrix: this is redistribution into the upper half plane, so because we are
# looking at incident light coming from this half-plane, this corresponds to reflection
We can use xarray’s functionality to transform the coordinates from \(\theta\) to \(\sin\theta\), and then rename the coordinates (this will automatically label the plots below).
= summat_g.assign_coords({r'$\theta_{in}$': np.sin(summat_g.coords[r'$\theta_{in}$']).data,
summat_g r'$\theta_{out}$': np.sin(summat_g.coords[r'$\theta_{out}$']).data})
= summat_g.rename({r'$\theta_{in}$': r'$\sin(\theta_{in})$', r'$\theta_{out}$': r'$\sin(\theta_{out})$'}) summat_g
Now repeat this for another surface (the pyramidal surface):
= load_npz(os.path.join(path, SC_fig8[0].name + 'rearRT.npz'))
sprs # Load the redistribution matrices for the top surface in SC_fig8 (this is the pyramids)
= sprs[wl_index].todense()
full
= theta_summary(full, angle_vector, options['n_theta_bins'], front_or_rear='rear')
summat # Front or rear refers to front or rear incidence on the surface, rather than the front or rear surface of the
# whole structure
= summat[options['n_theta_bins']:, :]
summat_r # We select the SECOND half of the matrix: this is redistribution into the lower half plane, so because we are
# looking at incident light coming from this half-plane, this corresponds to reflection
= summat_r.assign_coords({r'$\theta_{in}$': np.sin(summat_r.coords[r'$\theta_{in}$']).data,
summat_r r'$\theta_{out}$': np.sin(summat_r.coords[r'$\theta_{out}$']).data})
= summat_r.rename({r'$\theta_{in}$': r'$\sin(\theta_{in})$', r'$\theta_{out}$': r'$\sin(\theta_{out})$'}) summat_r
Plot the redistribution matrices:
PLOT 2: Redistribution matrices for reflection into Silicon from the diffraction grating (left) and pyramid surface (right).
= plt.figure(figsize=(10,4))
fig = plt.subplot(121)
ax = summat_g.plot.imshow(ax=ax, cmap=seamap, vmax=0.3)
ax = plt.subplot(122)
ax = summat_r.plot.imshow(ax=ax, cmap=seamap)
ax plt.show()
The left plot shows redistribution of light upon reflection from the rear grating. The right plot shows redistribution of light which hits the pyramidal front surface from the inside and is reflected back into the cell. We could plot equivalent matrices for e.g. transmission through the rear grating or light escaping when incident on the pyramid surface from the inside of the structure.