Expand this Topic clickable element to expand a topic
Skip to content
Optica Publishing Group

OpenFilters: open-source software for the design, optimization, and synthesis of optical filters

Open Access Open Access

Abstract

The design of optical filters relies on powerful computer-assisted methods. Many of these methods are provided by commercial programs, but, in order to adapt and improve them, or to develop new methods, one needs to create his own software. To help people interested in such a process, we decided to release our in-house software, called OpenFilters, under the GNU General Public License, an open-source license. It is programmed in Python and C++, and the graphical user interface is implemented with wxPython. It allows creation of multilayer and graded-index filters and calculation of reflection, transmission, absorption, phase, group delay, group delay dispersion, color, ellipsometric variables, admittance diagram, circle diagram, electric field distribution, and generation of reflection, transmission, and ellipsometric monitoring curves. It also provides the refinement, needle, step, and Fourier transform methods.

© 2008 Optical Society of America

1. Introduction

The conception of optical filters was revolutionized when, 50 years ago, Baumeister demonstrated the possibility to optimize optical filters using a computer program [1]. Before then, most optical filters consisted of quarter wave layers, and their design relied on graphical methods. Since then, a large variety of complex design procedures have been developed that rely on sophisticated numerical methods and the use of computers [2]. Nowadays, we have at our disposal very powerful synthesis methods, such as the needle method, that allow one to design optical filters for any physically sound problem.

Many commercial programs are available to design optical filters; the most important ones were reviewed in 2003 by Kruschwitz [3]. Despite the high quality of these commercial programs, many companies and research institutions continue to develop their own in-house software. In-house software can be rapidly modified when a new problem arises and adapted to fit the specific needs of the organization, while commercial programs, by their nature, are less customizable.

At the Functional Coating and Surface Engineering Laboratory (FCSEL) we developed an expertise in the design and fabrication of graded-index and intermediate index optical filters and found that commercial programs offer only limited capabilities for the design of such filters. Also in recent years we developed new design methods, and we wanted to incorporate them in a complete design environment, including popular design methods and an easy-to-use graphical user interface. This brought us to the creation, from scratch, of a new design program, a process that took us many years.

In the hope of helping other groups with similar goals to avoid the same troubles, we decided to release this program, called OpenFilters, as open-source software under the GNU General Public License (GPL). It is freely available on our website, http://www.polymtl.ca/larfis. We believe that the availability of such open-source software is a significant advance for the optical coating community. It will reduce the barrier encountered by people entering the community by giving them the opportunity to start developing new features from a fully functional program. We hope that this will stimulate the improvement of existing analysis and design methods as well as the creation of new ones.

Our aim is to present what OpenFilters offers so the reader can decide whether there is interest in using it to justify the choices we made during its creation, to show how to use it, to explain under what conditions it can be used or modified, and to describe its implementation so that one can determine if it can be adapted to fit his or her specific needs.

We first present the GPL, followed by a review of the methods used by OpenFilters to calculate the properties of optical filters, as well as the design, optimization, and synthesis methods it proposes. Contrary to our other publications about the design and synthesis methods we developed, we do not attempt to provide a complete development of the design methods; we present only the main equations used by OpenFilters and give references for interested readers to learn more. We then present a very short user guide and the structure of the implementation of OpenFilters. Finally, we outline some plans for the future development of OpenFilters and indicate how one can collaborate in its development.

2. GNU General Public License

The GPL [4] is an open source license, or free software license. It gives the user the freedom to access the source code of the program and to modify it to suit its needs. The user does not need to distribute the modifications made to OpenFilters. But, if one decides to do so, the derived work must also be released under the GPL. One should carefully read the GPL before distributing any work derived from OpenFilters.

The GPL does not apply to the results obtained with OpenFilters. It can be used to design filters for commercial applications, and the results can be published under different conditions. However, we would be grateful if you refer to this article or our website when publishing results obtained with OpenFilters.

3. What OpenFilters Offers: a Review of the Calculation, Design, Optimization, and Synthesis of Optical Filters

In this section we provide basic information to understand how OpenFilters designs, optimizes, synthesizes, and calculates the optical properties of interference filters.

3A. Calculation of the Optical Properties

As shown in Fig. 1, a classical optical filter consists of a stack of layers of thicknesses di and indices of refraction Ni between an incidence and an exit media of indices of refraction Ninc and Nex, respectively.

OpenFilters calculates the filter properties using the characteristic matrix approach developed by Abelès [5] and presented in detail in most optical coating textbooks such as Macleod's [6]. In this exact approach, the ith layer is represented by

Mi=[cosφi(i/ηi)sinφiiηisinφicosφi],
where
ηi={Nicosθis polarizationNi/cosθip polarization
is the pseudoindex of the layer,
φi=2πλNidicosθi
is the phase shift of the wave inside the layer, θi is the angle of propagation in the layer, and λ is the wavelength of light in vacuum.

According to the Snell–Descartes' law, α=Nisinθi is constant [7]. To avoid computer intensive trigonometric function calculations, the pseudoindices and phase shift can be calculated using

ηi={Ni2α2s polarizationNi2/Ni2α2p polarization,
φi=2πλNi2α2di
instead of Eqs. (2) and (3), respectively.

The characteristic matrix describing the multilayer is

M=[m11m12m21m22]=i=q1Mi,
where q is the number of layers, and the product is taken in reverse order since the matrices of upper layers must be multiplied on the left.

The amplitude reflection and transmission coefficients of the multilayer are

r=ηincm11ηexm22+ηincηexm12m21ηincm11+ηexm22+ηincηexm12+m21,
t=2ηincηincm11+ηexm22+ηincηexm12+m21,
where ηinc and ηex are the pseudoindices of the incidence and exit media, respectively. The reflectance and transmittance are
R=rr*=|r|2,
T=ReNexReNinctt*=ReNexReNinc|t|2,
where Re is the real part and * denotes the complex conjugate. The absorptance is simply
A=1RT.

When dealing with a rapidly changing signal, such as a pulse train, one also needs to know the dispersive properties of the filter. The global phase shifts on reflection and transmission modulo 2π, ϕr, and ϕt are the angles made by r and t in the complex plane so that

ϕr=argr=arctanImrRer,
ϕt=argt=arctanImtRet,
where Im is the imaginary part and the signs of the numerator and the denominator must be evaluated separately.

By themselves, the phase shifts do not provide much information about the behavior of the filter. One is usually more interested in the delay introduced when a pulse is reflected or transmitted by the filter, the group delay (GD), or in the deformation of a finite bandwidth pulse caused by the variation of GD with the wavelength, the group delay dispersion (GDD). GD and GDD are obtained from the phase using

GD=dϕdω,
GDD=d2ϕdω2,
where ω=2πc/λ is the angular frequency and c is the speed of light in vacuum. There are analytical formulas to calculate the GD and GDD, but it is impossible to calculate them analytically from the characteristic matrix of a multilayer. For that reason, OpenFilters calculates GD and GDD numerically from the ϕr or ϕt spectrum.

Since ellipsometry is commonly used to characterize optical filters, OpenFilters can generate the ellipsometric spectrum of a filter. Following the convention most commonly used in the optical thin film community [8], the ellipsometric angles Ψ and Δ are defined by

ρ=rprs=tanΨeiΔ,
where rs and rp are the amplitude reflection coefficients for s- and p-polarized light, respectively. Therefore,
Ψ=arctan|rp||rs|,Δ=arg(rp)arg(rs).

There also are applications, such as color shifting security devices, where the color of a filter is of interest. To calculate it, one must multiply the spectrum of an illuminant by that of the filter and color matching functions representing the sensitivity of the eye. OpenFilters strictly follows the CIE 15:2004 standard [9]. OpenFilters also offers tools that provide an intuitive understanding of some filters: the admittance diagram [6, 10], the circle diagram [11], and the electric field distribution [12].

Finally, to prepare the filter deposition, OpenFilters can generate the reflection, transmission, or ellipsometric monitoring curves. To do so, it simply grows the filter by separating it in thin sublayers that are successively added and by calculating the properties after the addition of each of these sublayers.

3B. Consideration of the Backside

Up to this point we have considered the case of a semi-infinite exit medium. This is clearly unrealistic, and it is necessary to account for the effect of the substrate backside. Since the coherence length of light is usually shorter than the substrate thickness, this case must be treated differently from that of a layer. As shown in Fig. 2, one can simply add multiple reflections and transmissions occurring in the substrate. They follow geometric series whose sums are

R=RF+TFTFRRBexp4βi1RFRRBexp4βi,
T=TFTBexp2βi1RFRRBexp4βi,
where RF and TF are the reflectance and transmittance of the front side, RFR and TFR are the reflectance and transmittance of the front side in reverse direction, RB and TB are the reflectance and transmittance of the backside,
βi=Im(2πλNsub2α2dsub)
is related to the absorption in the substrate, and Nsub is the index of refraction of the substrate.

The different reflection and transmission coefficients can be calculated from Eqs. (9) and (10) while considering appropriate incidence and exit media. It should also be noted that, since the characteristic matrices Eq. (6) are persymmetric, the product i=1qMi can be obtained from i=q1Mi by simply interchanging the diagonal elements.

The situation is more complicated for ellipsometry since the incoherent effect of the front side and backside phase shifts must be considered. In that case, OpenFilters uses the formalism of Yang and Abelson [13].

3C. Graded-Index Filters

The index of refraction of graded-index filters varies continuously throughout the thickness. It is possible to treat some simple cases analytically, but this approach is very limited. A more general approach consists in approximating the index gradient by a series of very thin sublayers [14]. The thickness of the sublayers must be small enough to correctly represent the index profile, but large enough to limit calculation time and avoid numerical errors.

The discretization of the index profile is usually accomplished by a series of sublayers with constant physical or optical thickness. This approach is simple since the software needs to calculate only the function generating the index profile at equally spaced points. However, when one wants to calculate the properties of a filter made of real materials with dispersive refractive index, it is necessary to calculate the dispersion of the index for every sublayer. To avoid these repeated calculations, OpenFilters discretizes the index profile using predefined index levels.

The discretization process is shown in Fig. 3. First, the index profile n(z) is calculated at a large number of points with a thickness interval chosen to provide multiple points in each index interval. Then, for each index interval, linear interpolation is used to determine the points a and b, where the index profile crosses the predefined index levels nj and nj+1, defining a small section of the index profile. Finally, that section of the index profile is replaced by two sublayers of thicknesses dj and dj+1 so that

dj+dj+1=ba,
njdj+nj+1dj+1=abn(z)dz,
where the integral is evaluated using the trapezoidal rule. This guarantees that the discretized filter preserves both the physical thickness and the optical thickness of the original index profile.

3D. Optimization of Multilayer Filters

It is often difficult, or even impossible, to manually design a filter respecting all the specifications for a given application. However, it is possible to optimize a filter using refinement [1]. In this method, the designer provides a starting design whose properties are sufficiently close to the specifications. Then, an optimization algorithm is used to adjust the thickness of the layers and eventually their index of refraction.

In addition to the starting design, the designer must provide targets describing the specifications. The targets can be any property computable from the parameters of the filter; usually, these are the reflection, the transmission, phase properties, or the color defined for some polarization and angle of incidence. Depending on the application, it may be necessary to define a target at a single wavelength or over a range of wavelengths. In the latter case, the target must in fact be discretized and defined at a finite number of wavelengths. Using the targets, it is possible to define a merit function (MF), representing the quality of a design, that the refinement must minimize. OpenFilters uses

χ2=i=1m(BiB¯iΔBi)2,
where m is the number of targets, Bi is a property of interest, B¯i is the target value for that property, and ΔBi is the tolerance for that property.

The optimization algorithm used by OpenFilters is the Levenberg–Marquardt algorithm [15]. The properties of a filter that are optimized, the thickness and the index of refraction of the layers, are represented by a vector a=[a1,a2,]. The Levenberg–Marquardt algorithm calculates the first derivatives of the merit function with regard to every parameter ak,

dχ2dak=2i=1m[BiB¯i(ΔBi)2dBidak],
and it uses these derivatives to determine the point where the MF is the lowest in a trust region centered around the present value of a. Repeated improvements of the MF allow the Levenberg–Marquardt algorithm to find a local minimum.

Following van der Laan and Frankena [16], let us now show how to calculate dBi/dak in the case where Bi is the reflection or the transmission. According to Eqs. (9) and (10),

dRdak=2r*drdak,
dTdak=2Re(Ns)Re(Nm)t*dtdak.

According to Verly [17], the derivative of the amplitude reflection coefficient r relative to the parameter ak can be calculated using

drdak=Tr(dMdakψr),
where Tr is the trace and
ψr=t2Ninc[Ninc(1r)(1+r)NincNex(1r)Nex(1+r)].
Using a similar formalism, the derivative of the amplitude transmission coefficient can be calculated using
dtdak=Tr(dMdakψt),
where
ψt=t22Ninc[Ninc1NincNexNinc].

According to Eq. (6), the derivative of the matrix of the multilayer relative to a parameter ak of the jth layer is

dMdak=i=qj+1MidMjdaki=j11Mi.
If parameter ak is the thickness dj of the layer, Eqs. (1) and (5) give
dMjddj=dMjdφjdφjddj,
where
dMjdφj=[sinφj(i/ηj)cosφjiηjcosφjsinφj],
dφjddj=2πλNj2α2.
Similarly, if ak is the index of refraction of the layer,
dMjdNj=dMjdφjdφjdNj+dMjdηjdηjdNj,
where dMj/dφj is given by Eq. (33),
dMjdηj=[0(i/ηj2)sinφjisinφj0],
dηjdNj={NjNj2α2s polarizationNjNj2α2(2Nj2Nj2α2)p polarization,
dφjdNj=2πλNjNj2α2dj.
Note that the index of refraction of a layer is usually defined by its real part nj,0=Re(Nj,0) at a reference wavelength λ0. In that case,
dMjdnj,0=dMjdNjdNjdnj,0,
where dNj/dnj,0 is determined from the dispersion of the refractive index of the material.

OpenFilters also offers the possibility to refine the index of refraction of a layer while keeping its optical thickness constant [18]. Details will be published in an upcoming article.

Finally, the effect of the backside must be considered. According to Eqs. (18) and (19), the derivatives of the reflectance and transmittance by a parameter ak of the front stack are

dRdak=dRFdak+TFTFRRBexp4βi1RFRRBexp4βi(1TFdTFdak+1TRdTRdak+RBexp4βi1RFRRBexp4βidRFRdak),
dTdak=T(1TFdTFdak+RBexp4βi1RFRRBexp4βidRFRdak).

3E. Synthesis of Multilayer Filters

Even after being refined, the filter does not always fully respect the specifications. Or it can be difficult for the designer to provide a starting design. In that case, one must resort to synthesis methods. The most commonly used synthesis method is the needle method. OpenFilters also offers the step method that we developed.

3E1. Needle Method

The needle method was first described by Tikhonravov in 1982 [19]. However, it only began to be widely used in the middle of the 1990s [20, 21]. As shown in Fig. 4(a), it consists of adding thin layers at optimal positions in the filter and then adjusting their thickness by refinement. Needles are added until a satisfactory solution is found or the addition of more needles does not improve the filter.

The optimal position to add needles is determined by calculating the derivative of the MF with regard to the thickness of an infinitesimally thin layer as a function of the position where it is added. Where the derivative is negative, it is favorable to add a needle. Usually, one needle at a time is added at the position where the derivative of the MF is the most negative.

The addition of a needle in the jth layer represented by the matrix Mj, which has a thickness corresponding to a phase shift φj, creates two sublayers represented by matrices Mj,2 and Mj,1 with thicknesses corresponding to phases φj,2 and φj,1 such that φj=φj,2+φj,1. These two sublayers are separated by a needle represented by the matrix Mn and Mj=Mj,2MnMj,1. The effect of the addition of the needle of index Nn and infinitesimal thickness dn is, therefore,

dMjddn|dn=0=Mj,2dMnddn|dn=0Mj,1.
To speed up the calculations, Eq. (42) can be rewritten as
dMjddn|dn=0=12[(ηjηn+ηnηj)dMjdφj+(ηjηnηnηj)×[1001]dMj(Δφj)dΔφj]dφnddn,
where ηn is the pseudoindex of the needle, φn=(2π/λ)Nn2α2dn is the phase shift in the needle, and dMj(Δφj)/dΔφj is identical to Eq. (33) in which φj is replaced by Δφj=φj,1φj,2. Equation (43) is faster to compute than Eq. (42) because there is no matrix multiplication, dMj/dφj and dMj(Δφj)/dΔφj do not depend on the needle material, and dMj/dφj does not depend on the position of the needle.

3E2. Step Method

When materials with a continuous range of index of refraction are available, Verly proposed to determine both the optimal position and the index of refraction of the added needle [17]. On our side, we proposed to add steps in the index profile instead of needles [22]. As shown in Fig. 4(b), the step method consists of adding infinitesimal steps in the index profile and then refining the index of refraction and the thickness of the separated layers.

Similar to the needle method, the optimal position to add steps is determined by calculating the derivative of the MF with regard to the addition of a step as a function of the position where the step is added.

The jth layer is separated in two sublayers, and the refractive index of the first sublayer is increased while that of the second sublayer is decreased (or vice versa). If the index change is equally distributed on both sublayers, the effect of the addition of a step is

dMjdΔNj|ΔNj=0=12dMj,2dNjMj,1Mj,212dMj,1dNj.

To speed up the calculation, this equation can be rewritten as

dMjdΔNj|ΔNj=0=12[dMjdφjdΔφjdNj+(dMj(Δφj)dηj+1ηj(cosφjcosΔφj)[1001])dηjdNj],
where dMj(Δ)/dηj is identical to Eq. (36), where φj is replaced by Δφj.

If the index of refraction of the layer where the step is added is at a limit of the available index range, it is impossible to distribute the change of index equally, and the calculation must be slightly modified. Details about the step method will be published in an upcoming article.

3F. Design of Graded-Index Filters

We have seen how to design, optimize, and synthesize multilayer filters. We now turn to the design of graded-index filters. We present the Fourier transform method and a direct application, the design of rugate filters, as well as quintic antireflective layers.

3F1. Fourier Transform Method

The Fourier transform method for the design of optical filters was developed by Delano [23] and Sossi [24], and later popularized by Dobrowolski and Lowe [25]. It directly relates the desired reflection or transmission spectra with the index profile of the filter through the use of an amplitude and phase functions, Q and Ψ, respectively, called the Q function. The index depth profile n(x) is obtained by using the inverse Fourier transform [25]

lnn(x)nm=2π0Q(σ)σsin(Ψ(σ)σx)dσ,
where x is the double-centered optical thickness, σ=2π/λ is the wavenumber, λ is the wavelength, and
nm=nminnmax
is the geometric mean index of the filter. The double-centered optical thickness
x=20zn(u)du
is twice the optical thickness measured from the center of the filter, where z is the physical thickness and u is an integration variable. Note that in real applications, the Q function is defined at a finite number of wavelengths in a limited range, and the integral of Eq. (46) is replaced by a sum.

Multiple Q functions have been proposed [23, 24, 25, 26, 27, 28, 29, 30, 31, 32], and OpenFilters offers many of them. However, since the Q functions are only approximate, there will be discrepancies between the target and the obtained filter. This problem can be solved by iteratively correcting the Q function [33]. OpenFilters also considers the dispersion of the index of refraction in the Fourier transform method using a method we developed [34].

3F2. Rugate Filters

A direct application of the Fourier transform method is the design of single- or multiple-wavelength reflectors called rugate filters [26]. It can easily be understood that the Fourier transform of a Q function defined for a single wavelength gives a sinusoidal index profile. Furthermore, a multiband rugate filter can easily be designed by multiplying multiple sinusoidal profiles:

lnn(x)nm=iQ¯isin(2πx/λi+φi)w(x),
where λi are the wavelengths of the band, φi are phase shifts that allow one to center the index profile, and
Q¯i=12lnnm+Δni/2nmΔni/2
are the reduced Q functions that control the amplitude Δni of the index profile.

Since the sinusoidal index profile cannot be infinite, it is necessary to multiply it by a finite envelope w(x). The spectrum of the filter is the convolution of the Fourier transform of the sinus and that of the envelope. Therefore, if that envelope is simply a rectangular function, the bands are convoluted with a sinus cardinal, causing sidelobes. An envelope providing apodization is the Kaiser function,

w(x)=I0(β14x2)I0(β)Π(x),
where I0 is the modified Bessel function of the first kind and zeroth order, Π(x) is a rectangular function, and β is a parameter that controls the amount of apodization.

The bandwidth of a band, Δλi, is related to the amplitude of its index profile, while the reflecting power is related to the amplitude of the index profile and the number of periods. According to Bovard [30],

Δn=2nmsin(π4Δλiλi),
x=QπQ¯i|W0|/λi,
where W0 is the continuous component of the Fourier transform of w(x).

OpenFilters' rugate module corrects for the dispersion of the material using the method that Poitras and we have developed [35]. It consists of (1) designing separate single-band rugate filters for each band (2), converting the index profiles to a common wavelength using the dispersion of the material, and (3) multiplying the index profiles.

3F3. Quintic Layers

Graded-index layers can also be used as antireflective layers. Indeed, when the index change is continuous and very slow, there is almost no reflection in a layer. One particularly effective antireflective layer to avoid reflection between two materials of indices n1 and n2 is the quintic index profile [36]

n(u)=n1+(n2n1)(10u315u4+6u5),
where u=z/d, z is the physical depth, and d is the total physical thickness of the filter.

OpenFilters also offers to scale the thickness optically (u=x/2OT) and the index exponentially, giving

n(u)=n1exp[ln1+(n2n1)n1(10u315u4+6u5)],
which we have found to give even better results.

4. Very Short User Guide

Now that we have shown what OpenFilters offers, we succinctly present how to use it. All the functions of OpenFilters are accessible through a graphical user interface (GUI), which is designed so that the vast majority of the information is presented in a single main window, as shown in Fig. 5.

OpenFilters comes with a bank of materials from Palik [37, 38] or characterized in our laboratory. More materials can be added to fit the user's needs by use of the GUI. At this moment, OpenFilters offers three ways to enter the dispersion of the index of refraction: a single complex value for dispersionless materials, a table of complex values as a function of wavelength, or a Cauchy dispersion model with an Urbach absorption tail. The material dispersion formulas are saved in text files.

In OpenFilters, material mixtures are described using the real properties of the materials, instead of mixing laws such as the effective medium approximation. To do so, the user must enter the dispersion of the index of refraction for multiple mixtures, and the index of refraction of intermediate mixtures is interpolated using a cubic spline. OpenFilters also provides a mechanism to account for the limited resolution of the index of refraction during the eventual deposition of graded-index filters. When the optical properties are entered, the user must assign a number to every mixture. Then, OpenFilters considers that only intermediate mixtures represented by whole numbers are possible to deposit.

The operations in OpenFilters are centered around projects. A project allows the user to design and compare multiple solutions to the same problem by regrouping a set of filters designed to meet the same set of targets. After the creation of a project, the user can add filters and targets to it and modify or remove them in the order wanted.

When the user adds a new filter to the project, a dialog is presented that makes it necessary for the user to specify the substrate material and thickness, the front and back media, the reference wavelength, the wavelength range, and the graded-index step spacing. The reference wavelength is the wavelength at which the index of refraction of mixtures is defined and is used when calculating the optical thickness of the layers. The step spacing is used in the discretization of the index profile of graded-index filters as explained in Subsection 3C. The user may choose to discretize graded-index filters according to the deposition steps as described in the material file. All these properties may be changed later if necessary.

It is possible to add layers to the filter individually or through the use of a stack formula. When mixtures are used, in addition to the thickness of the layer, the user must specify its index of refraction. Layers can be added, removed, or modified at the will of the user.

OpenFilters comes with modules to design rugate and quintic filters. The rugate module offers the possibility to design single-band and multiband rugates and to specify the number of periods and the amplitude of the index profile either directly or from the bandwidth and the reflection power of the bands. It also offers the possibility to multiply the index profile by a Kaiser apodization envelope. In the quintic module, the starting and ending indices can be selected manually or automatically matched to the surrounding layers. The index can be linearly or exponentially scaled, while the thickness can be physically or optically scaled.

After a filter has been created, it is possible to calculate many of its properties: transmission, reflection, absorption, phase, GD, GDD, ellipsometric variables Ψ and Δ, color, the circle and admittance diagrams, and the electric field distribution. The color is calculated in XYZ, xyY, L*a*b*, and L*u*v* color spaces using the CIE1931 or CIE1964 colorimetric observers and one of the 38 illuminants defined by the Commission Internationale de l'Éclairage [9]. OpenFilters can also generate photometric or ellipsometric monitoring curves. When the user asks the software to calculate a property, a dialog is presented for selection of the conditions at which to calculate the property, such as the angle of incidence and the polarization.

To design, optimize, or synthesize a filter, the user must define targets. OpenFilters offers single wavelength and spectral reflection and transmission targets, and color targets. In the case of spectral targets, the user must set a range of wavelengths and a resolution for the target, and then define the value of the target at some wavelengths. The values between those wavelengths are linearly interpolated. It is possible for the user to specify that the target is an equality or an inequality. For color targets, the user has the choice of the same color spaces, observers, and illuminants already mentioned.

Once targets are set, the user can optimize an existing filter using refinement, synthesize a filter using the needle or step methods, or design one using the Fourier transform method. When the user selects one of these methods, a dialog is presented that allows control of the design, optimization, or synthesis. For example, the needle method dialog, presented in Fig. 6, offers the possibility to select the materials of the needles, to refine the filter, to add a selectable number of needles, or to remove thin layers. The user can also select the automatic mode in which refinement, addition of needles, and removal of thin layers are automatically done until an acceptable solution is found or the addition of more needles is no longer helpful.

Finally, the project can be saved in a text file and reopened later. All the results given by OpenFilters can be exported to text files to allow the user to plot them with a software of his or her choice.

5. Under the Hood

If the user is interested in modifying OpenFilters to fit specific needs and to collaborate on its development, it is necessary to understand the structure of its implementation.

OpenFilters is written in Python [39] and C++ using object oriented programming. Major logical elements of the software (materials, projects, filters, targets, design∕optimization∕synthesis routines) are represented by classes programmed in Python. To speed up the calculations, most of the computationally intensive tasks are performed by two modules implemented in C++: the abeles and moremath modules. The GUI is programmed using the wxPython toolkit [40].

The abeles module is named after Florin Abelès who first presented the characteristic matrix approach to calculate the optical properties of optical coatings [5]. It implements classes to calculate the index of refraction of materials from their dispersion formulas, computes the characteristic matrices of layers, multiplies these matrices, calculates the properties of the filter, and evaluates the derivatives used in refinement, needle, and step methods.

The moremath module, named to differentiate it from the standard Python module math, implements the Levenberg–Marquardt algorithm routines to solve linear equation systems using Gauss–Jordan elimination or QR decomposition, interpolation methods (mainly the cubic spline), and a few more tools. The Levenberg–Marquardt code is similar to MINPACK [41] but allows the use of inequality targets and the bounding of the fitted parameters (to avoid negative thicknesses and bound the index of refraction to acceptable values).

Each kind of material is represented by a different class that derives from the material base class. At this moment, there are six derived classes for simple materials and mixtures, and for the three dispersion models previously described. All these classes include a common set of methods to set the dispersion formula of the material and to obtain its index of refraction for a single wavelength or a spectrum. Many of the calculations are delegated to the abeles module. More dispersion models can be easily added by simply creating more derived classes without needing to modify other parts of the code.

Projects are instances of the project class. It is a very plain class that simply implements methods to add or remove filters and targets.

All offered kinds of target derive from the target base class. Derived classes are implemented for single wavelength and spectral reflection or transmission, and for color. They include methods to set the target and to interact with optimization methods. If new target classes are added, it will also be necessary to modify the optimization methods accordingly.

The optical filter class implements methods to add and remove homogeneous and graded-index layers, and to calculate the properties of a filter with the help of the abeles package. When a property is calculated at a given angle of incidence, the matrices for that angle of incidence are saved. Therefore, it is not necessary to recalculate them when determining another property at the same angle of incidence.

The classes implementing design, optimization, and synthesis methods derive from the optimization base class. The refinement and the Fourier transform method classes are directly derived from the optimization class. The refinement class is further derived to create the needle and step method classes. Optimization methods use the abeles and moremath modules intensively during the calculations.

All the files in which materials, illuminants, observers, or projects are saved are text files in an easily understandable format.

The GUI is clearly separated from the rest of the implementation to allow creation of another user interface if necessary. OpenFilters is somewhat multithreaded: computationally intensive tasks are done in a separate thread to preserve the GUI responsiveness, and it is possible to stop most of these operations. However, at this moment, these operations are done in a single thread.

Finally, rugate and quintic modules are self-contained. This implementation was selected to allow the creation of modules without having to modify any other part of the code. The modules are loaded when OpenFilters starts, so it is possible to add modules without recompiling it.

6. Conclusions and Future Plans

We have developed OpenFilters, an open-source program for the design of optical filters. It offers new features such as the step method and the consideration of dispersion in the Fourier transform method as well as popular methods such as refinement and the needle method. It was recently used in the OIC 2007 design contest and provided a result comparable to the winning design [42].

We plan to continue the development of OpenFilters and would be pleased to find collaborators. Following the open-source philosophy, we therefore invite you not only to use OpenFilters but also to modify it to fit your needs and to collaborate on its development. If you send us the modifications, and we believe they are of interest to the community, we will be glad to include them in the distribution of OpenFilters.

In the near future we plan to include gradual evolution [43, 44, 45], design cleaning [45], and preproduction analysis [46, 47, 48, 49] to OpenFilters. In the longer term, we would like to extend the OpenFilters project to develop a reverse-engineering software.

We would also like to build a large database of materials' refractive index. To help us, we invite you to send us the index of refraction of the materials that you measure as well as a description of the fabrication condition and measurement setup.

We acknowledge the financial support of the National Sciences and Engineering Research Council of Canada (NSERC), and we thank our colleagues of the FCSEL, particularly Marie-Maude de Denus Baillargeon and Bill Baloukas, who tested early versions of OpenFilters, for their feedback. Stéphane Larouche also thanks the NSERC for its scholarship.

A preliminary version of this work was presented at the Optical Society of America's Tenth Topical Meeting on Optical Interference Coatings held in Tucson, Arizona, USA, 3–8 June 2007 [50].

 figure: Fig. 1

Fig. 1 Multilayer optical filter.

Download Full Size | PDF

 figure: Fig. 2

Fig. 2 Optical filter with backside.

Download Full Size | PDF

 figure: Fig. 3

Fig. 3 Discretization of the refractive index profile of a graded-index filter (see text for details).

Download Full Size | PDF

 figure: Fig. 4

Fig. 4 Schematic representation of (a) the needle method and (b) the step method.

Download Full Size | PDF

 figure: Fig. 5

Fig. 5 (Color online) Main window of OpenFilters.

Download Full Size | PDF

 figure: Fig. 6

Fig. 6 (Color online) Needle method dialog.

Download Full Size | PDF

1. P. Baumeister, “Design of multilayer filters by successive approximations,” J. Opt. Soc. Am. 48, 955–958 (1958). [CrossRef]  

2. J. A. Dobrowolski, “The impact of computers on the design and manufacture of optical multilayer coatings during the past 50 years,” in 50th Annual Technical ConferenceProceedings (Society of Vacuum Coaters, 2008), pp. 289–301.

3. J. Kruschwitz, “Software tools speed optical thin-film design,” Laser Focus World 39, 153–157 (2003).

4. Free Software Foundation, “GNU general public license,” http://fsf.org/.

5. F. Abelès, “Recherches sur la propagation des ondes électromagnétiques sinusoïdales dans les milieux stratifiés. Application aux couches minces,” Ann. Phys. (Paris) 5, 596–640, 706–782 (1950).

6. H. A. Macleod, Thin-Film Optical Filters, 3rd ed. (Institute of Physics Publishing, 2001). [CrossRef]  

7. Sh. A. Furman and A. V. Tikhonravov, Basics of Optics of Multilayer Systems (Éditions Frontières, 1992).

8. R. H. Muller, “Definitions and conventions in ellipsometry,” Surf. Sci. 16, 14–33 (1969). [CrossRef]  

9. , Colorimetry, 3rd ed. CIE 15:2004 (Commission Internationale de l'Éclairage, 2004).

10. P. J. Leurgans, “The impedance concept in thin film optics,” J. Opt. Soc. Am. 41, 714–717 (1951). [CrossRef]  

11. J. H. Apfel, “Graphics in optical coating design,” Appl. Opt. 11, 1303–1312 (1972). [CrossRef]   [PubMed]  

12. V. V. Veremei and I. M. Minkov, “Distribution of light intensity within a dielectric mirror,” Opt. Spectrosc. (USSR) 33, 1175–1178 (1972); translation, Opt. Spectrosc. 33, 640–641 (1972).

13. Y. H. Yang and J. R. Abelson, “Spectroscopic ellipsometry of thin films on transparent substrates: a formalism for data interpretation,” J. Vac. Sci. Technol. A 13, 1145–1149 (1995). [CrossRef]  

14. P. Baumeister, “Simulation of a rugate filter via a stepped-index dielectric multilayer,” Appl. Opt. 25, 2644–2645 (1986). [CrossRef]   [PubMed]  

15. J. J. Moré, “The Levenberg-Marquardt algorithm: implementation and theory,” Lect. Notes Math. 630, 105–116 (1978). [CrossRef]  

16. C. J. van der Laan and H. J. Frankena, “Fast computation method for derivatives of multilayer stack reflectance,” Appl. Opt. 17, 538–541 (1978). [CrossRef]  

17. P. G. Verly, “Modified needle method with simultaneous thickness and refractive-index refinement for the synthesisof inhomogeneous and multilayer optical thin films,” Appl. Opt. 40, 5718–5725 (2001). [CrossRef]  

18. S. Larouche and L. Martinu, “Optical filters with constant optical thickness and refined refractive indices,” in Optical Interference Coatings on CD-ROM (Optical Society of America, 2007), p. TuD8.

19. A. V. Tikhonravov, “A method of synthesisof optical coverings which uses the necessary optimality conditions,” Vestn. Mosk. Univ. Fiz. Astronomiya 37, 91–93 (1982); translation, Mosc. Univ. Phys. Bull. 37, 108–110 (1982).

20. A. V. Tikhonravov, M. K. Trubetskov, and G. W. DeBell, “Application of the needle optimization technique to the design of optical coatings,” Appl. Opt. 35, 5493–5508 (1996). [CrossRef]   [PubMed]  

21. B. T. Sullivan and J. A. Dobrowolski, “Implementation of a numerical needle method for thin-film design,” Appl. Opt. 35, 5484–5492 (1996). [CrossRef]   [PubMed]  

22. S. Larouche and L. Martinu, “A new step method for the synthesisof optical filters with arbitrary indices,” in 49th Annual Technical ConferenceProceedings (Society of Vacuum Coaters, 2006), pp. 305–308.

23. E. Delano, “Fourier synthesisof multilayer filters,” J. Opt. Soc. Am. 57, 1529–1533 (1967). [CrossRef]  

24. L. Sossi, “A method for the synthesisof multilayer dielectric interference coatings,” Eesti NSV Teaduste Akadeemia Toimetised Füüsika, Matemaatika 23, 229–237 (1974). English translation available from the Translation Services of the Canada Institute for Scientific and Technical Information (CISTI).

25. J. A. Dobrowolski and D. Lowe, “Optical thin film synthesisprogram based on the use of Fourier transforms,” Appl. Opt. 17, 3039–3050 (1978). [CrossRef]   [PubMed]  

26. B. G. Bovard, “Rugate filter theory: an overview,” Appl. Opt. 32, 5427–5442 (1993). [CrossRef]   [PubMed]  

27. L. Sossi, “On the theory of the synthesisof multilayer dielectric light filters,” Eesti NSV Teaduste Akadeemia Toimetised Füüsika, Matemaatika 25, 171–176 (1976). English translation available from the Translation Services of the Canada Institute for Scientific and Technical Information (CISTI).

28. P. G. Verly, J. A. Dobrowolski, W. J. Wild, and R. L. Burton, “Synthesisof high rejection filters with the Fourier transform method,” Appl. Opt. 28, 2864–2875 (1989). [CrossRef]   [PubMed]  

29. B. G. Bovard, “Derivation of a matrix describing a rugate dielectric thin film,” Appl. Opt. 27, 1998–2005 (1988). [CrossRef]   [PubMed]  

30. B. G. Bovard, “Fourier transform technique applied to quarterwave optical coatings,” Appl. Opt. 27, 3062–3063 (1988). [CrossRef]   [PubMed]  

31. R. Szipöcs and A. Köházi-Kis, “Theory and design of chirped dielectric laser mirrors,” Appl. Phys. B 65, 115–135 (1997). [CrossRef]  

32. H. Chang, S.-S. Lee, M. R. Chol, and S. Lim, “Inhomogeneous optical filter design with the use of a Riccati equation,” Microwave Opt. Technol. Lett. 22, 140–144 (1999). [CrossRef]  

33. P. G. Verly and J. A. Dobrowolski, “Iterative correctionprocess for optical thin film synthesiswith the Fourier transform method,” Appl. Opt. 29, 3672–3684 (1990). [CrossRef]   [PubMed]  

34. S. Larouche and L. Martinu, “Dispersion implementation in optical filter design by the Fourier transform method using correction factors,” Appl. Opt. 46, 7436–7441 (2007). [CrossRef]   [PubMed]  

35. D. Poitras, S. Larouche, and L. Martinu, “Design and plasma deposition of dispersion-corrected multiband rugate filters,” Appl. Opt. 41, 5249–5255 (2002). [CrossRef]   [PubMed]  

36. W. H. Southwell, “Gradient-index antireflection coatings,” Opt. Lett. 8, 584–586 (1983). [CrossRef]   [PubMed]  

37. E. D. Palik, ed., Handbookof Optical Constants of Solids (Academic, 1985).

38. E. D. Palik, ed., Handbookof Optical Constants of Solids II (Academic, 1991).

39. “Python,” http://www.python.org/.

40. “wxpython,” http://wxpython.org/.

41. J. Moré, B. Garbow, and K. Hillstrom, “MINPACK,” http://www.netlib.org/minpack.

42. M. Tilsch and K. Hendrix, “Optical Interference Coatings design contest 2007: triple bandpass and nonpolarizing beam splitter,” Appl. Opt. 47, C55–C69 (2008). [CrossRef]   [PubMed]  

43. J. A. Dobrowolski, “Completely automatic synthesisof optical thin film systems,” Appl. Opt. 4, 937–946 (1965). [CrossRef]  

44. J. A. Dobrowolski, “Versatile computer program for absorbing optical thin film systems,” Appl. Opt. 20, 74–81 (1981). [CrossRef]   [PubMed]  

45. A. V. Tikhonravov, M. K. Trubetskov, and G. W. DeBell, “Optical coating design approaches based on the needle optimization technique,” Appl. Opt. 46, 704–710 (2007). [CrossRef]   [PubMed]  

46. P. W. Baumeister, “Methods of altering the characteristics of a multilayer stack,” J. Opt. Soc. Am. 52, 1149–1152 (1962). [CrossRef]  

47. W. P. Thoeni, “Deposition of optical coatings:process control and automation,” Thin Solid Films 88, 385–397 (1982). [CrossRef]  

48. H. Zorc, “Optimum multilayer design selection in relation to production errors,” Vacuum 37, 101–102 (1987). [CrossRef]  

49. A. V. Tikhonravov and M. K. Trubetskov, “Computational manufacturing as a bridge between design and production,” Appl. Opt. 44, 6877–6884 (2005). [CrossRef]   [PubMed]  

50. S. Larouche and L. Martinu, “OpenFilters: an open source software for the design and optimization of optical coatings,” in Optical Interference Coatings on CD-ROM (Optical Society of America, 2007), p. WB6.

Cited By

Optica participates in Crossref's Cited-By Linking service. Citing articles from Optica Publishing Group journals and other participating publishers are listed here.

Alert me when this article is cited.


Figures (6)

Fig. 1
Fig. 1 Multilayer optical filter.
Fig. 2
Fig. 2 Optical filter with backside.
Fig. 3
Fig. 3 Discretization of the refractive index profile of a graded-index filter (see text for details).
Fig. 4
Fig. 4 Schematic representation of (a) the needle method and (b) the step method.
Fig. 5
Fig. 5 (Color online) Main window of OpenFilters.
Fig. 6
Fig. 6 (Color online) Needle method dialog.

Equations (55)

Equations on this page are rendered with MathJax. Learn more.

M i = [ cos φ i ( i / η i ) sin φ i i η i sin φ i cos φ i ] ,
η i = { N i cos θ i s  polarization N i / cos θ i p  polarization
φ i = 2 π λ N i d i cos θ i
η i = { N i 2 α 2 s  polarization N i 2 / N i 2 α 2 p  polarization ,
φ i = 2 π λ N i 2 α 2 d i
M = [ m 11 m 12 m 21 m 22 ] = i = q 1 M i ,
r = η inc m 11 η ex m 22 + η inc η ex m 12 m 21 η inc m 11 + η ex m 22 + η inc η ex m 12 + m 21 ,
t = 2 η inc η inc m 11 + η ex m 22 + η inc η ex m 12 + m 21 ,
R = r r * = | r | 2 ,
T = Re N ex Re N inc t t * = Re N ex Re N inc | t | 2 ,
A = 1 R T .
ϕ r = arg r = arctan Im r Re r ,
ϕ t = arg t = arctan Im t Re t ,
GD = d ϕ d ω ,
GDD = d 2 ϕ d ω 2 ,
ρ = r p r s = tan Ψ e i Δ ,
Ψ = arctan | r p | | r s | , Δ = arg ( r p ) arg ( r s ) .
R = R F + T F T FR R B exp 4 β i 1 R FR R B exp 4 β i ,
T = T F T B exp 2 β i 1 R FR R B exp 4 β i ,
β i = Im ( 2 π λ N s u b 2 α 2 d s u b )
d j + d j + 1 = b a ,
n j d j + n j + 1 d j + 1 = a b n ( z ) d z ,
χ 2 = i = 1 m ( B i B ¯ i Δ B i ) 2 ,
d χ 2 d a k = 2 i = 1 m [ B i B ¯ i ( Δ B i ) 2 d B i d a k ] ,
d R d a k = 2 r * d r d a k ,
d T d a k = 2 Re ( N s ) Re ( N m ) t * d t d a k .
d r d a k = T r ( d M d a k ψ r ) ,
ψ r = t 2 N inc [ N inc ( 1 r ) ( 1 + r ) N inc N ex ( 1 r ) N ex ( 1 + r ) ] .
d t d a k = T r ( d M d a k ψ t ) ,
ψ t = t 2 2 N inc [ N inc 1 N inc N ex N inc ] .
d M d a k = i = q j + 1 M i d M j d a k i = j 1 1 M i .
d M j d d j = d M j d φ j d φ j d d j ,
d M j d φ j = [ sin φ j ( i / η j ) cos φ j i η j cos φ j sin φ j ] ,
d φ j d d j = 2 π λ N j 2 α 2 .
d M j d N j = d M j d φ j d φ j d N j + d M j d η j d η j d N j ,
d M j d η j = [ 0 ( i / η j 2 ) sin φ j i sin φ j 0 ] ,
d η j d N j = { N j N j 2 α 2 s polarization N j N j 2 α 2 ( 2 N j 2 N j 2 α 2 ) p polarization ,
d φ j d N j = 2 π λ N j N j 2 α 2 d j .
d M j d n j , 0 = d M j d N j d N j d n j , 0 ,
d R d a k = d R F d a k + T F T F R R B exp 4 β i 1 R F R R B exp 4 β i ( 1 T F d T F d a k + 1 T R d T R d a k + R B exp 4 β i 1 R F R R B exp 4 β i d R F R d a k ) ,
d T d a k = T ( 1 T F d T F d a k + R B exp 4 β i 1 R F R R B exp 4 β i d R F R d a k ) .
d M j d d n | d n = 0 = M j , 2 d M n d d n | d n = 0 M j , 1 .
d M j d d n | d n = 0 = 1 2 [ ( η j η n + η n η j ) d M j d φ j + ( η j η n η n η j ) × [ 1 0 0 1 ] d M j ( Δ φ j ) d Δ φ j ] d φ n d d n ,
d M j d Δ N j | Δ N j = 0 = 1 2 d M j , 2 d N j M j , 1 M j , 2 1 2 d M j , 1 d N j .
d M j d Δ N j | Δ N j = 0 = 1 2 [ d M j d φ j d Δ φ j d N j + ( d M j ( Δ φ j ) d η j + 1 η j ( cos φ j cos Δ φ j ) [ 1 0 0 1 ] ) d η j d N j ] ,
ln n ( x ) n m = 2 π 0 Q ( σ ) σ sin ( Ψ ( σ ) σ x ) d σ ,
n m = n m i n n m a x
x = 2 0 z n ( u ) d u
ln n ( x ) n m = i Q ¯ i sin ( 2 π x / λ i + φ i ) w ( x ) ,
Q ¯ i = 1 2 ln n m + Δ n i / 2 n m Δ n i / 2
w ( x ) = I 0 ( β 1 4 x 2 ) I 0 ( β ) Π ( x ) ,
Δ n = 2 n m sin ( π 4 Δ λ i λ i ) ,
x = Q π Q ¯ i | W 0 | / λ i ,
n ( u ) = n 1 + ( n 2 n 1 ) ( 10 u 3 15 u 4 + 6 u 5 ) ,
n ( u ) = n 1 exp [ ln 1 + ( n 2 n 1 ) n 1 ( 10 u 3 15 u 4 + 6 u 5 ) ] ,
Select as filters


Select Topics Cancel
© Copyright 2024 | Optica Publishing Group. All rights reserved, including rights for text and data mining and training of artificial technologies or similar technologies.