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

Fast solvers for one dimensional light scattering in the discrete dipole approximation

Open Access Open Access

Abstract

In this paper we propose new algorithms for solution of light scattering on non-spherical particles using one-dimensional variant of discrete dipole approximation. We discuss recent advances in algorithms for matrices with structures in context of the discrete dipole approximation and show that it is possible to apply these advances to form non-iterative solvers and improve algorithmic complexity in case of many incoming plane parallel waves.

©2004 Optical Society of America

1. Introduction - one dimensional discrete dipole approximation

The discrete-dipole approximation [3,4] is a general and exact method for computing scattering and absorption by a particle of arbitrary shape. In the last decade it allowed to routinely solve scattering problems by arbitrary non-spherical particles with size parameter (ratio of physical size to incomming wavelength) between x=-20. There is very strong interest in this method in variety of applications including atmospheric science, nanotechnology [9], chemistry, biology, electrical engineering, and astrophysics. The discrete dipole approximation (DDA) has surprisingly rich numerical and physical structure, mostly due to its simplicity, and to the fact that the boundary conditions are naturally included. In the limit of very many dipoles the method is exactly equivalent to integral form of Maxwell equations for light scattering problems. Some-what surprisingly, this simplicity of the DDA approach resulted in many exciting new extensions, for example, to periodic structures Chaumet [1] or particles placed on surfaces. There is also several of papers studying various aspects of the DDA numerics. There is no doubt that further improvements are possible. The discrete dipole approximation replaces the solid particle by an array of N point dipoles, with the spacing between dipoles small compared with the wavelength. Physical intuition suggest that the complexity of any solution algorithm can not be better than O(N). Current solvers indeed progressed to fast solvers with complexity proportional to O(N logN) but through iterative methods. Another outstanding problem is related to many incoming plane waves. Currently, for each of them one has to solve the iterative problem anew. Finally, for orientational averages over many incoming plane waves one would like to know full inverse of matrix describing the shape and composition of a particle. In this paper we attempt to show how to attack these outstanding problems in the one dimensional case of the discrete dipole approximation.

The most general DDA discretization [3] leads to set of 3N linear complex equations

k=1NAjkPk=Einc,j(j=1,,N)

where 3×3 matrix Ajk is defined as

AjkPk=exp(ikrjk)rjk3{k2rjk×(rjk×Pk)+(1ikrjk)rjk[rjk2Pk3rjk(rjk·Pk)]}(jk),

and r jk ≡|r j-r k| is the distance between respective position of dipoles, P k has 3 components and it is polarization vector induced at dipole k, position of a dipole is defined by 3-component vector r k and k is the wavenumber (certain care needs to be taken to differentiate index k and wavenumber k). For dipoles interacting with itself we define

Ajj=αj1

where αk is polarizability of dipole k. Equation (2) can be rewritten in the following form

AjkPk=f(rjk)Pk+g(rjk)njk(njk·Pk)

where n jk=r jk/rjk is the direction pointing from the position of dipole j towards dipole k. For special case of dipoles placed on x-axis vector n jk=(1,0,0) for all dipoles, i.e.

AjkPk=(fjk+gjk000fjk000fjk)(px,kpy,kpz,k)

Functions f (rjk ) and g(rjk ) are

f(rjk)=exp(ikrjk)(k2rjk+ikrjk21rjk3)

and

g(rjk)=exp(ikrjk)(k2rjk3ikrjk2+3rjk3)

and the sum of these two is

h(rjk)=f(rjk)+g(rjk)=exp(ikrjk)(2ikrjk22rjk3).

We will now consider simple example of just 3 dipoles placed on x-axis. According to Eq. (1) this leads to 9 equations

(α100h1200h13000α100f1200f13000α100f1200f13h2100α100h23000f2100α100f23000f2100α100f23h3100h3200α1000f3100f3200α1000f3100f3200α1)(px,1py,1pz,1px,2py,2pz,2px,3py,3pz,3)

where we used (4) and definition (7). This can be re-arranged by combining x,y,z components separately to read

(α1h12h13000000h21α1h23000000h31h32α1000000000α1f12f13000000f21α1f23000000f31f32α1000000000α1f12f13000000f21α1f23000000f31f32α1)(px,1px,2px,3py,1py,2py,3pz,1pz,2pz,3)

It is easy to see from Eq. (8) that x,y, z-components are decoupled and can be solved separately. Interactions defined by Eqs. (5) and (6) do not depend on position of dipoles but only on their distance hjkh(|rj -rk |). This is crucial simplification as we can write the interaction forces in a very simple way. For example, the x-component of the N-element polarization vector is given by

(α1h12h13h1Nh21α1h12h31h21h13h12hN1h31h21α1)(P1P2PN)x=(E1E2En)inc,x

where entries on diagonals are determined by the first row and column only. Such matrix is called Toeplitz and leads to very efficient solution method which we will discuss shortly. Not

only is this matrix Toeplitz but it is also symmetric, i.e. hjk =hkj . This is because the dipole-dipole interactions depend only on the absolute distance between them. Thus, (9) is fully determined by its first row. I.e.

A({α1,h12,h13,,h1N})Px=Einc,x

where notation of the left hand side indicates that Toeplitz matrix A is generated by column {α -1, h 12, h 13, …, h 1 N}. Such structure holds for the y and z components. Equation (10) is rather simple case of DDA which nevertheless exhibits its interesting numerical aspects. To the best of our knowledge all current fast algorithms to solve (9) employ iterative technique of guessing polarization vector and gradually improve on it. The algorithm requires numerous matrix times vector multiplications which can be efficiently done using Fast Fourier Transform because the matrix has Toeplitz structure. However, one wonders if the inverse problem has simple structure. This is indeed the case in one dimensions as the following discussion shows.

2. Displacement structure of Toeplitz matrices and its relationship to Fast Fourier Transform.

In this section we summarize recent results related to numerical algorithms to invert and multiply Toeplitz matrix. The notation and most results follow work of Gohberg and Olshevsky [6,7]. The algorithms will be presented in terms of matrix multiplications and so we need to define several matrices of special structure. The most general Toeplitz

A(a)A(ac,ar)=(a0a1an+1a1a0a1a2a1an1a2a0)

matrix is defined by its first column a c=[a 1, a 2, …,a n-1] and its first row a r=[a 0, a -1, …,a -n+1] . In the case of symmetric matrix the first column is the same as the first row a c=a r. The φ-cyclic circulant has form

Circφ(r)=(r0φrn1φr1r1r0φrn1r1r0φrn1rn1r1r0)

where vector r=(ri )i=0n1. Circulant (φ=1) is completely defined by its first column r and each subsequent column is right shifted. We are particularly interested in φ-circulants because they are closely related to the Fast Fourier Transform (FFT). Multiplication of φ-circulant matrix by vector is fast and requires three FFTs as the following result [2] shows

Circφ(r)=Dφ1Λφ(r)Dφ

where

Dφ=diag((ξ)i=0n1)andΛφ(r)=diag(Dφr)

here diag(r) is diagonal matrix, ξn =φ, and is the Fourier matrix and the asterix means conjugate transpose. For strictly circulant matrix φ=1 and all elements of Dφ are 1, thus

Circ(r)=Λ(r)

and multiplication of Circ(r) by a vector b is done by taking FFT of b, i.e. (b), multiplying this vector term by term with (r), and finally taking inverse FFT of the resulting vector. Equation (13) follows the same pattern of three FFTs and multiplications except that each element of vectors b and r is first scaled by elements of vector Dφ =[1, ξ, ξ 2, …, ξ n-1]. Even though (13) is written in terms of matrix times matrix multiplications in practice this is never done. Rather, it is a series of matrix times vector multiplications which are performed. Because it is fast to multiply by cyclic circulants our plan is to reduce multiplication and inversion of a Toeplitz matrix in terms of circulants.

We begin with simple derivations. Let us write matrix (11) in terms of circulant (φ=1)and skew-circulant (φ=-1). For this we introduce two vectors which are almost reverse of the vectors (ac,ar ) which generate a Toeplitz matrix. These are defined as bc =[0, a -n+1, … a -2, a -1] and br =[0, a n-1, … a 2, a 1]. By adding and subtracting A(b) we can rewrite A(a) as

A(a)=12[A(a)+A(b)]+12[A(a)A(b)]=12[A(a+b)+A(ab)].

Notice that matrix A(a)+A(b)=A(a+b) and A(a)-A(b)=A(a-b). By direct inspection we see that A(a+b)=Circ1(a+b) and A(a-b)=Circ-1(a-b). Therefore A(a) multiplied by a vector d is given by

A(a)d=12Circ1(a+b)d+12Cric1(ab)d=12Conv1(a+b,d)+12Conv1(ab,d),

where we introduced definition of convolution of two vectors in terms of multiplication of circulant by a vector Conv(p,q)≡Circ(p)q. Equation (16) and (13) shows that multiplication of a Toeplitz matrix by a vector can be done with 6 FFTs and scaling (for skew-circulant part). In iterative techniques, it is required to multiply A(a)d for many ds the FFTs of vectors (a+b) and (a-b) can be precalculated and the complexity of multiplication by a vector reduces to 4 FFTs of length n. Equations (16) forms a basis for almost all current implementations of the discrete dipole approximation. These implementations depend on iterative calculations of A(a)d with vector d changed according to conjugate gradient scheme. There are variants of (16) which rely on embedding matrix A(a) to larger 2n dimensional matrix and zero padding but they are equivalent to the scheme given above. Now, we will report an important result related to the inverse of Toeplitz matrix. To this end we need to introduce φ-cyclic lower shift matrix

Zφ=(0φ10010010)

and assume that we can calculate two vectors x and y defined by

Ax=e0andAy=en1

where e 0=(1, 0, …, 0, 0) and e n-1=(0, 0, …, 0, 1) and x 0≠0 then inverse of matrix A is given by

A1=1x0(φψ)[Circψ(x)Circ(Zφy)Circψ(Zψy)Circφ(x)]

This result is modification of celebrated Gohberg-Semencul [6,7] formula expressed in terms of circulants. Equation (18) provides very fast algorithm for inverse matrix times vector multiplication A -1 d in terms of 4 convolutions. It shows that one needs just two auxiliary vectors to form the Toeplitz matrix inverse.

3. Proposed algorithms

We will now propose two algorithms to solve discrete dipole approximation in a prototype, one-dimensional case.

3.1. Algorithm 1. Conjugate gradient (iterative)

Consider Eq. (10) A(h)P=E which is set of equations for unknown polarization vector P and known right hand side E and Toeplitz matrix defined by N-element vector h=(α -1 h 12 h 13h 1N) associated with function (7). Equations (16) and (13) show that multiplication of a Toeplitz matrix by a vector can be done with 6 FFTs and scaling (for skew-circulant part). Using conjugate gradient iterations we have to multiply A(h)P for many incomming plane parallel waves E. In that case the FFTs of vectors (h+b) and (h-b), where b is defined in Equation (15), can be precalculated and the complexity of each multiplication by a vector reduces to 4 FFTs of length N. This algorithm is similar to that implemented in the DDSCAT code [4]. However, the algorithm we propose here requires only N-dimensional FFT rather than 2N-dimensional version used in the DDSCAT code [8]. There is also economy in memory use because one doesn’t have to form extended matrix of dimension 2N.

3.2. Algorithm 2. Two-phase inversion (the main result).

Consider Eq. (10) A(h)P=E which is a set of equations for unknown polarization vector P and known right hand side E and Toeplitz matrix defined by N-element vector h=(α -1, h 12, h 13, …, h 1N) defined by function (7). There are two phases of the algorithm.

Phase 1. In the first phase one has to calculate and store two additional vectors defined in (17). This can be done iteratively by using conjugate gradient method (Algorithm 1).

Phase 2. The second phase applies A -1(h)Einc using expression (18). This requires 4 convolutions and each of them can be performed by using 3 FFTs (see Eq. 13) with scaling. Each subsequent case of the incomming plane wave can be solved by employing Phase 2. For many right hand sides of (10) this algorithm is faster in comparison to conjugate gradient Algorithm 1.

4. Discussion

In this paper we propose new algorithms for solution of light scattering on non-spherical particles using one-dimensional variant of the discrete dipole approximation. We discuss recent advances in algorithms for matrices with structures and show that it is possible to apply these advances to use FFT and non-iterative solvers. Algorithm 1 can be extended to 3D for arbitrary non-spherical particles and should be competitive with current implementations. There are variants [10] of Algorithm 2 which do not require iterative solution for auxiliary vectors x and y defined by (17). Future challenge is an extension of Algorithm 2 to the three-dimensional case, i.e. block-Toeplitz matrices [5]. Extension to 3D parallelepiped for homogeneous and isotropic refractive index should be straightforward. Apparently, the way non-spherical particles are extended to parallelepiped requires introduction of vacuum dipoles with refractive index equal to 1 which ruins the Toeplitz structure on main diagonal.

References and links

1. P.C. Chaumet, A. Rahmani, and G. W. Bryant, “Generalization of the coupled dipole method to periodic structures,” Phys. Rev. B 67, Art. No. 165404, (2003). [CrossRef]  

2. R. E. Cline, R. J. Plemmons, and G. Worm, “Generalized inverses of certain Toeplitz matrices,” Linear Algbra and Its Applications 8,, 25–33 (1974). [CrossRef]  

3. B. T. Draine and P. J. Flatau, “Discrete dipole approximation for scattering calculations,” J. Opt. Soc. Am. A 11, 1491–1499, 1994. [CrossRef]  

4. B. T. Draine and P. J. Flatau, “User Guide for the Discrete Dipole Approximation Code DDSCAT.6.0,” http://arxiv.org/abs/astro-ph/0309069, (2003).

5. P. J. Flatau, G. L. Stephens, and B. T. Draine, “Light scattering by rectangular solids in the discrete-dipole approximation: a new algorithm exploiting the block-Toeplitz structure,” J. Opt. Soc. Am. A 7, 593–600 (1990). [CrossRef]  

6. I. Gohberg and V. Olshevsky, “Circulants, displacements and decompositions of matrices,” Integ. Equat. Oper. Th. 15, 730–743 (1992). [CrossRef]  

7. I. Gohberg and V. Olshevsky, “Complexity of multiplication with vectors for structured matrices,” Linear Algebra Appl. 202, 163–192, (1994). [CrossRef]  

8. J. J. Goodman, B. T. Draine, and P. J. Flatau, “Application of fast-Fourier-transform techniques to the discrete-dipole approximation,” Opt. Lett. 16, 1198–1200 (1991). [CrossRef]   [PubMed]  

9. G. C. Schatz, “Electrodynamics of nonspherical noble metal nanoparticles and nanoparticle aggregates,”J. Mol. Struct.-Theochem 573, 73–80 (2001). [CrossRef]  

10. M. Van Barel, G. Heinig, and P. A. Kravanja, “Stabilized superfast solver for nonsymmetric Toeplitz systems,” SIAM J. Matrix Anal. A 23, 494–510 (2001). [CrossRef]  

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.


Equations (20)

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

k = 1 N A jk P k = E inc , j ( j = 1 , , N )
A jk P k = exp ( i k r jk ) r jk 3 { k 2 r jk × ( r jk × P k ) + ( 1 i k r jk ) r jk [ r jk 2 P k 3 r jk ( r jk · P k ) ] } ( j k ) ,
A j j = α j 1
A jk P k = f ( r jk ) P k + g ( r jk ) n jk ( n jk · P k )
A jk P k = ( f jk + g jk 0 0 0 f jk 0 0 0 f jk ) ( p x , k p y , k p z , k )
f ( r jk ) = exp ( i k r jk ) ( k 2 r jk + ik r jk 2 1 r jk 3 )
g ( r jk ) = exp ( i k r jk ) ( k 2 r jk 3 ik r jk 2 + 3 r jk 3 )
h ( r jk ) = f ( r jk ) + g ( r jk ) = exp ( i k r jk ) ( 2 ik r jk 2 2 r jk 3 ) .
( α 1 h 12 h 13 0 0 0 0 0 0 h 21 α 1 h 23 0 0 0 0 0 0 h 31 h 32 α 1 0 0 0 0 0 0 0 0 0 α 1 f 12 f 13 0 0 0 0 0 0 f 21 α 1 f 23 0 0 0 0 0 0 f 31 f 32 α 1 0 0 0 0 0 0 0 0 0 α 1 f 12 f 13 0 0 0 0 0 0 f 21 α 1 f 23 0 0 0 0 0 0 f 31 f 32 α 1 ) ( p x , 1 p x , 2 p x , 3 p y , 1 p y , 2 p y , 3 p z , 1 p z , 2 p z , 3 )
( α 1 h 12 h 13 h 1 N h 21 α 1 h 12 h 31 h 21 h 13 h 12 h N 1 h 31 h 21 α 1 ) ( P 1 P 2 P N ) x = ( E 1 E 2 E n ) inc , x
A ( { α 1 , h 12 , h 13 , , h 1 N } ) P x = E inc , x
A ( a ) A ( a c , a r ) = ( a 0 a 1 a n + 1 a 1 a 0 a 1 a 2 a 1 a n 1 a 2 a 0 )
Circ φ ( r ) = ( r 0 φ r n 1 φ r 1 r 1 r 0 φ r n 1 r 1 r 0 φ r n 1 r n 1 r 1 r 0 )
Circ φ ( r ) = D φ 1 Λ φ ( r ) D φ
D φ = diag ( ( ξ ) i = 0 n 1 ) and Λ φ ( r ) = diag ( D φ r )
Circ ( r ) = Λ ( r )
A ( a ) = 1 2 [ A ( a ) + A ( b ) ] + 1 2 [ A ( a ) A ( b ) ] = 1 2 [ A ( a + b ) + A ( a b ) ] .
A ( a ) d = 1 2 Circ 1 ( a + b ) d + 1 2 Cric 1 ( a b ) d = 1 2 Conv 1 ( a + b , d ) + 1 2 Conv 1 ( a b , d ) ,
A x = e 0 and A y = e n 1
A 1 = 1 x 0 ( φ ψ ) [ Circ ψ ( x ) Circ ( Z φ y ) Circ ψ ( Z ψ y ) Circ φ ( x ) ]
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.