A Crash Course on Fast Multipole Method (FMM)

Size: px
Start display at page:

Download "A Crash Course on Fast Multipole Method (FMM)"

Transcription

1 A Crash Course on Fast Multipole Method (FMM) Hanliang Guo Kanso Biodynamical System Lab, 2018 April

2 What is FMM? A fast algorithm to study N body interactions (Gravitational, Coulombic interactions ) 2

3 Top 10 algorithms in the 20th century* Metropolis Algorithm for Monte Carlo Simplex Method for Linear Programming Krylov Subspace Iteration Methods The Decompositional Approach to Matrix Computations The Fortran Optimizing Compiler QR Algorithm for Computing Eigenvalues Quicksort Algorithm for Sorting Fast Fourier transform Integer Relation Detection Fast Multipole Method *:chronological order J. Dongarra & F. Sullivan, Computing in Science & Engineering, (2000) 3

4 What is FMM? N body interactions (Coulombic, Gravitational interactions ) Reduces complexity from O(N 2 ) to O(N) An approximation with well defined error tolerance Not (too) difficult to implement Exists libraries to use directly 4

5 Goal for this course Learn: Understand the algorithm (Why is it accurate Why is it fast ) Get a hand on my toy FMM code (matlab) How to use existing libraries Future: Adaptive mesh Periodic boundary conditions 5

6 Outline Complexity Multipole expansion Coarse graining N log(n) algorithm Fast multipole method (FMM) Application to Stokes flow Kernel independent FMM (KIFMM) 6

7 Complexity How computational cost scales with the problem size Does not care the constant factor Extremely important for large N O(N 2 ) complexity is usually considered infeasible! The constant factor is also very important in practice A naive implementation of N body interaction problem has O(N 2 ) complexity 7

8 A working example N source points with charges qi Want to know: Potential and electrostatic forces at N target points Assume target points and source points are the same (not necessary) Away from source point: x o (x) = log(kx x o k) E xo (x) = x x o kx x o k 2 N=400 8

9 A working example N source points with charges qi Want to know: Potential and electrostatic forces at N target points Assume target points and source points are the same (not necessary) Away from source point: x o (x) =Re( log(z z o )) E xo (x) =r xo (x) N=400 9

10 Multipole expansion Suppose that m charges of strengths {qi, i=1,,m} are located at points {zi, i=1,,m}, with zi <r. Then for any z with z >r, the potential \phi(z) induced by the charges is given by z q i,z i r Q = (z) =Q log(z)+ mx i=1 q i a k = Proof 1X k=1 mx i=1 a k z k Can we truncate the infinite series with a known error tolerance? q i z k i k 10

11 Error bound For any p>=1, z (z) Q log(z) px k=1 a k z k apple 1 apple p +1 r z A p +1 p+1 1 c 1 1 c p cr c = z r, A = m X i=1 q i, = A 1 r z q i,z i r For any tolerance \epsilon, choose p s.t. p = log c 11

12 A naive coarse graining method Group particles in each box as clusters. Form a multipole expansion for each box. Compute interactions between distant clusters when possible. Add far-field and direct nearfield (direct computations) together. Complexity is still O(N 2 )! The constant factor could be reduced. 12

13 N log(n) algorithm Divide and conquer! Consider clusters of particles at successive levels of spatial refinement, and to compute interactions between distant clusters by means of expansions when possible. 13

14 N log(n) algorithm Near neighbors: two boxes are at the same refinement level and share a boundary point Well separated: two boxes are at same refinement level and are not near neighbors Interaction list: box i s interaction list consists of the children of the near neighbors of i s parent which are well separated from box i. 14

15 N log(n) algorithm Near neighbors: two boxes are at the same refinement level and share a boundary point Well separated: two boxes are at same refinement level and are not near neighbors Maximum size of interaction list is 27 Interaction list: box i s interaction list consists of the children of the near neighbors of i s parent which are well separated from box i. 15

16 N log(n) algorithm At every level, the multipole expansion is formed for each box due to the particles it contains. The resulting expansion is then evaluated for each particle in the region covered by its interaction list. Halt the recursive process after roughly log(n) levels of refinement. At the finest level, compute interactions between nearest neighbors. Operation count 16

17 Fast multipole method (FMM) Can we do better than Nlog(N)? The previous algorithm is of Nlog(N) complexity because all particles are accessed at every level of refinement. We can avoid this by some more analytical manipulations. In particular Translation of a multipole expansion (M2M) Conversion of a multipole expansion into a local expansion (M2L) Translation of a local expansion (L2L) 17

18 Translation of a multipole expansion (M2M) Suppose that (z) =a o log(z z o )+ is a multipole expansion of the potential due to a set of m charges of strengths q1,q2,,qm, all of which are located inside the circle D of radius R with center at zo. 1X k=1 a k (z z o ) k q i,z i D z R R + z o z o O D 1 Then for z outside the circle D1 of radius (R+ zo ) and center at the origin, where b l = (z) =a o log(z)+ a oz l o l + lx k=1 a k z l o Proof k 1X l=1 b l z l l 1 k 1 18

19 Error bound of M2M For any p>=1, (z) a o log(z) px l=1 b l z l apple 1 A z o +R z 1 A z o + R z p+1 mx z A = q i q i,z i D R R + z o z o O D 1 (z) i=1 Similar to the multipole expansion Q log(z) px k=1 a k z k apple 1 apple p +1 r z A p +1 p+1 1 c 1 p 1 c 19

20 Conversion of a multipole expansion into a local expansion (M2L) Suppose that m charges of strengths q1,q2,,qm are located inside the circle D1 with radius R and center zo, and that zo =(c+1)r with c>1. Then the 1X a k corresponding multipole expansion (z) =a o log(z z o )+ (z z o ) k k=1 converges inside the circle D2 of radius R centered about the origin. Inside D2, the potential due to the charges is described by a power series: z o R q i,z i z O R b l = (z) = 1X l=0 1X b o = a o log( z o )+ a o lzo l + 1 z l o 1X k=1 a k z k o k=1 b l z l a k z k o l + k 1 k 1 ( 1) k ( 1) k 20

21 Error bounds of M2L (z) px l=0 b l z l < A(4e(p + c)(c + 1) + c2 ) c(c 1) 1 c p+1 (c>1) z o R q i,z i z Proof See Greengard & Rokhlin JCP 1987 O R 21

22 Translation of a local expansion (L2L) For any complex zo, z, and {ak}, k=0,1,2,,n, nx nx nx a k (z z o ) k k = a k l k=0 l=0 k=l ( z o ) k l! z l nx k=0 z o a k (z z o ) k the origin. Expand series close to O Immediate results of Maclaurin series. No error bound needed! 22

23 More generally (in case you want to code) Multipole expansion about zc: (z) =a o log(z z C )+ a o = mx q j, a k = j=1 mx j=1 px k=1 a k rp + O( (z z C ) k R p ) q j (z j k z C ) k M2M from zc to zm: (z) =b o log(z z M )+ b o = a o, b l = a o(z C z M ) l l + px l=1 lx k=1 b l (z z M ) l + O( ) a k (z C z M ) l k l 1 k 1 M2L from zm to zl: (z) = px c l (z z L ) l + O( ) c o = b o log(z L z M )+ px k=1 ( 1) k b k (z M z L ) k, c l = l=0 b o l(z M z L ) l + 1 (z M z L ) l px k=1 ( 1) k b k (z M z L ) k l + k 1 k 1 L2L from zl to zt: d l = px (z) = d l (z z T ) l px k c k l k=1 l=0 (z T z L ) k l Ying et al. JCP (2004) 23

24 The fast part! If we know the multipole expansion for all children boxes, we can get the multipole expansion for the parent box by doing M2M four times. (4p 2 operations) If we know the multipole expansion for any box, we can get the local expansion for any well separated box by doing M2L one time. (p 2 operations) If we know the local expansion for the parent box, we can get the local expansion for all the children boxes by doing L2L four times. (4p 2 operations) 24

25 FMM algorithm Initialization: Choose a number of levels so that there are, on average, s particles per box at the finest level. Upward Pass: Begin at the finest level, create multipole expansions from the source positions and strengths. The expansions for all boxes at all higher levels are the formed by the merging procedure (M2M). Downward Pass: We convert the multipole expansion into a local expansion about the center of all boxes in b s interaction list (M2L). Shift local expansions from parent boxes to children boxes (L2L). Add far field and near field interactions at the finest level. Note: Within all steps, you only save the coefficients of the expansions. 25

26 FMM algorithm Upward Pass Downward Pass multipole-to-local multipole-to-multipole local-to-local multipole-to-local 1. Upward pass computes multipoles for all cells: M-to-M translation 2. Downward pass translates multipoles to local terms for all cells Constant (189 in 3D) interactive (cousin) cells per destination cell contribute to M-to-L translation Within parent s neighbor but not my neighbor Inheritance from the parent cell: L-to-L translation (& delegation) 3. Direct interactions for the nearest-neighbor leaf cells Adapted from A. Nakano s lecture note 26

27 Algorithm - initialization & upward pass Initialization Choose a level of refinement n log4n, a precision \epsilon, and set p -log2(\epsilon) Upward pass 1. Form multipole expansions of potential field due to particles in each box about the box center at the finest mesh level 2. Form multipole expansions about the centers of all boxes at all coarser mesh levels, each expansion representing the potential field due to all particles contained in one box. 27

28 Algorithm - downward pass Downward pass 3. Form a local expansion about the center of each box at each mesh level l<=n-1. This local expansion describes the field due to all particles in the system that are not contained in the current box or its nearest neighbors. Once the local expansion is obtained for a given box, it is shifted, in the second inner loop to the centers of the box s children, forming the initial expansion for the boxes at the next level. 4. Compute interactions at finest mesh level. 5. Evaluate local expansions at particle positions. 6. Compute potential (or force) due to nearest neighbor directly. 7. Add direct and far-field terms together. 28

29 Algorithm - complexity Greengard & Rokhlin, JCP,

30 A toy problem in matlab www-scf.usc.edu/~hanliang/fmm_working.m www-scf.usc.edu/~hanliang/fmm.m (solution) 30

31 Outline Complexity Multipole expansion Coarse graining N log(n) algorithm Fast multipole method (FMM) Application to Stokes flow Kernel independent FMM (KIFMM) 31

32 Application to Stokes flow One fundamental solution to Stokes flow is the Stokeslet r 2 u(x)+rp(x) =f(y) (x y) u i (x) =S ij (x, y)f j (y), i,j =1, 2, 3 S ij (x, y) = ij x y + (x i y i )(x j y j ) x y 3 32

33 Application to Stokes flow For a set of N Stokeslets, velocity induced by the other Stokeslets at the m-th Stokeslet: u m i = NX 3X S ij (x m, x n )f n j, m=1,,n n=1,n6=m j=1 Direct evaluation of velocities at all N Stokeslets leads to O(N 2 ) complexity We seek a fast approach that can make use of the FMM to reduce the complexity to O(N) (x, y) = 3D Laplace FMM: 1 x y, E i(x, y) = x i y i x y 3 S ij (x, y) = 3D Stokes kernel: ij x y + (x i y i )(x j y j ) x y 3 33

34 Application to Stokes flow For a set of N Stokeslets, velocity induced by the other Stokeslets at the m-th Stokeslet: u m i = NX 3X S ij (x m, x n )f n j, m=1,,n n=1,n6=m j=1 Direct evaluation of velocities at all N Stokeslets leads to O(N 2 ) complexity We seek a fast approach that can make use of the FMM to reduce the complexity to O(N) (x, y) = 3D Laplace FMM: 1 x y, E i(x, y) i x y S ij (x, y) = 3D Stokes kernel: ij (x j y i 1 x y 34

35 Application to Stokes flow For a set of N Stokeslets, velocity induced by the other Stokeslets at the m-th Stokeslet: u m i = u m i = NX n=1,n6=m NX n=1,n6=m 3X j=1 3X j=1 S ij (x m, x n )f n j, m=1,,n ij (x m j x n m i f n j x m x n u m i = 3X j=1 2 4 ij x m i X N n=1,n6=m fj n r nm 3 m i NX n=1,n6=m x n f n r nm Four FMM calls! r nm = x m x n 35

36 Kernel independent FMM (KIFMM) The traditional FMM works well as long as the multipole expansions for the underlying kernel K are known. Z X (x) = K(x, y)q(y)ds (x i )= K(x i,y j )q(y j ) j Sometimes it is difficult/impossible to expand a kernel (e.g. the regularized Stokeslet) What can we do? 36

37 KIFMM - Basic idea To use a distribution of source point with known kernel (typically Laplace kernel) outside the box to represent the far-field/near-field potential generated by the source points inside/outside the box. equivalent density, equivalent surface 37

38 KIFMM - Uniqueness theorem If u is real and its first and second partial derivatives are continuous in a region V and on its boundary S, and r 2 u = in V, u = f = g where \rho, f and g are prescribed functions, then u is unique. (or at least up to a constant) equivalent density, equivalent surface 38

39 KIFMM - Multipole expansion Match the potential generated by the sources and the equivalent density at the check surface outside the equivalent surface. Two potentials are the same on and outside the check surface. (uniqueness of the 2nd order PDE s solution for outer Dirichlet problem) Upward check surface Evaluate induced potential of the sources on the check surface (x (c) i )= X K (x (c) i, y (s) j )q (y (s) j ) j 2. Solve the upward equivalent density (x (c) i )= X j K(x (c) i, y (e) j )q(y (e) j ) Upward equivalent density, Upward equivalent surface R (e) =( p 2+d)r, R (c) =(4 0 apple d apple 4 p 2 3 p 2, 2r is the box size 2d)r 39

40 KIFMM - Local expansion Match the potential generated by the sources and the equivalent density at the check surface inside the equivalent surface. Two potentials are the same on and inside the check surface. (uniqueness of the 2nd order PDE s solution for inner Dirichlet problem) Downward check surface 1 1. Evaluate induced potential of the sources on the check surface (x (c) i )= X K (x (c) i, y (s) j )q (y (s) j ) j 2. Solve the downward equivalent density (x (c) i )= X j K(x (c) i, y (e) j )q(y (e) j ) 2 Downward equivalent density, Downward equivalent surface R (e) =(4 0 apple d apple 4 p 2 3 p 2 2d)r, R (c) =( p 2+d)r, 2r is the box size 40

41 KIFMM - M2M, M2L, L2L M2M M2L L2L Ying et al. JCP (2004) 1. Evaluate induced potential of the equivalent density 1 on the check surface 2. Solve for the equivalent density 2 (x (c) i )= X j K(x (c) i, y (e1) j )q(y (e1) j ) (x (c) i )= X j K(x (c) i, y (e2) j )q(y (e2) j ) 41

42 KIFMM - Notes Algorithm stays exactly* the same as the traditional FMM. No need to expand any kernels! Still need to evaluate induced potential for the new kernel at the leaf boxes (bottom level) Equivalent densities are found by solving p algebraic equations (p is the number of discretization points on the surface, usually small) 42

43 Algorithm - initialization & upward pass Initialization Choose a level of refinement n log4n, a precision \epsilon, and set p -log2(\epsilon) Upward pass 1. Form multipole expansions of potential field due to particles in each box about the box center at the finest mesh level 2. Form multipole expansions about the centers of all boxes at all coarser mesh levels, each expansion representing the potential field due to all particles contained in one box. 43

44 Algorithm - downward pass Downward pass 3. Form a local expansion about the center of each box at each mesh level l<=n-1. This local expansion describes the field due to all particles in the system that are not contained in the current box or its nearest neighbors. Once the local expansion is obtained for a given box, it is shifted, in the second inner loop to the centers of the box s children, forming the initial expansion for the boxes at the next level. 4. Compute interactions at finest mesh level. 5. Evaluate local expansions at particle positions. 6. Compute potential (or force) due to nearest neighbor directly. 7. Add direct and far-field terms together. 44

45 KIFMM - A toy problem in matlab www-scf.usc.edu/~hanliang/kifmm_working.m www-scf.usc.edu/~hanliang/kifmm.m (solution) 45

46 References L. Greengard & V. Rokhlin, A fast algorithm for particle simulations, Journal of Computational Physics, 1987 R. Beatson & L. Greengard, A short course on fast multipole methods, in Wavelets, Multilevel Methods and Elliptic PDEs, Clarendon Press, Oxford, 1997 H. Cheng et al., A fast adaptive multipole algorithm in three dimensions, Journal of Computational Physics, 1999 L.X. Ying et al., A kernel-independent adaptive fast multipole algorithm in two and three dimensions, Journal of Computational Physics, 2004 A-K Tornberg & L. Greengard, A fast multipole method for the three-dimensional Stokes equations, Journal of Computational Physics, 2008 D. Malhotra & G. Biros, PVFMM: A parallel kernel independent FMM for particle and volume potentials, Communications in Computational Physics, 2015 W. Yan & M. Shelley, Flexibly imposing periodicity in kernel independent FMM: A Multipole-To- Local operator approach, Journal of Computational Physics,

47 Libraries Greengard: software.html PVFMM: 47

18.336J/6.335J: Fast methods for partial differential and integral equations. Lecture 13. Instructor: Carlos Pérez Arancibia

18.336J/6.335J: Fast methods for partial differential and integral equations. Lecture 13. Instructor: Carlos Pérez Arancibia 18.336J/6.335J: Fast methods for partial differential and integral equations Lecture 13 Instructor: Carlos Pérez Arancibia MIT Mathematics Department Cambridge, October 24, 2016 Fast Multipole Method (FMM)

More information

Fast multipole method

Fast multipole method 203/0/ page Chapter 4 Fast multipole method Originally designed for particle simulations One of the most well nown way to tae advantage of the low-ran properties Applications include Simulation of physical

More information

Differential Algebra (DA) based Fast Multipole Method (FMM)

Differential Algebra (DA) based Fast Multipole Method (FMM) Differential Algebra (DA) based Fast Multipole Method (FMM) Department of Physics and Astronomy Michigan State University June 27, 2010 Space charge effect Space charge effect : the fields of the charged

More information

Course Requirements. Course Mechanics. Projects & Exams. Homework. Week 1. Introduction. Fast Multipole Methods: Fundamentals & Applications

Course Requirements. Course Mechanics. Projects & Exams. Homework. Week 1. Introduction. Fast Multipole Methods: Fundamentals & Applications Week 1. Introduction. Fast Multipole Methods: Fundamentals & Applications Ramani Duraiswami Nail A. Gumerov What are multipole methods and what is this course about. Problems from phsics, mathematics,

More information

Hybrid Analog-Digital Solution of Nonlinear Partial Differential Equations

Hybrid Analog-Digital Solution of Nonlinear Partial Differential Equations Hybrid Analog-Digital Solution of Nonlinear Partial Differential Equations Yipeng Huang, Ning Guo, Kyle Mandli, Mingoo Seok, Yannis Tsividis, Simha Sethumadhavan Columbia University Hybrid Analog-Digital

More information

MATH20602 Numerical Analysis 1

MATH20602 Numerical Analysis 1 M\cr NA Manchester Numerical Analysis MATH20602 Numerical Analysis 1 Martin Lotz School of Mathematics The University of Manchester Manchester, January 27, 2014 Outline General Course Information Introduction

More information

Fast Multipole Methods: Fundamentals & Applications. Ramani Duraiswami Nail A. Gumerov

Fast Multipole Methods: Fundamentals & Applications. Ramani Duraiswami Nail A. Gumerov Fast Multipole Methods: Fundamentals & Applications Ramani Duraiswami Nail A. Gumerov Week 1. Introduction. What are multipole methods and what is this course about. Problems from physics, mathematics,

More information

An implementation of the Fast Multipole Method without multipoles

An implementation of the Fast Multipole Method without multipoles An implementation of the Fast Multipole Method without multipoles Robin Schoemaker Scientific Computing Group Seminar The Fast Multipole Method Theory and Applications Spring 2002 Overview Fast Multipole

More information

MATH20602 Numerical Analysis 1

MATH20602 Numerical Analysis 1 M\cr NA Manchester Numerical Analysis MATH20602 Numerical Analysis 1 Martin Lotz School of Mathematics The University of Manchester Manchester, February 1, 2016 Outline General Course Information Introduction

More information

INTRODUCTION TO FAST MULTIPOLE METHODS LONG CHEN

INTRODUCTION TO FAST MULTIPOLE METHODS LONG CHEN INTRODUCTION TO FAST MULTIPOLE METHODS LONG CHEN ABSTRACT. This is a simple introduction to fast multipole methods for the N-body summation problems. Low rank approximation plus hierarchical decomposition

More information

Lecture 2: The Fast Multipole Method

Lecture 2: The Fast Multipole Method CBMS Conference on Fast Direct Solvers Dartmouth College June 23 June 27, 2014 Lecture 2: The Fast Multipole Method Gunnar Martinsson The University of Colorado at Boulder Research support by: Recall:

More information

A Fast Adaptive Multipole Algorithm in Three Dimensions

A Fast Adaptive Multipole Algorithm in Three Dimensions Journal of Computational Physics 155, 468 498 (1999) Article ID jcph.1999.6355, available online at http://www.idealibrary.com on A Fast Adaptive Multipole Algorithm in Three Dimensions H. Cheng, L. Greengard,

More information

Lecture 1 Numerical methods: principles, algorithms and applications: an introduction

Lecture 1 Numerical methods: principles, algorithms and applications: an introduction Lecture 1 Numerical methods: principles, algorithms and applications: an introduction Weinan E 1,2 and Tiejun Li 2 1 Department of Mathematics, Princeton University, weinan@princeton.edu 2 School of Mathematical

More information

HOW TO DEVELOP A TOP- TEN ALGORITHM IN THE 21ST CENTURY

HOW TO DEVELOP A TOP- TEN ALGORITHM IN THE 21ST CENTURY HOW TO DEVELOP A TOP- TEN ALGORITHM IN THE 21ST CENTURY Alex Townsend Cornell University (A talk for fun. Audience participation encouraged.) DONGARRA S TOP10 LIST FROM 20TH CENTURY 1946: The Metropolis

More information

Scalability Metrics for Parallel Molecular Dynamics

Scalability Metrics for Parallel Molecular Dynamics Scalability Metrics for arallel Molecular Dynamics arallel Efficiency We define the efficiency of a parallel program running on processors to solve a problem of size W Let T(W, ) be the execution time

More information

Fast Multipole Methods for The Laplace Equation. Outline

Fast Multipole Methods for The Laplace Equation. Outline Fast Multipole Methods for The Laplace Equation Ramani Duraiswami Nail Gumerov Outline 3D Laplace equation and Coulomb potentials Multipole and local expansions Special functions Legendre polynomials Associated

More information

Lecture Note 18: Duality

Lecture Note 18: Duality MATH 5330: Computational Methods of Linear Algebra 1 The Dual Problems Lecture Note 18: Duality Xianyi Zeng Department of Mathematical Sciences, UTEP The concept duality, just like accuracy and stability,

More information

Generalized fast multipole method

Generalized fast multipole method Home Search Collections Journals About Contact us My IOPscience Generalized fast multipole method This article has been downloaded from IOPscience. Please scroll down to see the full text article. 2 IOP

More information

A Fast Algorithm for Particle Simulations*

A Fast Algorithm for Particle Simulations* JOURNAL OF COMPUTATIONAL PHYSICS 35, 280 292 (997) ARTICLE NO. CP975706 A Fast Algorithm for Particle Simulations* L. Greengard and V. Rokhlin Department of Computer Science, Yale University, New Haven,

More information

(1) u i = g(x i, x j )q j, i = 1, 2,..., N, where g(x, y) is the interaction potential of electrostatics in the plane. 0 x = y.

(1) u i = g(x i, x j )q j, i = 1, 2,..., N, where g(x, y) is the interaction potential of electrostatics in the plane. 0 x = y. Encyclopedia entry on Fast Multipole Methods. Per-Gunnar Martinsson, University of Colorado at Boulder, August 2012 Short definition. The Fast Multipole Method (FMM) is an algorithm for rapidly evaluating

More information

Monte Carlo Methods. Part I: Introduction

Monte Carlo Methods. Part I: Introduction Monte Carlo Methods Part I: Introduction Spring Semester 2013/14 Department of Applied Mathematics, University of Crete Instructor: Harmandaris Vagelis, email: vagelis@tem.uoc.gr Course web page: http://www.tem.uoc.gr/~vagelis/courses/em385/

More information

Parallel Adaptive Fast Multipole Method: application, design, and more...

Parallel Adaptive Fast Multipole Method: application, design, and more... Parallel Adaptive Fast Multipole Method: application, design, and more... Stefan Engblom UPMARC @ TDB/IT, Uppsala University PSCP, Uppsala, March 4, 2011 S. Engblom (UPMARC/TDB) Parallel Adaptive FMM PSCP,

More information

arxiv: v3 [math.na] 23 Aug 2018

arxiv: v3 [math.na] 23 Aug 2018 Universal image systems for non-periodic and periodic Stokes flows above a no-slip wall Wen Yan a,b,, Michael Shelley a,b a Center for Computational Biology, Flatiron Institute, Simons Foundation, New

More information

Particle Methods. Lecture Reduce and Broadcast: A function viewpoint

Particle Methods. Lecture Reduce and Broadcast: A function viewpoint Lecture 9 Particle Methods 9.1 Reduce and Broadcast: A function viewpoint [This section is being rewritten with what we hope will be the world s clearest explanation of the fast multipole algorithm. Readers

More information

CME 302: NUMERICAL LINEAR ALGEBRA FALL 2005/06 LECTURE 0

CME 302: NUMERICAL LINEAR ALGEBRA FALL 2005/06 LECTURE 0 CME 302: NUMERICAL LINEAR ALGEBRA FALL 2005/06 LECTURE 0 GENE H GOLUB 1 What is Numerical Analysis? In the 1973 edition of the Webster s New Collegiate Dictionary, numerical analysis is defined to be the

More information

The Fast Multipole Method and other Fast Summation Techniques

The Fast Multipole Method and other Fast Summation Techniques The Fast Multipole Method and other Fast Summation Techniques Gunnar Martinsson The University of Colorado at Boulder (The factor of 1/2π is suppressed.) Problem definition: Consider the task of evaluation

More information

Lecture 8: Boundary Integral Equations

Lecture 8: Boundary Integral Equations CBMS Conference on Fast Direct Solvers Dartmouth College June 23 June 27, 2014 Lecture 8: Boundary Integral Equations Gunnar Martinsson The University of Colorado at Boulder Research support by: Consider

More information

Arizona State University, Tempe, AZ 85287, USA 2 Department of Electrical Engineering. Arizona State University, Tempe, AZ 85287, USA ABSTRACT

Arizona State University, Tempe, AZ 85287, USA 2 Department of Electrical Engineering. Arizona State University, Tempe, AZ 85287, USA ABSTRACT Accurate Three-Dimensional Simulation of Electron Mobility Including Electron-Electron and Electron-Dopant Interactions C. Heitzinger, 1 C. Ringhofer, 1 S. Ahmed, 2 D. Vasileska, 2 1 Department of Mathematics

More information

Fast Multipole Methods

Fast Multipole Methods An Introduction to Fast Multipole Methods Ramani Duraiswami Institute for Advanced Computer Studies University of Maryland, College Park http://www.umiacs.umd.edu/~ramani Joint work with Nail A. Gumerov

More information

Stabilization and Acceleration of Algebraic Multigrid Method

Stabilization and Acceleration of Algebraic Multigrid Method Stabilization and Acceleration of Algebraic Multigrid Method Recursive Projection Algorithm A. Jemcov J.P. Maruszewski Fluent Inc. October 24, 2006 Outline 1 Need for Algorithm Stabilization and Acceleration

More information

Improved Fast Gauss Transform. Fast Gauss Transform (FGT)

Improved Fast Gauss Transform. Fast Gauss Transform (FGT) 10/11/011 Improved Fast Gauss Transform Based on work by Changjiang Yang (00), Vikas Raykar (005), and Vlad Morariu (007) Fast Gauss Transform (FGT) Originally proposed by Greengard and Strain (1991) to

More information

SOLVING ELLIPTIC PDES

SOLVING ELLIPTIC PDES university-logo SOLVING ELLIPTIC PDES School of Mathematics Semester 1 2008 OUTLINE 1 REVIEW 2 POISSON S EQUATION Equation and Boundary Conditions Solving the Model Problem 3 THE LINEAR ALGEBRA PROBLEM

More information

AMS526: Numerical Analysis I (Numerical Linear Algebra for Computational and Data Sciences)

AMS526: Numerical Analysis I (Numerical Linear Algebra for Computational and Data Sciences) AMS526: Numerical Analysis I (Numerical Linear Algebra for Computational and Data Sciences) Lecture 19: Computing the SVD; Sparse Linear Systems Xiangmin Jiao Stony Brook University Xiangmin Jiao Numerical

More information

xx" i" l(x--xi, Y--Yi)"

xx i l(x--xi, Y--Yi) SIAM J. ScI. STATo COMPUT. Vol. 11, No. 4, pp. 603-620, July 1990 1990 Society for Industrial and Applied Mathematics 001 POTENTIAL FLOW IN CHANNELS* L. GREENGARDt Abstract. A method is presented for calculating

More information

Wavelet-Based Numerical Homogenization for Scaled Solutions of Linear Matrix Equations

Wavelet-Based Numerical Homogenization for Scaled Solutions of Linear Matrix Equations International Journal of Discrete Mathematics 2017; 2(1: 10-16 http://www.sciencepublishinggroup.com/j/dmath doi: 10.11648/j.dmath.20170201.13 Wavelet-Based Numerical Homogenization for Scaled Solutions

More information

Fast algorithms for dimensionality reduction and data visualization

Fast algorithms for dimensionality reduction and data visualization Fast algorithms for dimensionality reduction and data visualization Manas Rachh Yale University 1/33 Acknowledgements George Linderman (Yale) Jeremy Hoskins (Yale) Stefan Steinerberger (Yale) Yuval Kluger

More information

A fast randomized algorithm for computing a Hierarchically Semi-Separable representation of a matrix

A fast randomized algorithm for computing a Hierarchically Semi-Separable representation of a matrix A fast randomized algorithm for computing a Hierarchically Semi-Separable representation of a matrix P.G. Martinsson, Department of Applied Mathematics, University of Colorado at Boulder Abstract: Randomized

More information

Fast multipole boundary element method for the analysis of plates with many holes

Fast multipole boundary element method for the analysis of plates with many holes Arch. Mech., 59, 4 5, pp. 385 401, Warszawa 2007 Fast multipole boundary element method for the analysis of plates with many holes J. PTASZNY, P. FEDELIŃSKI Department of Strength of Materials and Computational

More information

Two special equations: Bessel s and Legendre s equations. p Fourier-Bessel and Fourier-Legendre series. p

Two special equations: Bessel s and Legendre s equations. p Fourier-Bessel and Fourier-Legendre series. p LECTURE 1 Table of Contents Two special equations: Bessel s and Legendre s equations. p. 259-268. Fourier-Bessel and Fourier-Legendre series. p. 453-460. Boundary value problems in other coordinate system.

More information

Calculus of Variations and Computer Vision

Calculus of Variations and Computer Vision Calculus of Variations and Computer Vision Sharat Chandran Page 1 of 23 Computer Science & Engineering Department, Indian Institute of Technology, Bombay. http://www.cse.iitb.ernet.in/ sharat January 8,

More information

Fast Multipole BEM for Structural Acoustics Simulation

Fast Multipole BEM for Structural Acoustics Simulation Fast Boundary Element Methods in Industrial Applications Fast Multipole BEM for Structural Acoustics Simulation Matthias Fischer and Lothar Gaul Institut A für Mechanik, Universität Stuttgart, Germany

More information

Fast Multipole Methods for Incompressible Flow Simulation

Fast Multipole Methods for Incompressible Flow Simulation Fast Multipole Methods for Incompressible Flow Simulation Nail A. Gumerov & Ramani Duraiswami Institute for Advanced Computer Studies University of Maryland, College Park Support of NSF awards 0086075

More information

FastMMLib: a generic Fast Multipole Method library. Eric DARRIGRAND. IRMAR Université de Rennes 1

FastMMLib: a generic Fast Multipole Method library. Eric DARRIGRAND. IRMAR Université de Rennes 1 FastMMLib: a generic Fast Multipole Method library Eric DARRIGRAND joint work with Yvon LAFRANCHE IRMAR Université de Rennes 1 Outline Introduction to FMM Historically SVD principle A first example of

More information

Kasetsart University Workshop. Multigrid methods: An introduction

Kasetsart University Workshop. Multigrid methods: An introduction Kasetsart University Workshop Multigrid methods: An introduction Dr. Anand Pardhanani Mathematics Department Earlham College Richmond, Indiana USA pardhan@earlham.edu A copy of these slides is available

More information

A fast adaptive numerical solver for nonseparable elliptic partial differential equations

A fast adaptive numerical solver for nonseparable elliptic partial differential equations J. KSIAM Vol.2. No.1. 27-39, 1998 27 A fast adaptive numerical solver for nonseparable elliptic partial differential equations June-Yub Lee Dept of Math, Ewha Womans Univ, Seoul 120-750, KOREA jylee@math.ewha.ac.kr

More information

Geometric Series and the Ratio and Root Test

Geometric Series and the Ratio and Root Test Geometric Series and the Ratio and Root Test James K. Peterson Department of Biological Sciences and Department of Mathematical Sciences Clemson University September 5, 2018 Outline 1 Geometric Series

More information

RBF-FD Approximation to Solve Poisson Equation in 3D

RBF-FD Approximation to Solve Poisson Equation in 3D RBF-FD Approximation to Solve Poisson Equation in 3D Jagadeeswaran.R March 14, 2014 1 / 28 Overview Problem Setup Generalized finite difference method. Uses numerical differentiations generated by Gaussian

More information

The Kernel Trick, Gram Matrices, and Feature Extraction. CS6787 Lecture 4 Fall 2017

The Kernel Trick, Gram Matrices, and Feature Extraction. CS6787 Lecture 4 Fall 2017 The Kernel Trick, Gram Matrices, and Feature Extraction CS6787 Lecture 4 Fall 2017 Momentum for Principle Component Analysis CS6787 Lecture 3.1 Fall 2017 Principle Component Analysis Setting: find the

More information

Fast Direct Methods for Gaussian Processes

Fast Direct Methods for Gaussian Processes Fast Direct Methods for Gaussian Processes Mike O Neil Departments of Mathematics New York University oneil@cims.nyu.edu December 12, 2015 1 Collaborators This is joint work with: Siva Ambikasaran Dan

More information

N-body simulations. Phys 750 Lecture 10

N-body simulations. Phys 750 Lecture 10 N-body simulations Phys 750 Lecture 10 N-body simulations Forward integration in time of strongly coupled classical particles or (rigid-body composite objects) dissipation Brownian motion Very general

More information

An Overview of Fast Multipole Methods

An Overview of Fast Multipole Methods An Overview of Fast Multipole Methods Alexander T. Ihler April 23, 2004 Sing, Muse, of the low-rank approximations Of spherical harmonics and O(N) computation... Abstract We present some background and

More information

Lecture 8: PGM Inference

Lecture 8: PGM Inference 15 September 2014 Intro. to Stats. Machine Learning COMP SCI 4401/7401 Table of Contents I 1 Variable elimination Max-product Sum-product 2 LP Relaxations QP Relaxations 3 Marginal and MAP X1 X2 X3 X4

More information

Karhunen-Loève Approximation of Random Fields Using Hierarchical Matrix Techniques

Karhunen-Loève Approximation of Random Fields Using Hierarchical Matrix Techniques Institut für Numerische Mathematik und Optimierung Karhunen-Loève Approximation of Random Fields Using Hierarchical Matrix Techniques Oliver Ernst Computational Methods with Applications Harrachov, CR,

More information

Jim Lambers ENERGY 281 Spring Quarter Homework Assignment 3 Solution. 2 Ei r2 D., 4t D and the late time approximation to this solution,

Jim Lambers ENERGY 281 Spring Quarter Homework Assignment 3 Solution. 2 Ei r2 D., 4t D and the late time approximation to this solution, Jim Lambers ENERGY 8 Spring Quarter 7-8 Homework Assignment 3 Solution Plot the exponential integral solution p D (r D,t D ) = ) ( Ei r D, 4t D and the late time approximation to this solution, p D (r

More information

A Fast Solver for the Stokes Equations. Tejaswin Parthasarathy CS 598APK, Fall 2017

A Fast Solver for the Stokes Equations. Tejaswin Parthasarathy CS 598APK, Fall 2017 A Fast Solver for the Stokes Equations Tejaswin Parthasarathy CS 598APK, Fall 2017 Stokes Equations? http://www.earthtimes.org/ Continuity wallpapers-s.blogspot.com @ @t + @( u i) @ i =0 http://testingstufftonight.blogspot.com/

More information

APPENDIX A. Background Mathematics. A.1 Linear Algebra. Vector algebra. Let x denote the n-dimensional column vector with components x 1 x 2.

APPENDIX A. Background Mathematics. A.1 Linear Algebra. Vector algebra. Let x denote the n-dimensional column vector with components x 1 x 2. APPENDIX A Background Mathematics A. Linear Algebra A.. Vector algebra Let x denote the n-dimensional column vector with components 0 x x 2 B C @. A x n Definition 6 (scalar product). The scalar product

More information

Birth-death chain. X n. X k:n k,n 2 N k apple n. X k: L 2 N. x 1:n := x 1,...,x n. E n+1 ( x 1:n )=E n+1 ( x n ), 8x 1:n 2 X n.

Birth-death chain. X n. X k:n k,n 2 N k apple n. X k: L 2 N. x 1:n := x 1,...,x n. E n+1 ( x 1:n )=E n+1 ( x n ), 8x 1:n 2 X n. Birth-death chains Birth-death chain special type of Markov chain Finite state space X := {0,...,L}, with L 2 N X n X k:n k,n 2 N k apple n Random variable and a sequence of variables, with and A sequence

More information

arxiv: v2 [math.na] 1 Oct 2016

arxiv: v2 [math.na] 1 Oct 2016 Inexact Krylov iterations and relaxation strategies with fast-multipole boundary element method Tingyu Wang a, Simon K. Layton b,c,1, Lorena A. Barba a a Department of Mechanical and Aerospace Engineering,

More information

Solutions to Laplace s Equation in Cylindrical Coordinates and Numerical solutions. ρ + (1/ρ) 2 V

Solutions to Laplace s Equation in Cylindrical Coordinates and Numerical solutions. ρ + (1/ρ) 2 V Solutions to Laplace s Equation in Cylindrical Coordinates and Numerical solutions Lecture 8 1 Introduction Solutions to Laplace s equation can be obtained using separation of variables in Cartesian and

More information

19 th INTERNATIONAL CONGRESS ON ACOUSTICS MADRID, 2-7 SEPTEMBER 2007 HIGH FREQUENCY ACOUSTIC SIMULATIONS VIA FMM ACCELERATED BEM

19 th INTERNATIONAL CONGRESS ON ACOUSTICS MADRID, 2-7 SEPTEMBER 2007 HIGH FREQUENCY ACOUSTIC SIMULATIONS VIA FMM ACCELERATED BEM 19 th INTERNATIONAL CONGRESS ON ACOUSTICS MADRID, 2-7 SEPTEMBER 2007 HIGH FREQUENCY ACOUSTIC SIMULATIONS VIA FMM ACCELERATED BEM PACS: 43.20.Fn Gumerov, Nail A.; Duraiswami, Ramani; Fantalgo LLC, 7496

More information

MATH 590: Meshfree Methods

MATH 590: Meshfree Methods MATH 590: Meshfree Methods Chapter 33: Adaptive Iteration Greg Fasshauer Department of Applied Mathematics Illinois Institute of Technology Fall 2010 fasshauer@iit.edu MATH 590 Chapter 33 1 Outline 1 A

More information

An adaptive fast multipole boundary element method for the Helmholtz equation

An adaptive fast multipole boundary element method for the Helmholtz equation An adaptive fast multipole boundary element method for the Helmholtz equation Vincenzo Mallardo 1, Claudio Alessandri 1, Ferri M.H. Aliabadi 2 1 Department of Architecture, University of Ferrara, Italy

More information

Elliptic Problems / Multigrid. PHY 604: Computational Methods for Physics and Astrophysics II

Elliptic Problems / Multigrid. PHY 604: Computational Methods for Physics and Astrophysics II Elliptic Problems / Multigrid Summary of Hyperbolic PDEs We looked at a simple linear and a nonlinear scalar hyperbolic PDE There is a speed associated with the change of the solution Explicit methods

More information

Fast numerical methods for solving linear PDEs

Fast numerical methods for solving linear PDEs Fast numerical methods for solving linear PDEs P.G. Martinsson, The University of Colorado at Boulder Acknowledgements: Some of the work presented is joint work with Vladimir Rokhlin and Mark Tygert at

More information

Practical in Numerical Astronomy, SS 2012 LECTURE 9

Practical in Numerical Astronomy, SS 2012 LECTURE 9 Practical in Numerical Astronomy, SS 01 Elliptic partial differential equations. Poisson solvers. LECTURE 9 1. Gravity force and the equations of hydrodynamics. Poisson equation versus Poisson integral.

More information

Fast Polynomial Multiplication

Fast Polynomial Multiplication Fast Polynomial Multiplication Marc Moreno Maza CS 9652, October 4, 2017 Plan Primitive roots of unity The discrete Fourier transform Convolution of polynomials The fast Fourier transform Fast convolution

More information

Key words. fast multipole method, integral equations, boundary element method, dense matrixvector

Key words. fast multipole method, integral equations, boundary element method, dense matrixvector CAUCHY FAST MULTIPOLE METHOD FOR GENERAL ANALYTIC KERNELS PIERRE-DAVID LÉTOURNEAU, CRIS CECKA, AND ERIC DARVE Abstract. The fast multipole method (FMM) is a technique allowing the fast calculation of long-range

More information

CS 556: Computer Vision. Lecture 21

CS 556: Computer Vision. Lecture 21 CS 556: Computer Vision Lecture 21 Prof. Sinisa Todorovic sinisa@eecs.oregonstate.edu 1 Meanshift 2 Meanshift Clustering Assumption: There is an underlying pdf governing data properties in R Clustering

More information

Contents. Preface to the Third Edition (2007) Preface to the Second Edition (1992) Preface to the First Edition (1985) License and Legal Information

Contents. Preface to the Third Edition (2007) Preface to the Second Edition (1992) Preface to the First Edition (1985) License and Legal Information Contents Preface to the Third Edition (2007) Preface to the Second Edition (1992) Preface to the First Edition (1985) License and Legal Information xi xiv xvii xix 1 Preliminaries 1 1.0 Introduction.............................

More information

Introduction to Scientific Computing

Introduction to Scientific Computing Introduction to Scientific Computing Two-lecture series for post-graduates, Dr. Lorena Barba University of Bristol 0 What is Scientific Computing? Solution of scientific problems using computers It is

More information

A Remark on the Fast Gauss Transform

A Remark on the Fast Gauss Transform Publ. RIMS, Kyoto Univ. 39 (2003), 785 796 A Remark on the Fast Gauss Transform By Kenta Kobayashi Abstract We propose an improvement on the Fast Gauss Transform which was presented by Greengard and Sun

More information

OUTLINE ffl CFD: elliptic pde's! Ax = b ffl Basic iterative methods ffl Krylov subspace methods ffl Preconditioning techniques: Iterative methods ILU

OUTLINE ffl CFD: elliptic pde's! Ax = b ffl Basic iterative methods ffl Krylov subspace methods ffl Preconditioning techniques: Iterative methods ILU Preconditioning Techniques for Solving Large Sparse Linear Systems Arnold Reusken Institut für Geometrie und Praktische Mathematik RWTH-Aachen OUTLINE ffl CFD: elliptic pde's! Ax = b ffl Basic iterative

More information

INTEGRAL-EQUATION-BASED FAST ALGORITHMS AND GRAPH-THEORETIC METHODS FOR LARGE-SCALE SIMULATIONS

INTEGRAL-EQUATION-BASED FAST ALGORITHMS AND GRAPH-THEORETIC METHODS FOR LARGE-SCALE SIMULATIONS INTEGRAL-EQUATION-BASED FAST ALGORITHMS AND GRAPH-THEORETIC METHODS FOR LARGE-SCALE SIMULATIONS Bo Zhang A dissertation submitted to the faculty of the University of North Carolina at Chapel Hill in partial

More information

Transactions on Modelling and Simulation vol 18, 1997 WIT Press, ISSN X

Transactions on Modelling and Simulation vol 18, 1997 WIT Press,  ISSN X Application of the fast multipole method to the 3-D BEM analysis of electron guns T. Nishida and K. Hayami Department of Mathematical Engineering and Information Physics, School of Engineering, University

More information

COMS 4721: Machine Learning for Data Science Lecture 19, 4/6/2017

COMS 4721: Machine Learning for Data Science Lecture 19, 4/6/2017 COMS 4721: Machine Learning for Data Science Lecture 19, 4/6/2017 Prof. John Paisley Department of Electrical Engineering & Data Science Institute Columbia University PRINCIPAL COMPONENT ANALYSIS DIMENSIONALITY

More information

Large scale simulations of gravity induced sedimentation of slender fibers

Large scale simulations of gravity induced sedimentation of slender fibers Large scale simulations of gravity induced sedimentation of slender fibers Katarina Gustavsson Royal Institute of Technology (KTH) Stockholm Simu mulations of rigid fibers Fibers in Waterland 800 fibers

More information

Nonlinear Dimensionality Reduction

Nonlinear Dimensionality Reduction Nonlinear Dimensionality Reduction Piyush Rai CS5350/6350: Machine Learning October 25, 2011 Recap: Linear Dimensionality Reduction Linear Dimensionality Reduction: Based on a linear projection of the

More information

MATH 590: Meshfree Methods

MATH 590: Meshfree Methods MATH 590: Meshfree Methods Chapter 33: Adaptive Iteration Greg Fasshauer Department of Applied Mathematics Illinois Institute of Technology Fall 2010 fasshauer@iit.edu MATH 590 Chapter 33 1 Outline 1 A

More information

CS 542G: The Poisson Problem, Finite Differences

CS 542G: The Poisson Problem, Finite Differences CS 542G: The Poisson Problem, Finite Differences Robert Bridson November 10, 2008 1 The Poisson Problem At the end last time, we noticed that the gravitational potential has a zero Laplacian except at

More information

Markov chain Monte Carlo Lecture 9

Markov chain Monte Carlo Lecture 9 Markov chain Monte Carlo Lecture 9 David Sontag New York University Slides adapted from Eric Xing and Qirong Ho (CMU) Limitations of Monte Carlo Direct (unconditional) sampling Hard to get rare events

More information

Fast matrix algebra for dense matrices with rank-deficient off-diagonal blocks

Fast matrix algebra for dense matrices with rank-deficient off-diagonal blocks CHAPTER 2 Fast matrix algebra for dense matrices with rank-deficient off-diagonal blocks Chapter summary: The chapter describes techniques for rapidly performing algebraic operations on dense matrices

More information

A Robust Preconditioner for the Hessian System in Elliptic Optimal Control Problems

A Robust Preconditioner for the Hessian System in Elliptic Optimal Control Problems A Robust Preconditioner for the Hessian System in Elliptic Optimal Control Problems Etereldes Gonçalves 1, Tarek P. Mathew 1, Markus Sarkis 1,2, and Christian E. Schaerer 1 1 Instituto de Matemática Pura

More information

OUTLINE 1. Introduction 1.1 Notation 1.2 Special matrices 2. Gaussian Elimination 2.1 Vector and matrix norms 2.2 Finite precision arithmetic 2.3 Fact

OUTLINE 1. Introduction 1.1 Notation 1.2 Special matrices 2. Gaussian Elimination 2.1 Vector and matrix norms 2.2 Finite precision arithmetic 2.3 Fact Computational Linear Algebra Course: (MATH: 6800, CSCI: 6800) Semester: Fall 1998 Instructors: { Joseph E. Flaherty, aherje@cs.rpi.edu { Franklin T. Luk, luk@cs.rpi.edu { Wesley Turner, turnerw@cs.rpi.edu

More information

Rapid evaluation of electrostatic interactions in multi-phase media

Rapid evaluation of electrostatic interactions in multi-phase media Rapid evaluation of electrostatic interactions in multi-phase media P.G. Martinsson, The University of Colorado at Boulder Acknowledgements: Some of the work presented is joint work with Mark Tygert and

More information

Graphs, Vectors, and Matrices Daniel A. Spielman Yale University. AMS Josiah Willard Gibbs Lecture January 6, 2016

Graphs, Vectors, and Matrices Daniel A. Spielman Yale University. AMS Josiah Willard Gibbs Lecture January 6, 2016 Graphs, Vectors, and Matrices Daniel A. Spielman Yale University AMS Josiah Willard Gibbs Lecture January 6, 2016 From Applied to Pure Mathematics Algebraic and Spectral Graph Theory Sparsification: approximating

More information

Scientific Computing with Case Studies SIAM Press, Lecture Notes for Unit VII Sparse Matrix

Scientific Computing with Case Studies SIAM Press, Lecture Notes for Unit VII Sparse Matrix Scientific Computing with Case Studies SIAM Press, 2009 http://www.cs.umd.edu/users/oleary/sccswebpage Lecture Notes for Unit VII Sparse Matrix Computations Part 1: Direct Methods Dianne P. O Leary c 2008

More information

Chenhan D. Yu The 3rd BLIS Retreat Sep 28, 2015

Chenhan D. Yu The 3rd BLIS Retreat Sep 28, 2015 GSKS GSKNN BLIS-Based High Performance Computing Kernels in N-body Problems Chenhan D. Yu The 3rd BLIS Retreat Sep 28, 2015 N-body Problems Hellstorm Astronomy and 3D https://youtu.be/bllwkx_mrfk 2 N-body

More information

Preconditioned inverse iteration and shift-invert Arnoldi method

Preconditioned inverse iteration and shift-invert Arnoldi method Preconditioned inverse iteration and shift-invert Arnoldi method Melina Freitag Department of Mathematical Sciences University of Bath CSC Seminar Max-Planck-Institute for Dynamics of Complex Technical

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

Numerical Methods for Large-Scale Nonlinear Equations

Numerical Methods for Large-Scale Nonlinear Equations Slide 1 Numerical Methods for Large-Scale Nonlinear Equations Homer Walker MA 512 April 28, 2005 Inexact Newton and Newton Krylov Methods a. Newton-iterative and inexact Newton methods. Slide 2 i. Formulation

More information

Description / Instructions: Covers 9th edition chapters and

Description / Instructions: Covers 9th edition chapters and Description / Instructions: Covers 9th edition chapters 21-1 -- 21-6 and 22-1 -- 22-4. Question 1 Figure 21-14 shows four situations in which charged particles are fixed in place on an axis. In which situations

More information

Chapter 5. Methods for Solving Elliptic Equations

Chapter 5. Methods for Solving Elliptic Equations Chapter 5. Methods for Solving Elliptic Equations References: Tannehill et al Section 4.3. Fulton et al (1986 MWR). Recommended reading: Chapter 7, Numerical Methods for Engineering Application. J. H.

More information

MATH 205 HOMEWORK #3 OFFICIAL SOLUTION. Problem 1: Find all eigenvalues and eigenvectors of the following linear transformations. (a) F = R, V = R 3,

MATH 205 HOMEWORK #3 OFFICIAL SOLUTION. Problem 1: Find all eigenvalues and eigenvectors of the following linear transformations. (a) F = R, V = R 3, MATH 205 HOMEWORK #3 OFFICIAL SOLUTION Problem 1: Find all eigenvalues and eigenvectors of the following linear transformations. a F = R, V = R 3, b F = R or C, V = F 2, T = T = 9 4 4 8 3 4 16 8 7 0 1

More information

Solving Symmetric Indefinite Systems with Symmetric Positive Definite Preconditioners

Solving Symmetric Indefinite Systems with Symmetric Positive Definite Preconditioners Solving Symmetric Indefinite Systems with Symmetric Positive Definite Preconditioners Eugene Vecharynski 1 Andrew Knyazev 2 1 Department of Computer Science and Engineering University of Minnesota 2 Department

More information

A THE FAST MULTIPLE METHOD FOR GRIDLESS PARTICLEii

A THE FAST MULTIPLE METHOD FOR GRIDLESS PARTICLEii A-89 804 THE FAST MULTIPLE METHOD FOR GRIDLESS PARTICLEii UNCLASSIFIED SIMULATIONSU) YALE UNIV NEW HAVEN CT DEPT OF COMPUTER SCIENCE J AMBROSIANO ET AL SEP 87 YALEU/DCS/RR-565 N888t14-8-k-S F/G 12/1 NL

More information

Class Averaging in Cryo-Electron Microscopy

Class Averaging in Cryo-Electron Microscopy Class Averaging in Cryo-Electron Microscopy Zhizhen Jane Zhao Courant Institute of Mathematical Sciences, NYU Mathematics in Data Sciences ICERM, Brown University July 30 2015 Single Particle Reconstruction

More information

Multigrid absolute value preconditioning

Multigrid absolute value preconditioning Multigrid absolute value preconditioning Eugene Vecharynski 1 Andrew Knyazev 2 (speaker) 1 Department of Computer Science and Engineering University of Minnesota 2 Department of Mathematical and Statistical

More information

July 21 Math 2254 sec 001 Summer 2015

July 21 Math 2254 sec 001 Summer 2015 July 21 Math 2254 sec 001 Summer 2015 Section 8.8: Power Series Theorem: Let a n (x c) n have positive radius of convergence R, and let the function f be defined by this power series f (x) = a n (x c)

More information

Kernel Methods. Charles Elkan October 17, 2007

Kernel Methods. Charles Elkan October 17, 2007 Kernel Methods Charles Elkan elkan@cs.ucsd.edu October 17, 2007 Remember the xor example of a classification problem that is not linearly separable. If we map every example into a new representation, then

More information

Recurrence Relations and Fast Algorithms

Recurrence Relations and Fast Algorithms Recurrence Relations and Fast Algorithms Mark Tygert Research Report YALEU/DCS/RR-343 December 29, 2005 Abstract We construct fast algorithms for decomposing into and reconstructing from linear combinations

More information