Beam Propagation Method Solution to the Seminar Tasks

Size: px
Start display at page:

Download "Beam Propagation Method Solution to the Seminar Tasks"

Transcription

1 Beam Propagation Method Solution to the Seminar Tasks Matthias Zilk The task was to implement a 1D beam propagation method (BPM) that solves the equation z v(xz) = i 2 [ 2k x 2 + (x) k 2 ik2 v(x, z) = Lv(x, z) (1) 2k ] using a centered finite-difference approximation of the x-derivative and two different finite-difference schemes along the propagation direction z. Voluntarily, the Crank-Nicolson could be implemented as a third solution method. The implementations had to be tested with a Gaussian beam v(x) = exp ( x2 w 2 ) that is slightly too large to fit into a step index waveguide n n(x) = core for x < x b /2; { n cladding otherwise. (2) (3) The parameters of the test geometry are given in table 1. 1 Task I: The Explicit FTCS Scheme The first task was the implementation of the explicit FTCS scheme, where the transverse second derivative is discretized by a central difference while the z-derivative is discretized by a forward difference. The field update of this scheme is given by v n+1 = (I + ΔzL)v n = Av n (4) where I is the identity matrix and L is the discretized beam propagation operator of equation (1). The vector v n = (v n 1,, vn i,, vn N x ) T contains the discretized field at the lateral positions x = x a /2 + (i 1)Δx and at z = (n 1)Δz. Width of computational domain x a = 5 µm Waveguide width x b = 2 µm Cladding refractive index n cladding = 1.45 Core refractive index n core = 1.46 Beam width w = 4 µm Vacuum wavelength λ = 1 µm Propagation distance z end = 1 µm Table 1: Parameters of the test geometry. 1

2 1.1 Implementation For the implementation of the explicit scheme the matrix of the discretized beam propagation operator L is required. As this matrix is also required by the other schemes, it it useful to implement it in a separate function. This function is called bpm_operator: bpm_operator.m 1 function L = bpm_operator (dx,n,nd, lambda ) 2 % L = bpm_operator (lambda,n,nd,dx) 3 % Calculates the finite difference discretization of the 4 % BPM differential operator L = 1i /(2* kbar )*( d ^2/ dx ^2 + k ^2 - kbar ^2). 5 % All lengths have to be specified in µm. 6 % Arguments : 7 % dx : Lateral step size ( scalar ) 8 % n : Refractive index distribution ( vector ) 9 % nd : Reference refractive index ( scalar ) 1 % lambda : Wavelength ( scalar ) 11 % Returns : 12 % L : Beam propagation operator ( sparse matrix ) Nx = numel (n); 15 k = 2* pi/ lambda *n (:); 16 kbar = 2* pi/ lambda *nd; 17 alpha = 1/(( dx ^2)* 2* kbar ); % abbreviation for prefactor 18 Wi = ( k.^2 - kbar ^2)/( 2* kbar ); % abbreviation for last term 19 2 main_ diag = 1i*( Wi - 2* alpha ); 21 aux_diag = 1i* alpha * ones (Nx, 1); 22 L = spdiags ([ aux_diag, main_diag, aux_diag ], [-1,, 1], Nx, Nx ); The implementation is a literal translation of the formulas from the seminar slides. The discretized beam propagation operator is a symmetric tridiagonal matrix. The main and the secondary diagonals are set up in line 2 and 21. In line 22 the matrix is created using the spdiags function. This produces a sparse matrix that stores only the non-zero entries. As L has only 3 non-zero diagonals, using sparse matrix saves quite a lot of memory. Also numerical operations with sparse matrices are computationally more efficient than operation with dense matrices that contain mostly zeros. With the matrix L we can now implement the explicit scheme: beamprop_explicit.m 1 function [ v_out, z] = beamprop_ explicit ( v_in, lambda, dx, n, nd,... 2 z_end, dz, output_ step ) 3 % [ v_out, z] = beamprop_ explicit ( v_in, lambda, dx, n, nd,... 4 % z_end, dz, output_ step ) 5 % Propagates an initial field over a given distance based on the 6 % solution of the paraxial wave equation in an inhomogeneous 7 % refractive index distribution using the explicit 8 % forward Euler scheme. All lengths have to be specified in µm. 9 % Arguments : 1 % v_in : Initial field ( vector ) 11 % lambda : Wavelength ( scalar ) 12 % dx : Transverse step size ( scalar ) 13 % n : Refractive index distribution ( vector ) 14 % nd : Reference refractive index ( scalar ) 15 % z_end : Propagation distance ( scalar ) 2

3 16 % dz : Step size in propagation direction ( scalar ) 17 % output_ step : Number of steps between field outputs ( integer ) 18 % Returns : 19 % v_out : Propagated field ( matrix ) 2 % z : z- coordinates of field output ( vector ) % calculate grid size 23 Nx = length (n); 24 Nz = round ( z_end /( output_ step * dz )) + 1; % +1 for initial field at z = 25 % calculate required number of iterations 26 Niter = ( Nz - 1)* output_ step ; % generate the output grid 29 v_out = zeros ( Nx, Nz ); 3 z = ( : (Nz - 1))* dz* output_step ; % generate iteration matrix A = I + dz* L 33 A = speye (Nx) + dz* bpm_operator (dx,n,nd, lambda ); % iteration 36 curr_ slice = 1; % current postion in output matrix 37 v_ curr = v_in (:); % current field 38 v_out (:, curr_ slice ) = v_ curr ; % store input field as first output 39 for iter = 1 : Niter 4 % advance field : multiply current field with iteration matrix 41 v_curr = A* v_curr ; 42 % check if current iteration has to be stored 43 if mod( iter, output_ step ) == 44 curr_ slice = curr_ slice + 1; % move to next output slot 45 v_out (:, curr_ slice ) = v_ curr ; % store current solution 46 end 47 end The function consists of three parts: In line 23 to 3 the output matrices are set up and the required number of iterations is calculated. In line 33 the iteration matrix is created using the auxiliary function bpm_operator. This line is a literal translation of equation (4). As we are dealing with sparse matrices, the function speye has to be used to create the identity matrix. Finally, in line 36 to 47 the field is propagated using a for loop and is stored at the requested intervals. At each iteration the field is advanced by Δz by multiplying the current field with the iteration matrix. As the iteration matrix is tridiagonal this operation has a linear complexity of O(N x ). The if condition in line 43 uses a modulo operation to decide if the current field has to be stored in the output. 1.2 Results The implementation was tested with a step index waveguide and a Gaussian initial filed. The parameters of the test case are given in table 1. For the lateral discretization N x = 251 points were used, resulting in a lateral step size of Δx = x a /(N x 1) =.2 µm. As the explicit scheme is unstable, a very small propagation step size of Δz = 2.5 nm had to be used to achieve a propagation distance of z end = 1 µm. For the subtraction of the carrier a reference refractive index of n d = was used. The refractive index distribution, the initial field and the fundamental waveguide mode of the step index waveguide (the waveguide supports only a single mode) are shown in figure 1. The waveguide 3

4 lateral position [µm] real part of field real part of field afer 1 µm input field fundamental waveguide mode index difference n(x) - n cladding lateral position [µm] Figure 1: Refractive index distribution, initial field and fundamental waveguide mode of the test geometry. The initial field and the waveguide mode have been normalized to the same power. explicit FTCS schme dz = 2.5nm, Nx=251 dz = 5.nm, Nx=251 dz = 2.5nm, Nx= propagation distance [µm] lateral position [µm] Figure 2: Evolution of the field propagated with the explicit scheme using a propagation step size of Δz = 2.5 nm and a lateral step size of Δx = x a /(N x 1) =.2 µm. Figure 3: Influence of the parameters Δz and N x on the stability of the explicit scheme. The plots show the real part of the field after a propagation distance of 1 µm for various discretization parameters. The individual curves have been offset vertically for better distinction. mode has been calculated with the finite-difference mode solver of seminar 3. It is apparent that the initial field is slightly larger than the waveguide mode. The effective index of the waveguide mode is n eff = which is very close to the chosen reference index. The evolution of the field propagated with the explicit scheme is shown in figure 2. Most of the initial field is coupled to the waveguide mode and propagates in the waveguide. However, as the overlap between the initial field and the waveguide mode is not perfect, parts of the initial field are scattered and create oscillating sidelobes that spread laterally with increasing propagation distance. The field in the waveguide shows almost no phase variation. This is because the BPM calculates only the slowly varying envelop of the actual field. The oscillating carrier is removed by the choice of k = 2πn d /λ. As k was chosen very close to the propagation constant of the waveguide mode, the envelop of the field in the waveguide exhibits almost no phase evolution upon propagation. The field shown figure 2 looks well but we know that the explicit scheme is unstable. So what happens when we change the propagation step size or the lateral resolution? In the seminar it has been shown that the squared magnitude of the eigenvalues of the propagation matrix in absence of 4

5 a refractive index modulation (i.e. k(x) = k) is given by g(κ) 2 = 1 + (Δz)2 k 2 (Δx) [cos(κδx) 4 1]2 (5) whereby κ is the transverse wave number of the eigenvector of the beam propagation operator. The eigenvalues are larger than unity for all κ > making the explicit scheme unstable. The eigenvalues are largest for high frequency components with κ close to π/δx. The magnitude of the eigenvalues increases both when Δz is increased or when Δx is decreased. From equation (5) we can expect that both increasing Δz and N x will increase the amplification of numerical errors which will in turn lead to the appearance of high frequency noise. This is exactly what can be seen in figure 3. With the original parameters of Δz = 2.5 nm and N x = 251 there are already some small high frequency distortions visible on the field after a propagation distance of 1 µm. When Δz or N x is increased, these distortions grow strongly and the solution becomes completely unusable. 2 Task II: The Implicit BTCS Scheme The stability problem of the explicit scheme is circumvented in the implicit BTCS scheme by using a backward difference for the approximation for the derivative in propagation direction. The field update of this scheme is given by v n+1 = (I ΔzL) 1 v n = A 1 v n (6) and requires the solution of a linear system of equations. However, as the matrix A is tridiagonal, this can still be done with a complexity of O(N x ). 2.1 Implementation The implementation of the implicit scheme is very similar to the implementation of the explicit scheme. Actually only two lines have to be changed: beamprop_implicit.m 32 % generate implicit iteration matrix A = I - dz* L 33 A = speye (Nx) - dz* bpm_operator (dx,n,nd, lambda ); and 39 for iter = 1 : Niter beamprop_implicit.m 4 % advance field : solve tridiagonal system of equations 41 v_curr = A\ v_curr ; 42 % check if current iteration has to be stored 43 if mod( iter, output_ step ) == 44 curr_ slice = curr_ slice + 1; % move to next output slot 45 v_out (:, curr_ slice ) = v_ curr ; % store current solution 46 end 47 end In line 33 the new iteration matrix is assembled according to equation (6). In line 41 the multiplication of the field vector with the iteration matrix is replaced by the solution of a linear system of equations using Matlab s backslash operator. This selects an efficient algorithm automatically. 5

6 lateral position [µm] real part of field lateral position [µm] real part of field real part of field -2-1 implicit BTCS scheme initial field propagated field after 1µm waveguide mode (scaled) propagation distance [µm] lateral position [µm] Figure 4: Evolution of the field propagated with the implicit scheme using a propagation step size of Δz =.1 µm and a lateral step size of Δx = x a /(N x 1) =.2 µm. Figure 5: Plot of the field of figure 4 at z = 1 µm. implicit BTCS scheme propagation distance [µm] Figure 6: Evolution of the field over a longer propagation distance. The parameters are the same as in figure Results The implicit scheme is unconditionally stable. Hence, a larger propagation step size of Δz =.1 µm can be used for testing the implementation. The evolution of the propagated field is shown in figure 4. Despite the much larger step size it looks very similar to the result of the explicit method. Figure 5 shows the field after a propagation distance of 1 µm. The high frequency distortions of the explicit method are gone. The central part of the field distribution strongly resembles the waveguide mode while the oscillating sidelobes originate from the parts of the initial field that are not coupled to the waveguide. The dominance of the waveguide mode justifies the selection of the reference index of n d = which almost matches the effective index of the waveguide mode of n eff = Figure 6 shows the evolution of the field over a longer propagation distance. It reveals a fundamental flaw of our simple BPM implementation: It cannot simulate an infinite computational domain. When the scattered field that is not coupled to the waveguide reaches the boundaries, it is reflected at the perfectly conducting walls. It propagates back and forth in the computational domain and interferes with the waveguide mode. In most applications this behavior is undesirable. Hence, more sophisticated BPM implementations provide some kind of open boundaries, for example in 6

7 form of perfectly matched layers (PMLs), that do not reflect impinging waves but absorb them. 3 Task III: The Crank-Nicolson Scheme The implicit scheme is stable but the backward difference approximation is only first order accurate. The implicit scheme is also not energy conserving in the absence of absorption. These shortcomings are mended by the Crank-Nicolson (CN) scheme which uses a centered finite-difference approximation of the derivative in propagation direction. The field update of this scheme is given by v n+1 = ( I 1 2 ΔzL 1 ) ( I ΔzL ) vn = A 1 Bv n (7) which is a combination of the explicit and the implicit scheme. 3.1 Implementation The implementation of the CN scheme requires only very few changes with respect to the implementation of the implicit scheme. Instead of a single iteration matrix now two matrices A and B have to be assembled: beamprop_cn.m 32 % generate iteration matrices 33 % A = I -.5* dz*l and B = I +.5* dz*l 34 B =.5* dz* bpm_operator (dx,n,nd, lambda ); 35 A = speye ( Nx) - B; 36 B = speye ( Nx) + B; The update of the fields in the iteration loop has to be adapted to equation (7) as well: 42 for iter = 1 : Niter beamprop_cn.m 43 % advance field : solve tridiagonal system of equations 44 % parentheses around ( B* v_ curr ) are very important for efficiency 45 v_curr = A\(B* v_curr ); 46 % check if current iteration has to be stored 47 if mod( iter, output_ step ) == 48 curr_ slice = curr_ slice + 1; % move to next output slot 49 v_out (:, curr_ slice ) = v_ curr ; % store current solution 5 end 51 end The parentheses around the expression (B*v_curr) in line 45 are very important! Without them, Matlab left-divides B by A before multiplying with v_curr. This means solving N x linear systems and results in more densely populated matrix that has to be multiplied with v_curr. With parentheses, v_curr is multiplied with B first and a single tridiagonal system is solved with the resulting vector afterwards. This is much more efficient. 7

8 lateral position [µm] real part of field Crank-Nicolson scheme propagation distance [µm] Figure 7: Evolution of the field propagated with the Crank-Nicolson scheme using a propagation step size of Δz =.5 µm and a lateral step size of Δx = x a /(N x 1) =.2 µm. 3.2 Results The evolution of the field in the test geometry upon porpagation with the CN scheme is shown in figure 7. As the CN scheme is more accurate than the implicit scheme, the propagation step size was increased to Δz =.5 µm. The results are nearly identical to the result of the implicit scheme shown in figure 4. 4 Comparison of the Solution Schemes In the following sections we will take a closer look at the various aspects of the different schemes 4.1 Conservation of Energy First, we have a look sum of the squared magnitude of the field N x E(z) = v i (z) 2. (8) i=1 The test geometry does not contain absorbing materials or open boundaries. Hence, E(z) should be conserved upon propagation. Figure 8 shows the evolution of E(z) along the propagation distance for the different solution schemes and various propagation step sizes. Only the Crank-Nicolson scheme is energy conserving. The explicit scheme exhibits an exponential growth due to the instability that causes an amplification of high frequency noise. The amplification is stronger for larger propagation step sizes as it is indicated by equation (5). Also the implicit method does not conserve the field energy. Instead the solution is damped upon propagation. The damping is stronger for larger propagation step sizes. 8

9 sum of squared magnitude explicit scheme, dz=2.5nm explicit scheme, dz=1.nm implicit scheme, dz=1nm implicit scheme, dz=1nm Crank-Nicolson scheme, dz=5nm propagation distance [µm] Figure 8: Comparison of the total power of the field within the computational domain along the propagation distance for the different solution schemes and different propagation step sizes. 4.2 Covergence Finally, we have a look of the influence of the discretization onto the accuracy of the obtained solution. As the explicit method is unstable it does not make sense to investigate its accuracy. Only the implicit scheme and the Crank-Nicolson scheme are considered in the following. First, we will have a look at the influence of the propagation step size. To avoid any impact of the geometry we replace the discontinuous step index waveguide with a smooth Gaussian index distribution n(x) = exp ( x2 w 2 n ) (9) with w n = 2 µm. To avoid boundary effects, the width of the computational domain is chosen larger than the propagation length (x a = 5 µm, z end = 2 µm). The relative error e is given by the square root of sum of the squared magnitude of the difference between the propagated field v(z end ) and the true result v (z end ): N x e = v i (z end ) v i (z end ) 2. (1) i=1 The initial field was normalized to have a sum of the squared magnitude equal to unity. The true result was approximated by the result of the Crank-Nicolson scheme at the smallest step size. The lateral step size was set to Δx = 5 nm. Figure 9 shows the convergence of the two methods with respect to the propagation steps size together with according power law fits. As expected from the order of the finite-difference approximation of the z-derivative, the implicit scheme exhibits only a linear convergence while the Crank-Nicolson scheme converges quadratically. At very small steps sizes the Crank-Nicolson scheme is limited by the lateral resolution. Next, we investigate the influence of the lateral resolution. As the number of grid points is not constant in this experiment, the relative error cannot be calculated with equation (1). Instead it is 9

10 relative error relative error implicit scheme power law fit, k=.97 Crank-Nicolson scheme power law fit, k= implicit scheme Crank-Nicolson scheme power law fit, k= propagation step size / lateral step size lateral step size / propagation step size Figure 9: Convergence of the implicit and the Crank-Nicolson scheme in dependence of the propagation step size Δz. A Gaussian refractive index distribution with w n = 2 µm was assumed instead of the step index distribution of the original test geometry. The lateral step size was set to Δx = 5 nm. Figure 1: Convergence of the implicit and the Crank-Nicolson scheme in dependence of the lateral step size Δx. A Gaussian refractive index distribution with w n = 2 µm was assumed instead of the step index distribution of the original test geometry. The propagation step size was set to Δz = 5 nm. approximated by the value of the field in the center of the waveguide: e = v (N x 1)/2+1(z end ) v (N x 1)/2+1 (z end). (11) v (N x 1)/2+1 (z end ) For both methods the propagation step size was set to Δz = 5 nm. The results are shown in figure 1. Both schemes use the same discretization of the second derivative with respect to x, hence both schemes exhibit the expected quadratic convergence. However, the accuracy of implicit scheme is limited much earlier by the propagation step size than the accuracy of the Crank-Nicolson scheme. How does the convergence change when we use the original step index waveguide instead of the smooth Gaussian index distribution? The answer can be found in figures 11 and 12. The convergence with respect to the propagation step size is slowed for both methods but the Crank-Nicolson scheme still converges faster than the implicit scheme. The convergence with respect to the lateral resolution is also slowed and becomes very irregular as the actual width of the waveguide cannot be represented correctly at all resolutions. This example shows, that the true convergence of a numerical method is not only influenced by its mathematical properties but also by the actual geometry of the problem. Hence, convergence should be tested for each geometry individually. 1

11 relative error relative error implicit scheme power law fit, k=.63 Crank-Nicolson scheme power law fit, k= implicit scheme Crank-Nicolson scheme power law fit, k= propagation step size / lateral step size lateral step size / propagation step size Figure 11: Convergence of the implicit and the Crank-Nicolson scheme in dependence of the propagation step size Δz using the step index distribution of the original test geometry. The lateral step size was set to Δx = 5 nm. Figure 12: Convergence of the implicit and the Crank-Nicolson scheme in dependence of the lateral step size Δx using the step index distribution of the original test geometry. The propagation step size was set to Δz = 5 nm. 11

1 R.V k V k 1 / I.k/ here; we ll stimulate the action potential another way.) Note that this further simplifies to. m 3 k h k.

1 R.V k V k 1 / I.k/ here; we ll stimulate the action potential another way.) Note that this further simplifies to. m 3 k h k. 1. The goal of this problem is to simulate a propagating action potential for the Hodgkin-Huxley model and to determine the propagation speed. From the class notes, the discrete version (i.e., after breaking

More information

Lecture 4.5 Schemes for Parabolic Type Equations

Lecture 4.5 Schemes for Parabolic Type Equations Lecture 4.5 Schemes for Parabolic Type Equations 1 Difference Schemes for Parabolic Equations One-dimensional problems: Consider the unsteady diffusion problem (parabolic in nature) in a thin wire governed

More information

MIT (Spring 2014)

MIT (Spring 2014) 18.311 MIT (Spring 014) Rodolfo R. Rosales May 6, 014. Problem Set # 08. Due: Last day of lectures. IMPORTANT: Turn in the regular and the special problems stapled in two SEPARATE packages. Print your

More information

1 Finite difference example: 1D implicit heat equation

1 Finite difference example: 1D implicit heat equation 1 Finite difference example: 1D implicit heat equation 1.1 Boundary conditions Neumann and Dirichlet We solve the transient heat equation ρc p t = ( k ) (1) on the domain L/2 x L/2 subject to the following

More information

ME Computational Fluid Mechanics Lecture 5

ME Computational Fluid Mechanics Lecture 5 ME - 733 Computational Fluid Mechanics Lecture 5 Dr./ Ahmed Nagib Elmekawy Dec. 20, 2018 Elliptic PDEs: Finite Difference Formulation Using central difference formulation, the so called five-point formula

More information

The Interaction of Light and Matter: α and n

The Interaction of Light and Matter: α and n The Interaction of Light and Matter: α and n The interaction of light and matter is what makes life interesting. Everything we see is the result of this interaction. Why is light absorbed or transmitted

More information

STABILITY FOR PARABOLIC SOLVERS

STABILITY FOR PARABOLIC SOLVERS Review STABILITY FOR PARABOLIC SOLVERS School of Mathematics Semester 1 2008 OUTLINE Review 1 REVIEW 2 STABILITY: EXPLICIT METHOD Explicit Method as a Matrix Equation Growing Errors Stability Constraint

More information

Additive Manufacturing Module 8

Additive Manufacturing Module 8 Additive Manufacturing Module 8 Spring 2015 Wenchao Zhou zhouw@uark.edu (479) 575-7250 The Department of Mechanical Engineering University of Arkansas, Fayetteville 1 Evaluating design https://www.youtube.com/watch?v=p

More information

Finite Difference Methods (FDMs) 2

Finite Difference Methods (FDMs) 2 Finite Difference Methods (FDMs) 2 Time- dependent PDEs A partial differential equation of the form (15.1) where A, B, and C are constants, is called quasilinear. There are three types of quasilinear equations:

More information

Partial Differential Equations (PDEs) and the Finite Difference Method (FDM). An introduction

Partial Differential Equations (PDEs) and the Finite Difference Method (FDM). An introduction Page of 8 Partial Differential Equations (PDEs) and the Finite Difference Method (FDM). An introduction FILE:Chap 3 Partial Differential Equations-V6. Original: May 7, 05 Revised: Dec 9, 06, Feb 0, 07,

More information

Scientific Computing

Scientific Computing Scientific Computing Direct solution methods Martin van Gijzen Delft University of Technology October 3, 2018 1 Program October 3 Matrix norms LU decomposition Basic algorithm Cost Stability Pivoting Pivoting

More information

Simulation of CESR-c Luminosity from Beam Functions

Simulation of CESR-c Luminosity from Beam Functions Simulation of CESR-c Luminosity from Beam Functions Abhijit C. Mehta Trinity College, Duke University, Durham, North Carolina, 27708 (Dated: August 13, 2004) It is desirable to have the ability to compute

More information

Numerical Solution Techniques in Mechanical and Aerospace Engineering

Numerical Solution Techniques in Mechanical and Aerospace Engineering Numerical Solution Techniques in Mechanical and Aerospace Engineering Chunlei Liang LECTURE 3 Solvers of linear algebraic equations 3.1. Outline of Lecture Finite-difference method for a 2D elliptic PDE

More information

Assignment on iterative solution methods and preconditioning

Assignment on iterative solution methods and preconditioning Division of Scientific Computing, Department of Information Technology, Uppsala University Numerical Linear Algebra October-November, 2018 Assignment on iterative solution methods and preconditioning 1.

More information

BTCS Solution to the Heat Equation

BTCS Solution to the Heat Equation BTCS Solution to the Heat Equation ME 448/548 Notes Gerald Recktenwald Portland State University Department of Mechanical Engineering gerry@mepdxedu ME 448/548: BTCS Solution to the Heat Equation Overview

More information

Chapter 10 Exercises

Chapter 10 Exercises Chapter 10 Exercises From: Finite Difference Methods for Ordinary and Partial Differential Equations by R. J. LeVeque, SIAM, 2007. http://www.amath.washington.edu/ rl/fdmbook Exercise 10.1 (One-sided and

More information

6. Iterative Methods for Linear Systems. The stepwise approach to the solution...

6. Iterative Methods for Linear Systems. The stepwise approach to the solution... 6 Iterative Methods for Linear Systems The stepwise approach to the solution Miriam Mehl: 6 Iterative Methods for Linear Systems The stepwise approach to the solution, January 18, 2013 1 61 Large Sparse

More information

Numerical Solutions to Partial Differential Equations

Numerical Solutions to Partial Differential Equations Numerical Solutions to Partial Differential Equations Zhiping Li LMAM and School of Mathematical Sciences Peking University A Model Problem in a 2D Box Region Let us consider a model problem of parabolic

More information

Part 1. The diffusion equation

Part 1. The diffusion equation Differential Equations FMNN10 Graded Project #3 c G Söderlind 2016 2017 Published 2017-11-27. Instruction in computer lab 2017-11-30/2017-12-06/07. Project due date: Monday 2017-12-11 at 12:00:00. Goals.

More information

Finite Difference Methods (FDMs) 1

Finite Difference Methods (FDMs) 1 Finite Difference Methods (FDMs) 1 1 st - order Approxima9on Recall Taylor series expansion: Forward difference: Backward difference: Central difference: 2 nd - order Approxima9on Forward difference: Backward

More information

Lecture 4 Fiber Optical Communication Lecture 4, Slide 1

Lecture 4 Fiber Optical Communication Lecture 4, Slide 1 ecture 4 Dispersion in single-mode fibers Material dispersion Waveguide dispersion imitations from dispersion Propagation equations Gaussian pulse broadening Bit-rate limitations Fiber losses Fiber Optical

More information

Electromagnetic waves in free space

Electromagnetic waves in free space Waveguide notes 018 Electromagnetic waves in free space We start with Maxwell s equations for an LIH medum in the case that the source terms are both zero. = =0 =0 = = Take the curl of Faraday s law, then

More information

B 2 P 2, which implies that g B should be

B 2 P 2, which implies that g B should be Enhanced Summary of G.P. Agrawal Nonlinear Fiber Optics (3rd ed) Chapter 9 on SBS Stimulated Brillouin scattering is a nonlinear three-wave interaction between a forward-going laser pump beam P, a forward-going

More information

Numerical algorithms for one and two target optimal controls

Numerical algorithms for one and two target optimal controls Numerical algorithms for one and two target optimal controls Sung-Sik Kwon Department of Mathematics and Computer Science, North Carolina Central University 80 Fayetteville St. Durham, NC 27707 Email:

More information

Designing Information Devices and Systems I Spring 2018 Lecture Notes Note Introduction to Linear Algebra the EECS Way

Designing Information Devices and Systems I Spring 2018 Lecture Notes Note Introduction to Linear Algebra the EECS Way EECS 16A Designing Information Devices and Systems I Spring 018 Lecture Notes Note 1 1.1 Introduction to Linear Algebra the EECS Way In this note, we will teach the basics of linear algebra and relate

More information

A Fast Fourier transform based direct solver for the Helmholtz problem. AANMPDE 2017 Palaiochora, Crete, Oct 2, 2017

A Fast Fourier transform based direct solver for the Helmholtz problem. AANMPDE 2017 Palaiochora, Crete, Oct 2, 2017 A Fast Fourier transform based direct solver for the Helmholtz problem Jari Toivanen Monika Wolfmayr AANMPDE 2017 Palaiochora, Crete, Oct 2, 2017 Content 1 Model problem 2 Discretization 3 Fast solver

More information

1 The formation and analysis of optical waveguides

1 The formation and analysis of optical waveguides 1 The formation and analysis of optical waveguides 1.1 Introduction to optical waveguides Optical waveguides are made from material structures that have a core region which has a higher index of refraction

More information

Course Notes: Week 1

Course Notes: Week 1 Course Notes: Week 1 Math 270C: Applied Numerical Linear Algebra 1 Lecture 1: Introduction (3/28/11) We will focus on iterative methods for solving linear systems of equations (and some discussion of eigenvalues

More information

Finite Difference Method for PDE. Y V S S Sanyasiraju Professor, Department of Mathematics IIT Madras, Chennai 36

Finite Difference Method for PDE. Y V S S Sanyasiraju Professor, Department of Mathematics IIT Madras, Chennai 36 Finite Difference Method for PDE Y V S S Sanyasiraju Professor, Department of Mathematics IIT Madras, Chennai 36 1 Classification of the Partial Differential Equations Consider a scalar second order partial

More information

Numerical Linear Algebra

Numerical Linear Algebra Numerical Linear Algebra Decompositions, numerical aspects Gerard Sleijpen and Martin van Gijzen September 27, 2017 1 Delft University of Technology Program Lecture 2 LU-decomposition Basic algorithm Cost

More information

Program Lecture 2. Numerical Linear Algebra. Gaussian elimination (2) Gaussian elimination. Decompositions, numerical aspects

Program Lecture 2. Numerical Linear Algebra. Gaussian elimination (2) Gaussian elimination. Decompositions, numerical aspects Numerical Linear Algebra Decompositions, numerical aspects Program Lecture 2 LU-decomposition Basic algorithm Cost Stability Pivoting Cholesky decomposition Sparse matrices and reorderings Gerard Sleijpen

More information

Numerical Methods I Non-Square and Sparse Linear Systems

Numerical Methods I Non-Square and Sparse Linear Systems Numerical Methods I Non-Square and Sparse Linear Systems Aleksandar Donev Courant Institute, NYU 1 donev@courant.nyu.edu 1 MATH-GA 2011.003 / CSCI-GA 2945.003, Fall 2014 September 25th, 2014 A. Donev (Courant

More information

IDR(s) Master s thesis Goushani Kisoensingh. Supervisor: Gerard L.G. Sleijpen Department of Mathematics Universiteit Utrecht

IDR(s) Master s thesis Goushani Kisoensingh. Supervisor: Gerard L.G. Sleijpen Department of Mathematics Universiteit Utrecht IDR(s) Master s thesis Goushani Kisoensingh Supervisor: Gerard L.G. Sleijpen Department of Mathematics Universiteit Utrecht Contents 1 Introduction 2 2 The background of Bi-CGSTAB 3 3 IDR(s) 4 3.1 IDR.............................................

More information

Designing Information Devices and Systems I Fall 2018 Lecture Notes Note Introduction to Linear Algebra the EECS Way

Designing Information Devices and Systems I Fall 2018 Lecture Notes Note Introduction to Linear Algebra the EECS Way EECS 16A Designing Information Devices and Systems I Fall 018 Lecture Notes Note 1 1.1 Introduction to Linear Algebra the EECS Way In this note, we will teach the basics of linear algebra and relate it

More information

Notes for CS542G (Iterative Solvers for Linear Systems)

Notes for CS542G (Iterative Solvers for Linear Systems) Notes for CS542G (Iterative Solvers for Linear Systems) Robert Bridson November 20, 2007 1 The Basics We re now looking at efficient ways to solve the linear system of equations Ax = b where in this course,

More information

A comparative study of higher order Bragg waveguide gratings using coupled mode theory and mode expansion modeling. H. Wenzel and R.

A comparative study of higher order Bragg waveguide gratings using coupled mode theory and mode expansion modeling. H. Wenzel and R. A comparative study of higher order Bragg waveguide gratings using coupled mode theory and mode expansion modeling H. Wenzel and R. Güther Motivation Widespread application of Bragg waveguide gratings

More information

DOING PHYSICS WITH MATLAB

DOING PHYSICS WITH MATLAB DOING PHYSICS WITH MATLAB ELECTROMAGNETISM USING THE FDTD METHOD [1D] Propagation of Electromagnetic Waves Matlab Download Director ft_3.m ft_sources.m Download and run the script ft_3.m. Carefull inspect

More information

5 Ordinary Differential Equations: Finite Difference Methods for Boundary Problems

5 Ordinary Differential Equations: Finite Difference Methods for Boundary Problems 5 Ordinary Differential Equations: Finite Difference Metods for Boundary Problems Read sections 10.1, 10.2, 10.4 Review questions 10.1 10.4, 10.8 10.9, 10.13 5.1 Introduction In te previous capters we

More information

Ordinary Differential Equations

Ordinary Differential Equations Ordinary Differential Equations We call Ordinary Differential Equation (ODE) of nth order in the variable x, a relation of the kind: where L is an operator. If it is a linear operator, we call the equation

More information

Chapter Two: Numerical Methods for Elliptic PDEs. 1 Finite Difference Methods for Elliptic PDEs

Chapter Two: Numerical Methods for Elliptic PDEs. 1 Finite Difference Methods for Elliptic PDEs Chapter Two: Numerical Methods for Elliptic PDEs Finite Difference Methods for Elliptic PDEs.. Finite difference scheme. We consider a simple example u := subject to Dirichlet boundary conditions ( ) u

More information

Multi-Factor Finite Differences

Multi-Factor Finite Differences February 17, 2017 Aims and outline Finite differences for more than one direction The θ-method, explicit, implicit, Crank-Nicolson Iterative solution of discretised equations Alternating directions implicit

More information

Gaussian beam diffraction in inhomogeneous media of cylindrical symmetry

Gaussian beam diffraction in inhomogeneous media of cylindrical symmetry Optica Applicata, Vol. XL, No. 3, 00 Gaussian beam diffraction in inhomogeneous media of cylindrical symmetry PAWEŁ BERCZYŃSKI, YURI A. KRAVTSOV, 3, GRZEGORZ ŻEGLIŃSKI 4 Institute of Physics, West Pomeranian

More information

Computational Methods CMSC/AMSC/MAPL 460. Eigenvalues and Eigenvectors. Ramani Duraiswami, Dept. of Computer Science

Computational Methods CMSC/AMSC/MAPL 460. Eigenvalues and Eigenvectors. Ramani Duraiswami, Dept. of Computer Science Computational Methods CMSC/AMSC/MAPL 460 Eigenvalues and Eigenvectors Ramani Duraiswami, Dept. of Computer Science Eigen Values of a Matrix Recap: A N N matrix A has an eigenvector x (non-zero) with corresponding

More information

JMBC Computational Fluid Dynamics I Exercises by A.E.P. Veldman

JMBC Computational Fluid Dynamics I Exercises by A.E.P. Veldman JMBC Computational Fluid Dynamics I Exercises by A.E.P. Veldman The exercises will be carried out on PC s in the practicum rooms. Several (Matlab and Fortran) files are required. How these can be obtained

More information

Chapter 9 Implicit Methods for Linear and Nonlinear Systems of ODEs

Chapter 9 Implicit Methods for Linear and Nonlinear Systems of ODEs Chapter 9 Implicit Methods for Linear and Nonlinear Systems of ODEs In the previous chapter, we investigated stiffness in ODEs. Recall that an ODE is stiff if it exhibits behavior on widelyvarying timescales.

More information

Sparse Linear Systems. Iterative Methods for Sparse Linear Systems. Motivation for Studying Sparse Linear Systems. Partial Differential Equations

Sparse Linear Systems. Iterative Methods for Sparse Linear Systems. Motivation for Studying Sparse Linear Systems. Partial Differential Equations Sparse Linear Systems Iterative Methods for Sparse Linear Systems Matrix Computations and Applications, Lecture C11 Fredrik Bengzon, Robert Söderlund We consider the problem of solving the linear system

More information

Coordinate Update Algorithm Short Course The Package TMAC

Coordinate Update Algorithm Short Course The Package TMAC Coordinate Update Algorithm Short Course The Package TMAC Instructor: Wotao Yin (UCLA Math) Summer 2016 1 / 16 TMAC: A Toolbox of Async-Parallel, Coordinate, Splitting, and Stochastic Methods C++11 multi-threading

More information

Math 471 (Numerical methods) Chapter 3 (second half). System of equations

Math 471 (Numerical methods) Chapter 3 (second half). System of equations Math 47 (Numerical methods) Chapter 3 (second half). System of equations Overlap 3.5 3.8 of Bradie 3.5 LU factorization w/o pivoting. Motivation: ( ) A I Gaussian Elimination (U L ) where U is upper triangular

More information

JACOBI S ITERATION METHOD

JACOBI S ITERATION METHOD ITERATION METHODS These are methods which compute a sequence of progressively accurate iterates to approximate the solution of Ax = b. We need such methods for solving many large linear systems. Sometimes

More information

Lecture Notes on Numerical Schemes for Flow and Transport Problems

Lecture Notes on Numerical Schemes for Flow and Transport Problems Lecture Notes on Numerical Schemes for Flow and Transport Problems by Sri Redeki Pudaprasetya sr pudap@math.itb.ac.id Department of Mathematics Faculty of Mathematics and Natural Sciences Bandung Institute

More information

Math 56 Homework 1 Michael Downs. ne n 10 + ne n (1)

Math 56 Homework 1 Michael Downs. ne n 10 + ne n (1) . Problem (a) Yes. The following equation: ne n + ne n () holds for all n R but, since we re only concerned with the asymptotic behavior as n, let us only consider n >. Dividing both sides by n( + ne n

More information

Applied Linear Algebra in Geoscience Using MATLAB

Applied Linear Algebra in Geoscience Using MATLAB Applied Linear Algebra in Geoscience Using MATLAB Contents Getting Started Creating Arrays Mathematical Operations with Arrays Using Script Files and Managing Data Two-Dimensional Plots Programming in

More information

Lecture Notes on Numerical Schemes for Flow and Transport Problems

Lecture Notes on Numerical Schemes for Flow and Transport Problems Lecture Notes on Numerical Schemes for Flow and Transport Problems by Sri Redeki Pudaprasetya sr pudap@math.itb.ac.id Department of Mathematics Faculty of Mathematics and Natural Sciences Bandung Institute

More information

Finite Difference Methods for

Finite Difference Methods for CE 601: Numerical Methods Lecture 33 Finite Difference Methods for PDEs Course Coordinator: Course Coordinator: Dr. Suresh A. Kartha, Associate Professor, Department of Civil Engineering, IIT Guwahati.

More information

Quantum Mechanics for Scientists and Engineers. David Miller

Quantum Mechanics for Scientists and Engineers. David Miller Quantum Mechanics for Scientists and Engineers David Miller Wavepackets Wavepackets Group velocity Group velocity Consider two waves at different frequencies 1 and 2 and suppose that the wave velocity

More information

Advanced Partial Differential Equations with Applications

Advanced Partial Differential Equations with Applications MIT OpenCourseWare http://ocw.mit.edu 8.36 Advanced Partial Differential Equations with Applications Fall 9 For information about citing these materials or our Terms of Use, visit: http://ocw.mit.edu/terms.

More information

Numerical Methods I: Numerical linear algebra

Numerical Methods I: Numerical linear algebra 1/3 Numerical Methods I: Numerical linear algebra Georg Stadler Courant Institute, NYU stadler@cimsnyuedu September 1, 017 /3 We study the solution of linear systems of the form Ax = b with A R n n, x,

More information

x x2 2 + x3 3 x4 3. Use the divided-difference method to find a polynomial of least degree that fits the values shown: (b)

x x2 2 + x3 3 x4 3. Use the divided-difference method to find a polynomial of least degree that fits the values shown: (b) Numerical Methods - PROBLEMS. The Taylor series, about the origin, for log( + x) is x x2 2 + x3 3 x4 4 + Find an upper bound on the magnitude of the truncation error on the interval x.5 when log( + x)

More information

Discrete Simulation of Power Law Noise

Discrete Simulation of Power Law Noise Discrete Simulation of Power Law Noise Neil Ashby 1,2 1 University of Colorado, Boulder, CO 80309-0390 USA 2 National Institute of Standards and Technology, Boulder, CO 80305 USA ashby@boulder.nist.gov

More information

6 The SVD Applied to Signal and Image Deblurring

6 The SVD Applied to Signal and Image Deblurring 6 The SVD Applied to Signal and Image Deblurring We will discuss the restoration of one-dimensional signals and two-dimensional gray-scale images that have been contaminated by blur and noise. After an

More information

SPRING 2006 PRELIMINARY EXAMINATION SOLUTIONS

SPRING 2006 PRELIMINARY EXAMINATION SOLUTIONS SPRING 006 PRELIMINARY EXAMINATION SOLUTIONS 1A. Let G be the subgroup of the free abelian group Z 4 consisting of all integer vectors (x, y, z, w) such that x + 3y + 5z + 7w = 0. (a) Determine a linearly

More information

Exponentially Convergent Sparse Discretizations and Application to Near Surface Geophysics

Exponentially Convergent Sparse Discretizations and Application to Near Surface Geophysics Exponentially Convergent Sparse Discretizations and Application to Near Surface Geophysics Murthy N. Guddati North Carolina State University November 9, 017 Outline Part 1: Impedance Preserving Discretization

More information

Lecture 03 Positive Semidefinite (PSD) and Positive Definite (PD) Matrices and their Properties

Lecture 03 Positive Semidefinite (PSD) and Positive Definite (PD) Matrices and their Properties Applied Optimization for Wireless, Machine Learning, Big Data Prof. Aditya K. Jagannatham Department of Electrical Engineering Indian Institute of Technology, Kanpur Lecture 03 Positive Semidefinite (PSD)

More information

Machine Learning. Kernels. Fall (Kernels, Kernelized Perceptron and SVM) Professor Liang Huang. (Chap. 12 of CIML)

Machine Learning. Kernels. Fall (Kernels, Kernelized Perceptron and SVM) Professor Liang Huang. (Chap. 12 of CIML) Machine Learning Fall 2017 Kernels (Kernels, Kernelized Perceptron and SVM) Professor Liang Huang (Chap. 12 of CIML) Nonlinear Features x4: -1 x1: +1 x3: +1 x2: -1 Concatenated (combined) features XOR:

More information

Name: INSERT YOUR NAME HERE. Due to dropbox by 6pm PDT, Wednesday, December 14, 2011

Name: INSERT YOUR NAME HERE. Due to dropbox by 6pm PDT, Wednesday, December 14, 2011 AMath 584 Name: INSERT YOUR NAME HERE Take-home Final UWNetID: INSERT YOUR NETID Due to dropbox by 6pm PDT, Wednesday, December 14, 2011 The main part of the assignment (Problems 1 3) is worth 80 points.

More information

LU Factorization. Marco Chiarandini. DM559 Linear and Integer Programming. Department of Mathematics & Computer Science University of Southern Denmark

LU Factorization. Marco Chiarandini. DM559 Linear and Integer Programming. Department of Mathematics & Computer Science University of Southern Denmark DM559 Linear and Integer Programming LU Factorization Marco Chiarandini Department of Mathematics & Computer Science University of Southern Denmark [Based on slides by Lieven Vandenberghe, UCLA] Outline

More information

Solving large scale eigenvalue problems

Solving large scale eigenvalue problems arge scale eigenvalue problems, Lecture 4, March 14, 2018 1/41 Lecture 4, March 14, 2018: The QR algorithm http://people.inf.ethz.ch/arbenz/ewp/ Peter Arbenz Computer Science Department, ETH Zürich E-mail:

More information

Extreme Values and Positive/ Negative Definite Matrix Conditions

Extreme Values and Positive/ Negative Definite Matrix Conditions Extreme Values and Positive/ Negative Definite Matrix Conditions James K. Peterson Department of Biological Sciences and Department of Mathematical Sciences Clemson University November 8, 016 Outline 1

More information

Bindel, Fall 2016 Matrix Computations (CS 6210) Notes for

Bindel, Fall 2016 Matrix Computations (CS 6210) Notes for 1 Logistics Notes for 2016-08-26 1. Our enrollment is at 50, and there are still a few students who want to get in. We only have 50 seats in the room, and I cannot increase the cap further. So if you are

More information

AIMS Exercise Set # 1

AIMS Exercise Set # 1 AIMS Exercise Set #. Determine the form of the single precision floating point arithmetic used in the computers at AIMS. What is the largest number that can be accurately represented? What is the smallest

More information

EXAMPLES OF CLASSICAL ITERATIVE METHODS

EXAMPLES OF CLASSICAL ITERATIVE METHODS EXAMPLES OF CLASSICAL ITERATIVE METHODS In these lecture notes we revisit a few classical fixpoint iterations for the solution of the linear systems of equations. We focus on the algebraic and algorithmic

More information

Lecture 3 Numerical Solutions to the Transport Equation

Lecture 3 Numerical Solutions to the Transport Equation Lecture 3 Numerical Solutions to the Transport Equation Introduction I There are numerous methods for solving the transport problem numerically. First we must recognize that we need to solve two problems:

More information

8 The SVD Applied to Signal and Image Deblurring

8 The SVD Applied to Signal and Image Deblurring 8 The SVD Applied to Signal and Image Deblurring We will discuss the restoration of one-dimensional signals and two-dimensional gray-scale images that have been contaminated by blur and noise. After an

More information

Geometric Modeling Summer Semester 2010 Mathematical Tools (1)

Geometric Modeling Summer Semester 2010 Mathematical Tools (1) Geometric Modeling Summer Semester 2010 Mathematical Tools (1) Recap: Linear Algebra Today... Topics: Mathematical Background Linear algebra Analysis & differential geometry Numerical techniques Geometric

More information

Efficient gradient computation of a misfit function for FWI using the adjoint method

Efficient gradient computation of a misfit function for FWI using the adjoint method Efficient gradient computation of a misfit function for FWI using the adjoint method B. Galuzzi, department of Earth Sciences A. Desio, University of Milan E. Stucchi, department of Earth Sciences A. Desio,

More information

Diffusion / Parabolic Equations. PHY 688: Numerical Methods for (Astro)Physics

Diffusion / Parabolic Equations. PHY 688: Numerical Methods for (Astro)Physics Diffusion / Parabolic Equations Summary of PDEs (so far...) Hyperbolic Think: advection Real, finite speed(s) at which information propagates carries changes in the solution Second-order explicit methods

More information

Photon Physics. Week 4 26/02/2013

Photon Physics. Week 4 26/02/2013 Photon Physics Week 4 6//13 1 Classical atom-field interaction Lorentz oscillator: Classical electron oscillator with frequency ω and damping constant γ Eqn of motion: Final result: Classical atom-field

More information

Exploring the energy landscape

Exploring the energy landscape Exploring the energy landscape ChE210D Today's lecture: what are general features of the potential energy surface and how can we locate and characterize minima on it Derivatives of the potential energy

More information

1.6: 16, 20, 24, 27, 28

1.6: 16, 20, 24, 27, 28 .6: 6, 2, 24, 27, 28 6) If A is positive definite, then A is positive definite. The proof of the above statement can easily be shown for the following 2 2 matrix, a b A = b c If that matrix is positive

More information

Advanced Engineering Mathematics Prof. Pratima Panigrahi Department of Mathematics Indian Institute of Technology, Kharagpur

Advanced Engineering Mathematics Prof. Pratima Panigrahi Department of Mathematics Indian Institute of Technology, Kharagpur Advanced Engineering Mathematics Prof. Pratima Panigrahi Department of Mathematics Indian Institute of Technology, Kharagpur Lecture No. #07 Jordan Canonical Form Cayley Hamilton Theorem (Refer Slide Time:

More information

Lecture 18 Classical Iterative Methods

Lecture 18 Classical Iterative Methods Lecture 18 Classical Iterative Methods MIT 18.335J / 6.337J Introduction to Numerical Methods Per-Olof Persson November 14, 2006 1 Iterative Methods for Linear Systems Direct methods for solving Ax = b,

More information

7 Mathematical Methods 7.6 Insulation (10 units)

7 Mathematical Methods 7.6 Insulation (10 units) 7 Mathematical Methods 7.6 Insulation (10 units) There are no prerequisites for this project. 1 Introduction When sheets of plastic and of other insulating materials are used in the construction of building

More information

Toward a Theory of Coherent Synchrotron Radiation in Realistic Vacuum Chambers

Toward a Theory of Coherent Synchrotron Radiation in Realistic Vacuum Chambers Toward a Theory of Coherent Synchrotron Radiation in Realistic Vacuum Chambers R. Warnock, SLAC National Accelerator Laboratory and Dept. of Mathematics and Statistics, U. of New Mexico Sincere thanks

More information

Platzhalter für Bild, Bild auf Titelfolie hinter das Logo einsetzen

Platzhalter für Bild, Bild auf Titelfolie hinter das Logo einsetzen Platzhalter für Bild, Bild auf Titelfolie hinter das Logo einsetzen Introduction to PDEs and Numerical Methods Lecture 6: Numerical solution of the heat equation with FD method: method of lines, Euler

More information

EXAMPLES OF MORDELL S EQUATION

EXAMPLES OF MORDELL S EQUATION EXAMPLES OF MORDELL S EQUATION KEITH CONRAD 1. Introduction The equation y 2 = x 3 +k, for k Z, is called Mordell s equation 1 on account of Mordell s long interest in it throughout his life. A natural

More information

Stability of Krylov Subspace Spectral Methods

Stability of Krylov Subspace Spectral Methods Stability of Krylov Subspace Spectral Methods James V. Lambers Department of Energy Resources Engineering Stanford University includes joint work with Patrick Guidotti and Knut Sølna, UC Irvine Margot

More information

Math 471 (Numerical methods) Chapter 4. Eigenvalues and Eigenvectors

Math 471 (Numerical methods) Chapter 4. Eigenvalues and Eigenvectors Math 471 (Numerical methods) Chapter 4. Eigenvalues and Eigenvectors Overlap 4.1 4.3 of Bradie 4.0 Review on eigenvalues and eigenvectors Definition. A nonzero vector v is called an eigenvector of A if

More information

CERN Accelerator School Wakefields. Prof. Dr. Ursula van Rienen, Franziska Reimann University of Rostock

CERN Accelerator School Wakefields. Prof. Dr. Ursula van Rienen, Franziska Reimann University of Rostock CERN Accelerator School Wakefields Prof. Dr. Ursula van Rienen, Franziska Reimann University of Rostock Contents The Term Wakefield and Some First Examples Basic Concept of Wakefields Basic Definitions

More information

Chapter 9 Implicit integration, incompressible flows

Chapter 9 Implicit integration, incompressible flows Chapter 9 Implicit integration, incompressible flows The methods we discussed so far work well for problems of hydrodynamics in which the flow speeds of interest are not orders of magnitude smaller than

More information

A Hybrid Method for the Wave Equation. beilina

A Hybrid Method for the Wave Equation.   beilina A Hybrid Method for the Wave Equation http://www.math.unibas.ch/ beilina 1 The mathematical model The model problem is the wave equation 2 u t 2 = (a 2 u) + f, x Ω R 3, t > 0, (1) u(x, 0) = 0, x Ω, (2)

More information

ANONSINGULAR tridiagonal linear system of the form

ANONSINGULAR tridiagonal linear system of the form Generalized Diagonal Pivoting Methods for Tridiagonal Systems without Interchanges Jennifer B. Erway, Roummel F. Marcia, and Joseph A. Tyson Abstract It has been shown that a nonsingular symmetric tridiagonal

More information

Statistical Geometry Processing Winter Semester 2011/2012

Statistical Geometry Processing Winter Semester 2011/2012 Statistical Geometry Processing Winter Semester 2011/2012 Linear Algebra, Function Spaces & Inverse Problems Vector and Function Spaces 3 Vectors vectors are arrows in space classically: 2 or 3 dim. Euclidian

More information

5. Direct Methods for Solving Systems of Linear Equations. They are all over the place...

5. Direct Methods for Solving Systems of Linear Equations. They are all over the place... 5 Direct Methods for Solving Systems of Linear Equations They are all over the place Miriam Mehl: 5 Direct Methods for Solving Systems of Linear Equations They are all over the place, December 13, 2012

More information

Deep Learning. Authors: I. Goodfellow, Y. Bengio, A. Courville. Chapter 4: Numerical Computation. Lecture slides edited by C. Yim. C.

Deep Learning. Authors: I. Goodfellow, Y. Bengio, A. Courville. Chapter 4: Numerical Computation. Lecture slides edited by C. Yim. C. Chapter 4: Numerical Computation Deep Learning Authors: I. Goodfellow, Y. Bengio, A. Courville Lecture slides edited by 1 Chapter 4: Numerical Computation 4.1 Overflow and Underflow 4.2 Poor Conditioning

More information

Numerical Solution of partial differential equations

Numerical Solution of partial differential equations G. D. SMITH Brunei University Numerical Solution of partial differential equations FINITE DIFFERENCE METHODS THIRD EDITION CLARENDON PRESS OXFORD Contents NOTATION 1. INTRODUCTION AND FINITE-DIFFERENCE

More information

THE beam propagation method (BPM) is at present the

THE beam propagation method (BPM) is at present the JOURNAL OF LIGHTWAVE TECHNOLOGY, VOL. 17, NO. 11, NOVEMBER 1999 2389 Three-Dimensional Noniterative Full-Vectorial Beam Propagation Method Based on the Alternating Direction Implicit Method Yu-li Hsueh,

More information

Scientific Computing: Solving Linear Systems

Scientific Computing: Solving Linear Systems Scientific Computing: Solving Linear Systems Aleksandar Donev Courant Institute, NYU 1 donev@courant.nyu.edu 1 Course MATH-GA.2043 or CSCI-GA.2112, Spring 2012 September 17th and 24th, 2015 A. Donev (Courant

More information

An explicit time-domain finite-element method for room acoustics simulation

An explicit time-domain finite-element method for room acoustics simulation An explicit time-domain finite-element method for room acoustics simulation Takeshi OKUZONO 1 ; Toru OTSURU 2 ; Kimihiro SAKAGAMI 3 1 Kobe University, JAPAN 2 Oita University, JAPAN 3 Kobe University,

More information

A Class of Fast Methods for Processing Irregularly Sampled. or Otherwise Inhomogeneous One-Dimensional Data. Abstract

A Class of Fast Methods for Processing Irregularly Sampled. or Otherwise Inhomogeneous One-Dimensional Data. Abstract A Class of Fast Methods for Processing Irregularly Sampled or Otherwise Inhomogeneous One-Dimensional Data George B. Rybicki and William H. Press Harvard-Smithsonian Center for Astrophysics, 60 Garden

More information

Optical modelling of photonic crystals

Optical modelling of photonic crystals Optical and Quantum Electronics 33: 327±341, 2001. Ó 2001 Kluwer Academic Publishers. Printed in the Netherlands. 327 Optical modelling of photonic crystals and VCSELs using eigenmode expansion and perfectly

More information