An implementation of the Fast Multipole Method without multipoles

Size: px
Start display at page:

Download "An implementation of the Fast Multipole Method without multipoles"

Transcription

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

2 Overview Fast Multipole Algorithm Anderson s method Poisson s formula instead of multipole expansions Application

3 N-body interactions (1) Particle simulations in physical systems require the evaluation of a potential function φ( r), (yielding a force field); These pair wise interactions are Coulombic/gravitational in nature: φ ( ) N r = q log r r, j = 1,, N j i j i i= 1 for a system of N charged particles in 2 dimensions with strengths q i.

4 N-body interactions (2) If N is the total number of particles involved, the temporal complexity of such a system is ( 2 O N ).

5 { z, i = 1,, m} i Multipole expansion {, = 1,, } For m charges of strengths q i m located at points, with z < r, the potential φ() z is approximated by the multipole expansion i i k a qz i i φ() z " log() z q ith a, k m p m k + w = i k k i= 1 k= 1 z i= 1 for any z # with z > r.

6 Error bound m = i i= 1 For A q and any p 1, m p a k A 1 φ() z log() z q i k i= 1 k= 1 z z/ r 1 z/ r p 1 A 2 p, for z / r 2.

7 Example of speed-up (1) Two sets of charges are well-separated : x x < r for i = 1,, m i 0 y y < r for j = 1,, n j 0 x y > 3r 0 0.,, x 1 r y 1 r r x 0 x m y 0 y n

8 Example of speed-up (2) The potential at the points {y i } due to charges at {x j } is computed directly via m i= 1 φ x Onm i ( ) ( y ) n points). j for all j = 1,, n and requires computations (evaluating m fields at x 1 r x 0 x m r y 1 y 0 r y n

9 Example of speed-up (3) A p-term multipole expansion due to charges q 1,, q m about x 0 requires O(mp) operations; Evaluating this expansion at all {y i } : O(np) operations; total : O(mp + np) The O(p) operations can be neglected for large m and n, resulting in O(m) + O(n) << O(mn).

10 Translation operators Shifting the centre of a multipole expansion: M2M; Convert a shifted expansion into a local (Taylor) expansion: M2L; Shifting the centre of a local (Taylor) expansion: L2L.

11 M2M φ() z " b l a log( z z ) + φ() z " a log( z) + p l= 1 b z l l p ( z l l 1 l k az = a z k 0 k= 1 k 1 l k= 1 0 l 0 0 a k z w ith ) k into D z 0 R φ() z R+ z 0 D 1

12 M2L z > ( c + 1) R with c > 1 0 φ() z " b z with p l= 0 l a b a z b l p 0 k " k k= 1 z0 0 0 l D 2 φ() z R k ( 1) + log( ) p 1 a l k 1 + k k a0 " ( 1) l 1 l k l z0 k= 1 z k 1 for l z 0 0 cr D 1 z 0 R

13 L2L Shifting a Taylor expansion via an exact translation operation with a finite number of terms: { a } For any complex z, z, a nd, k = 0,, n, 0 k a ( z z ) = a ( z ) l n n n k k l k 0 k 0 k= 0 l= 0 k= l k z l.

14 well separated cells Hierarchy: FMA (1) parent cell A M2L parent cell B M2M L2L children of A children of B

15 Levels of refinement Hierarchy: FMA (2)

16 Anderson s method FMM: φ() z due to large numbers of particles; Not forced to use a multipole expansion as the computational element. Instead use Poisson s formula

17 Poisson s formula (1) Solving Laplace s equation for the potential outside a disk with radius a containing sources : φ( r, θ) = κlog( r) + 2π 2 1 a 1 ( ) ( ( ) ( )) r φ as, κlog a ds a 2 a 2 2π 1 2( ) co s( ) ( ) 0 r θ s + r for r > a.

18 Poisson s formula (2) and for the potential inside a hole with radius a from sources outside: 2π 2 1 ( r 1 ) a φ( r, θ) = φ( a, s) ds ( r) cos( ) ( r π ) 0 a θ s + a for r < a.

19 Outer ring approximation (1) Numerical representation : With M an integer and K = 2M + 1, we set ( ( ) ( )) h = 2 π / K and s = acos ih, asin ih, i = 1,, K : i φ( r, θ) " κlog( r) + K 2 1 ( a 1 ) ( (, ) log ) r φ as κ ( a) h i ( a) cos( ) ( a π i= r θ s + r) i

20 Outer ring approximation (2) K φ( r, θ)

21 Construction via Poisson s formula: Parent outer rings

22 Inner ring approximation Similar as the outer ring construction: With M an integer and K = 2M + 1, we set ( ) ( ) ( ) h = 2 π / K and s = acos ih, asin ih, i = 1,, K : i φ( r, θ) " K 1 1 φ( a, s ) 2π i= cos( θ ( ) i a 2 a 2 ( r) ( r) i a r 2 s ) + h φ( r, θ) K for r < a.

23 Children inner rings K K

24 Levels of refinement Hierarchical tree

25 Hierarchy in action

26 Temporal complexity (1) Seven steps in the hierarchy : 1. Finest level direct interactions N 2 ; 2. Finest level outer ring construction KN; 3. Finest level contribution by outer rings in well-separated area KN; 4. Outer ring approximations K 2 ; 5. Inner ring approx. by outer rings K 2 ; 6. Inner ring approx. by inner ring parent K 2 ; 7. Finest level contribution by inner ring parent KN.

27 Temporal complexity (2) Total operation count depends on l f, N, and K ; with K << N and l f = f (N); For large l f this leads to : Complexity l α4 f N + βkn + γ4 f K 2 l 2 with αβγ,,, and K of order O(10) uniform distribution resulting in of particles, for a

28 Temporal complexity (3) an operation count linear in N Uniform distribution Non-uniform distribution

29 Numerical method for simulating : Contour dynamics (1) 2D, inviscid, incompressible vortex flows; Patches of uniform vorticity; Velocity field determined by the evolution of the contour bounding the patch: ur (,) t = % ln r r dr. C() t

30 Contour dynamics (2)

31 An O(N 2 ) method Contour dynamics (3)

32 Simple case : N = O(10 2 ) : Contour dynamics (4) Hard case : N = O(10 4 ) :

33 Instead of point sources, use source distributions like vorticity : Apply Anderson s method

34 Accuracy of Poisson kernel (1) Kernel is very inaccurate for r Ø a : K 2 1 a 1 ( ) (, ) (, ) r φ r θ " φ a s h i a 2 a 2 2π i= 1 1 2( r) cos( θ s ) + ( r) i Anderson solves for this: C.R. Anderson, SIAM J.Sci.Stat.Comput. Vol 13, No. 4, 1992; Vosbeek solves for this HEM (Hierarchical-Element Method): P.W.C. Vosbeek et al., J.Comput.Phys., Vol. 161, 2000.

35 Accuracy of Poisson kernel (2) From: P.W.C. Vosbeek et al., J.Comput.Phys., Vol. 161, 2000.

36 Not only point sources! Advantages of AM/HEM Operations for constructing and combining elements are easy to formulate: only function evaluation; These operations are almost identical in 2 and 3 dimensions (not discussed); HEM more accurate than AM; O(N).

A Crash Course on Fast Multipole Method (FMM)

A Crash Course on Fast Multipole Method (FMM) A Crash Course on Fast Multipole Method (FMM) Hanliang Guo Kanso Biodynamical System Lab, 2018 April What is FMM? A fast algorithm to study N body interactions (Gravitational, Coulombic interactions )

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

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

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

Multipole-Based Preconditioners for Sparse Linear Systems.

Multipole-Based Preconditioners for Sparse Linear Systems. Multipole-Based Preconditioners for Sparse Linear Systems. Ananth Grama Purdue University. Supported by the National Science Foundation. Overview Summary of Contributions Generalized Stokes Problem Solenoidal

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

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

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

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

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

A fast method for solving the Heat equation by Layer Potentials

A fast method for solving the Heat equation by Layer Potentials A fast method for solving the Heat equation by Layer Potentials Johannes Tausch Abstract Boundary integral formulations of the heat equation involve time convolutions in addition to surface potentials.

More information

Expansion of 1/r potential in Legendre polynomials

Expansion of 1/r potential in Legendre polynomials Expansion of 1/r potential in Legendre polynomials In electrostatics and gravitation, we see scalar potentials of the form V = K d Take d = R r = R 2 2Rr cos θ + r 2 = R 1 2 r R cos θ + r R )2 Use h =

More information

A Fast N-Body Solver for the Poisson(-Boltzmann) Equation

A Fast N-Body Solver for the Poisson(-Boltzmann) Equation A Fast N-Body Solver for the Poisson(-Boltzmann) Equation Robert D. Skeel Departments of Computer Science (and Mathematics) Purdue University http://bionum.cs.purdue.edu/2008december.pdf 1 Thesis Poisson(-Boltzmann)

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

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

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

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

A butterfly algorithm. for the geometric nonuniform FFT. John Strain Mathematics Department UC Berkeley February 2013

A butterfly algorithm. for the geometric nonuniform FFT. John Strain Mathematics Department UC Berkeley February 2013 A butterfly algorithm for the geometric nonuniform FFT John Strain Mathematics Department UC Berkeley February 2013 1 FAST FOURIER TRANSFORMS Standard pointwise FFT evaluates f(k) = n j=1 e 2πikj/n f j

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

Multiple Level Fast Multipole Algorithm in Differential Algebra Frame and Its Prospective Usage in Photoemission Simulation

Multiple Level Fast Multipole Algorithm in Differential Algebra Frame and Its Prospective Usage in Photoemission Simulation Multiple Level Fast Multipole Algorithm in Differential Algebra Frame and Its Prospective Usage in Photoemission Simulation Beam Theory and Dynamic Group, Department of Physics and Astronomy, Michigan

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

Contour Dynamics of Two-Dimensional Incompressible Systems

Contour Dynamics of Two-Dimensional Incompressible Systems Contour Dynamics of Two-Dimensional Incompressible Systems Christina Skowronski (a,b), Alan Dorsey (b), and Carlos Wexler (b) (a) Rutgers University, New Brunswick, NJ (b) University of Florida, Gainesville,

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

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

The Laplace Approximation

The Laplace Approximation The Laplace Approximation Sargur N. University at Buffalo, State University of New York USA Topics in Linear Models for Classification Overview 1. Discriminant Functions 2. Probabilistic Generative Models

More information

Considering our result for the sum and product of analytic functions, this means that for (a 0, a 1,..., a N ) C N+1, the polynomial.

Considering our result for the sum and product of analytic functions, this means that for (a 0, a 1,..., a N ) C N+1, the polynomial. Lecture 3 Usual complex functions MATH-GA 245.00 Complex Variables Polynomials. Construction f : z z is analytic on all of C since its real and imaginary parts satisfy the Cauchy-Riemann relations and

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

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

Physics Education Centre EXAMINATION. PHYS2016_Semester 2 Electromagnetism

Physics Education Centre EXAMINATION. PHYS2016_Semester 2 Electromagnetism Venue Student Number Physics Education Centre EXAMINATION This paper is for ANU students. Examination Duration: Reading Time: 180 minutes 15 minutes Exam Conditions: Central Examination Students must return

More information

Complex functions in the theory of 2D flow

Complex functions in the theory of 2D flow Complex functions in the theory of D flow Martin Scholtz Institute of Theoretical Physics Charles University in Prague scholtz@utf.mff.cuni.cz Faculty of Transportation Sciences Czech Technical University

More information

MULTI-LAYER HIERARCHICAL STRUCTURES AND FACTORIZATIONS

MULTI-LAYER HIERARCHICAL STRUCTURES AND FACTORIZATIONS MULTI-LAYER HIERARCHICAL STRUCTURES AND FACTORIZATIONS JIANLIN XIA Abstract. We propose multi-layer hierarchically semiseparable MHS structures for the fast factorizations of dense matrices arising from

More information

New York City College of Technology, CUNY Mathematics Department. MAT 1575 Final Exam Review Problems. 3x (a) x 2 (x 3 +1) 3 dx (b) dx.

New York City College of Technology, CUNY Mathematics Department. MAT 1575 Final Exam Review Problems. 3x (a) x 2 (x 3 +1) 3 dx (b) dx. New York City College of Technology, CUNY Mathematics Department MAT 575 Final Exam eview Problems. Evaluate the following definite integrals: x x (a) x (x +) dx (b) dx 0 0 x + 9 (c) 0 x + dx. Evaluate

More information

The Z transform (2) Alexandra Branzan Albu ELEC 310-Spring 2009-Lecture 28 1

The Z transform (2) Alexandra Branzan Albu ELEC 310-Spring 2009-Lecture 28 1 The Z transform (2) Alexandra Branzan Albu ELEC 310-Spring 2009-Lecture 28 1 Outline Properties of the region of convergence (10.2) The inverse Z-transform (10.3) Definition Computational techniques Alexandra

More information

Galactic Astronomy 2016

Galactic Astronomy 2016 10 Potential theory The study of dynamics is fundamental to any understanding of galaxies. The following few chapters provide a brief summary of the most important results. More details can be found in

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

ROTATING RING. Volume of small element = Rdθbt if weight density of ring = ρ weight of small element = ρrbtdθ. Figure 1 Rotating ring

ROTATING RING. Volume of small element = Rdθbt if weight density of ring = ρ weight of small element = ρrbtdθ. Figure 1 Rotating ring ROTATIONAL STRESSES INTRODUCTION High centrifugal forces are developed in machine components rotating at a high angular speed of the order of 100 to 500 revolutions per second (rps). High centrifugal force

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

Complex Analysis MATH 6300 Fall 2013 Homework 4

Complex Analysis MATH 6300 Fall 2013 Homework 4 Complex Analysis MATH 6300 Fall 2013 Homework 4 Due Wednesday, December 11 at 5 PM Note that to get full credit on any problem in this class, you must solve the problems in an efficient and elegant manner,

More information

NOTE. Application of Contour Dynamics to Systems with Cylindrical Boundaries

NOTE. Application of Contour Dynamics to Systems with Cylindrical Boundaries JOURNAL OF COMPUTATIONAL PHYSICS 145, 462 468 (1998) ARTICLE NO. CP986024 NOTE Application of Contour Dynamics to Systems with Cylindrical Boundaries 1. INTRODUCTION Contour dynamics (CD) is a widely used

More information

University of Illinois at Chicago Department of Physics. Electricity & Magnetism Qualifying Examination

University of Illinois at Chicago Department of Physics. Electricity & Magnetism Qualifying Examination University of Illinois at Chicago Department of Physics Electricity & Magnetism Qualifying Examination January 7, 28 9. am 12: pm Full credit can be achieved from completely correct answers to 4 questions.

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

A Multipole Based Treecode Using Spherical Harmonics for Potentials of the Form r λ

A Multipole Based Treecode Using Spherical Harmonics for Potentials of the Form r λ A Multipole Based Treecode Using Spherical Harmonics for Potentials of the Form r λ Kasthuri Srinivasan, Hemant Mahawar, and Vivek Sarin Department of Computer Science, Texas A&M University, College Station,

More information

A Second-order Finite Difference Scheme For The Wave Equation on a Reduced Polar Grid DRAFT

A Second-order Finite Difference Scheme For The Wave Equation on a Reduced Polar Grid DRAFT A Second-order Finite Difference Scheme For The Wave Equation on a Reduced Polar Grid Abstract. This paper presents a second-order numerical scheme, based on finite differences, for solving the wave equation

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, 2017 Outline Geometric Series The

More information

c2 2 x2. (1) t = c2 2 u, (2) 2 = 2 x x 2, (3)

c2 2 x2. (1) t = c2 2 u, (2) 2 = 2 x x 2, (3) ecture 13 The wave equation - final comments Sections 4.2-4.6 of text by Haberman u(x,t), In the previous lecture, we studied the so-called wave equation in one-dimension, i.e., for a function It was derived

More information

Math 10C - Fall Final Exam

Math 10C - Fall Final Exam Math 1C - Fall 217 - Final Exam Problem 1. Consider the function f(x, y) = 1 x 2 (y 1) 2. (i) Draw the level curve through the point P (1, 2). Find the gradient of f at the point P and draw the gradient

More information

Dynamics and Statistics of Quantum Turbulence in Quantum Fluid

Dynamics and Statistics of Quantum Turbulence in Quantum Fluid Dynamics and Statistics of Quantum Turbulence in Quantum Fluid Faculty of Science, Osaka City University Michikazu Kobayashi May 25, 2006, Kansai Seminar House Contents 1. 2. 3. 4. 5. Introduction - history

More information

CHAPTER THREE SYMMETRIC BENDING OF CIRCLE PLATES

CHAPTER THREE SYMMETRIC BENDING OF CIRCLE PLATES CHAPTER THREE SYMMETRIC BENDING OF CIRCLE PLATES * Governing equations in beam and plate bending ** Solution by superposition 1.1 From Beam Bending to Plate Bending 1.2 Governing Equations For Symmetric

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

Fast Direct Solver for Poisson Equation in a 2D Elliptical Domain

Fast Direct Solver for Poisson Equation in a 2D Elliptical Domain Fast Direct Solver for Poisson Equation in a 2D Elliptical Domain Ming-Chih Lai Department of Applied Mathematics National Chiao Tung University 1001, Ta Hsueh Road, Hsinchu 30050 Taiwan Received 14 October

More information

Lecture 16 February 25, 2016

Lecture 16 February 25, 2016 MTH 262/CME 372: pplied Fourier nalysis and Winter 2016 Elements of Modern Signal Processing Lecture 16 February 25, 2016 Prof. Emmanuel Candes Scribe: Carlos. Sing-Long, Edited by E. Bates 1 Outline genda:

More information

Patterns of Turbulence. Dwight Barkley and Laurette Tuckerman

Patterns of Turbulence. Dwight Barkley and Laurette Tuckerman Patterns of Turbulence Dwight Barkley and Laurette Tuckerman Plane Couette Flow Re = U gap/2 ν Experiments by Prigent and Dauchot Re400 Z (Spanwise) 40 24 o Gap 2 Length 770 X (Streamwise) Examples: Patterns

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

Infinite series, improper integrals, and Taylor series

Infinite series, improper integrals, and Taylor series Chapter Infinite series, improper integrals, and Taylor series. Determine which of the following sequences converge or diverge (a) {e n } (b) {2 n } (c) {ne 2n } (d) { 2 n } (e) {n } (f) {ln(n)} 2.2 Which

More information

General Solution of the Incompressible, Potential Flow Equations

General Solution of the Incompressible, Potential Flow Equations CHAPTER 3 General Solution of the Incompressible, Potential Flow Equations Developing the basic methodology for obtaining the elementary solutions to potential flow problem. Linear nature of the potential

More information

Part IB. Further Analysis. Year

Part IB. Further Analysis. Year Year 2004 2003 2002 2001 10 2004 2/I/4E Let τ be the topology on N consisting of the empty set and all sets X N such that N \ X is finite. Let σ be the usual topology on R, and let ρ be the topology on

More information

Linear Systems Theory

Linear Systems Theory ME 3253 Linear Systems Theory Review Class Overview and Introduction 1. How to build dynamic system model for physical system? 2. How to analyze the dynamic system? -- Time domain -- Frequency domain (Laplace

More information

MA 412 Complex Analysis Final Exam

MA 412 Complex Analysis Final Exam MA 4 Complex Analysis Final Exam Summer II Session, August 9, 00.. Find all the values of ( 8i) /3. Sketch the solutions. Answer: We start by writing 8i in polar form and then we ll compute the cubic root:

More information

1 POTENTIAL FLOW THEORY Formulation of the seakeeping problem

1 POTENTIAL FLOW THEORY Formulation of the seakeeping problem 1 POTENTIAL FLOW THEORY Formulation of the seakeeping problem Objective of the Chapter: Formulation of the potential flow around the hull of a ship advancing and oscillationg in waves Results of the Chapter:

More information

ASTR 320: Solutions to Problem Set 3

ASTR 320: Solutions to Problem Set 3 ASTR 30: Solutions to Problem Set 3 Problem : The Venturi Meter The venturi meter is used to measure the flow speed in a pipe. An example is shown in Fig., where the venturi meter (indicated by the dashed

More information

Computation of Moments in the Anisotropic Plane Elasticity Fast Multipole formulation

Computation of Moments in the Anisotropic Plane Elasticity Fast Multipole formulation Computation of Moments in the Anisotropic Plane Elasticity Fast Multipole formulation Afonso Dias Jr afonso.56@hotmail.com Universidade of Brasilia - Departamento do Engenharia Mecanica Darcy Ribeiro Campus,

More information

Improved Fast Gauss Transform. (based on work by Changjiang Yang and Vikas Raykar)

Improved Fast Gauss Transform. (based on work by Changjiang Yang and Vikas Raykar) Improved Fast Gauss Transform (based on work by Changjiang Yang and Vikas Raykar) Fast Gauss Transform (FGT) Originally proposed by Greengard and Strain (1991) to efficiently evaluate the weighted sum

More information

A Simple Compact Fourth-Order Poisson Solver on Polar Geometry

A Simple Compact Fourth-Order Poisson Solver on Polar Geometry Journal of Computational Physics 182, 337 345 (2002) doi:10.1006/jcph.2002.7172 A Simple Compact Fourth-Order Poisson Solver on Polar Geometry Ming-Chih Lai Department of Applied Mathematics, National

More information

Aerodynamics. High-Lift Devices

Aerodynamics. High-Lift Devices High-Lift Devices Devices to increase the lift coefficient by geometry changes (camber and/or chord) and/or boundary-layer control (avoid flow separation - Flaps, trailing edge devices - Slats, leading

More information

Before you begin read these instructions carefully:

Before you begin read these instructions carefully: NATURAL SCIENCES TRIPOS Part IB & II (General Friday, 30 May, 2014 9:00 am to 12:00 pm MATHEMATICS (2 Before you begin read these instructions carefully: You may submit answers to no more than six questions.

More information

Fast Algorithms for Many-Particle Simulations on Peta-Scale Parallel Architectures

Fast Algorithms for Many-Particle Simulations on Peta-Scale Parallel Architectures Mitglied der Helmholtz-Gemeinschaft Fast Algorithms for Many-Particle Simulations on Peta-Scale Parallel Architectures Godehard Sutmann Institute for Advanced Simulation (IAS) - Jülich Supercomputing Centre

More information

Section 5-7 : Green's Theorem

Section 5-7 : Green's Theorem Section 5-7 : Green's Theorem In this section we are going to investigate the relationship between certain kinds of line integrals (on closed paths) and double integrals. Let s start off with a simple

More information

5 GRAVITATION Last Updated: July 16, 2012

5 GRAVITATION Last Updated: July 16, 2012 Problem List 5.1 Total mass of a shell 5.2 Tunnel through the moon 5.3 Gravitational field above the center of a thin hoop 5.4 Gravitational force near a metal-cored planet surrounded by a gaseous cloud

More information

Improved near-wall accuracy for solutions of the Helmholtz equation using the boundary element method

Improved near-wall accuracy for solutions of the Helmholtz equation using the boundary element method Center for Turbulence Research Annual Research Briefs 2006 313 Improved near-wall accuracy for solutions of the Helmholtz equation using the boundary element method By Y. Khalighi AND D. J. Bodony 1. Motivation

More information

Tuesday, September 29, Page 453. Problem 5

Tuesday, September 29, Page 453. Problem 5 Tuesday, September 9, 15 Page 5 Problem 5 Problem. Set up and evaluate the integral that gives the volume of the solid formed by revolving the region bounded by y = x, y = x 5 about the x-axis. Solution.

More information

The purpose of this lecture is to present a few applications of conformal mappings in problems which arise in physics and engineering.

The purpose of this lecture is to present a few applications of conformal mappings in problems which arise in physics and engineering. Lecture 16 Applications of Conformal Mapping MATH-GA 451.001 Complex Variables The purpose of this lecture is to present a few applications of conformal mappings in problems which arise in physics and

More information

Fast Methods for Integral Equations. Jacob White. Thanks to Deepak Ramaswamy, Michal Rewienski, and Karen Veroy

Fast Methods for Integral Equations. Jacob White. Thanks to Deepak Ramaswamy, Michal Rewienski, and Karen Veroy Introduction to Simulation - Lecture 23 Fast Methods for Integral Equations Jacob White Thanks to Deepak Ramaswamy, Michal Rewienski, and Karen Veroy Outline Solving Discretized Integral Equations Using

More information

Math 342 Partial Differential Equations «Viktor Grigoryan

Math 342 Partial Differential Equations «Viktor Grigoryan Math 342 Partial ifferential Equations «Viktor Grigoryan 3 Green s first identity Having studied Laplace s equation in regions with simple geometry, we now start developing some tools, which will lead

More information

PHYS463 Electricity& Magnetism III ( ) Solution #1

PHYS463 Electricity& Magnetism III ( ) Solution #1 PHYS463 Electricity& Magnetism III (2003-04) lution #. Problem 3., p.5: Find the average potential over a spherical surface of radius R due to a point charge located inside (same as discussed in 3..4,

More information

FLUID MECHANICS. Chapter 3 Elementary Fluid Dynamics - The Bernoulli Equation

FLUID MECHANICS. Chapter 3 Elementary Fluid Dynamics - The Bernoulli Equation FLUID MECHANICS Chapter 3 Elementary Fluid Dynamics - The Bernoulli Equation CHAP 3. ELEMENTARY FLUID DYNAMICS - THE BERNOULLI EQUATION CONTENTS 3. Newton s Second Law 3. F = ma along a Streamline 3.3

More information

HW 3 Solution Key. Classical Mechanics I HW # 3 Solution Key

HW 3 Solution Key. Classical Mechanics I HW # 3 Solution Key Classical Mechanics I HW # 3 Solution Key HW 3 Solution Key 1. (10 points) Suppose a system has a potential energy: U = A(x 2 R 2 ) 2 where A is a constant and R is me fixed distance from the origin (on

More information

Here are brief notes about topics covered in class on complex numbers, focusing on what is not covered in the textbook.

Here are brief notes about topics covered in class on complex numbers, focusing on what is not covered in the textbook. Phys374, Spring 2008, Prof. Ted Jacobson Department of Physics, University of Maryland Complex numbers version 5/21/08 Here are brief notes about topics covered in class on complex numbers, focusing on

More information

1 Exam 1 Spring 2007.

1 Exam 1 Spring 2007. Exam Spring 2007.. An object is moving along a line. At each time t, its velocity v(t is given by v(t = t 2 2 t 3. Find the total distance traveled by the object from time t = to time t = 5. 2. Use the

More information

Dielectrics. Lecture 20: Electromagnetic Theory. Professor D. K. Ghosh, Physics Department, I.I.T., Bombay

Dielectrics. Lecture 20: Electromagnetic Theory. Professor D. K. Ghosh, Physics Department, I.I.T., Bombay What are dielectrics? Dielectrics Lecture 20: Electromagnetic Theory Professor D. K. Ghosh, Physics Department, I.I.T., Bombay So far we have been discussing electrostatics in either vacuum or in a conductor.

More information

z + az + bz + 12 = 0, where a and b are real numbers, is

z + az + bz + 12 = 0, where a and b are real numbers, is 016 IJC H Math 9758 Promotional Examination 1 One root of the equation z = 1 i z + az + bz + 1 = 0, where a and b are real numbers, is. Without using a calculator, find the values of a and b and the other

More information

LESSON 14: VOLUME OF SOLIDS OF REVOLUTION SEPTEMBER 27, 2017

LESSON 14: VOLUME OF SOLIDS OF REVOLUTION SEPTEMBER 27, 2017 LESSON 4: VOLUME OF SOLIDS OF REVOLUTION SEPTEMBER 27, 27 We continue to expand our understanding of solids of revolution. The key takeaway from today s lesson is that finding the volume of a solid of

More information

1 Constant Pressure Inner Boundary Condition

1 Constant Pressure Inner Boundary Condition Jim Lambers ENERGY 281 Spring Quarter 2007-08 Lecture 8 Notes These notes are based on Rosalind Archer s PE281 lecture notes, with some revisions by Jim Lambers. 1 Constant Pressure Inner Boundary Condition

More information

Analysis of eddy currents in a gradient coil

Analysis of eddy currents in a gradient coil Analysis of eddy currents in a gradient coil J.M.B. Kroot Eindhoven University of Technology P.O.Box 53; 56 MB Eindhoven, The Netherlands Abstract To model the z-coil of an MRI-scanner, a set of circular

More information

Quantum vortex reconnections

Quantum vortex reconnections Quantum vortex reconnections A.W. Baggaley 1,2, S. Zuccher 4, Carlo F Barenghi 2, 3, A.J. Youd 2 1 University of Glasgow 2 Joint Quantum Centre Durham-Newcastle 3 Newcastle University 4 University of Verona

More information

2.25 Advanced Fluid Mechanics

2.25 Advanced Fluid Mechanics MIT Department of Mechanical Engineering 2.25 Advanced Fluid Mechanics Problem 10.3 This problem is from Advanced Fluid Mechanics Problems by A.H. Shapiro and A.A. Sonin Consider the three different, steady,

More information

Instabilities due a vortex at a density interface: gravitational and centrifugal effects

Instabilities due a vortex at a density interface: gravitational and centrifugal effects Instabilities due a vortex at a density interface: gravitational and centrifugal effects Harish N Dixit and Rama Govindarajan Abstract A vortex placed at an initially straight density interface winds it

More information

A Fast, Parallel Potential Flow Solver

A Fast, Parallel Potential Flow Solver Advisor: Jaime Peraire December 16, 2012 Outline 1 Introduction to Potential FLow 2 The Boundary Element Method 3 The Fast Multipole Method 4 Discretization 5 Implementation 6 Results 7 Conclusions Why

More information

Complex Series (3A) Young Won Lim 8/17/13

Complex Series (3A) Young Won Lim 8/17/13 Complex Series (3A) 8/7/3 Copyright (c) 202, 203 Young W. Lim. Permission is granted to copy, distribute and/or modify this document under the terms of the GNU Free Documentation License, Version.2 or

More information

Transactions on Modelling and Simulation vol 19, 1998 WIT Press, ISSN X

Transactions on Modelling and Simulation vol 19, 1998 WIT Press,   ISSN X Cost estimation of the panel clustering method applied to 3-D elastostatics Ken Hayami* & Stefan A. Sauter^ * Department of Mathematical Engineering and Information Physics, Graduate School of Engineering,

More information

Complex Variables...Review Problems (Residue Calculus Comments)...Fall Initial Draft

Complex Variables...Review Problems (Residue Calculus Comments)...Fall Initial Draft Complex Variables........Review Problems Residue Calculus Comments)........Fall 22 Initial Draft ) Show that the singular point of fz) is a pole; determine its order m and its residue B: a) e 2z )/z 4,

More information

APPROXIMATING GAUSSIAN PROCESSES

APPROXIMATING GAUSSIAN PROCESSES 1 / 23 APPROXIMATING GAUSSIAN PROCESSES WITH H 2 -MATRICES Steffen Börm 1 Jochen Garcke 2 1 Christian-Albrechts-Universität zu Kiel 2 Universität Bonn and Fraunhofer SCAI 2 / 23 OUTLINE 1 GAUSSIAN PROCESSES

More information

FOR SOLVING COMBINED FIELD INTEGRAL EQUATION. OF ELECTROMAGNETIC SCATTERING y. J. M. Song and W. C. Chew. Electromagnetics Laboratory

FOR SOLVING COMBINED FIELD INTEGRAL EQUATION. OF ELECTROMAGNETIC SCATTERING y. J. M. Song and W. C. Chew. Electromagnetics Laboratory MULTILEVEL FAST MULTIPOLE ALGORITHM FOR SOLVING COMBINED FIELD INTEGRAL EQUATION OF ELECTROMAGNETIC SCATTERING y J. M. Song and W. C. Chew Electromagnetics Laboratory Department of Electrical and Computer

More information

PHYS 404 Lecture 1: Legendre Functions

PHYS 404 Lecture 1: Legendre Functions PHYS 404 Lecture 1: Legendre Functions Dr. Vasileios Lempesis PHYS 404 - LECTURE 1 DR. V. LEMPESIS 1 Legendre Functions physical justification Legendre functions or Legendre polynomials are the solutions

More information

Mathematical Modelling Lecture 14 Fractals

Mathematical Modelling Lecture 14 Fractals Lecture 14 phil.hasnip@york.ac.uk Overview of Course Model construction dimensional analysis Experimental input fitting Finding a best answer optimisation Tools for constructing and manipulating models

More information

Offshore Hydromechanics Module 1

Offshore Hydromechanics Module 1 Offshore Hydromechanics Module 1 Dr. ir. Pepijn de Jong 4. Potential Flows part 2 Introduction Topics of Module 1 Problems of interest Chapter 1 Hydrostatics Chapter 2 Floating stability Chapter 2 Constant

More information

INTEGRATION WORKSHOP 2003 COMPLEX ANALYSIS EXERCISES

INTEGRATION WORKSHOP 2003 COMPLEX ANALYSIS EXERCISES INTEGRATION WORKSHOP 23 COMPLEX ANALYSIS EXERCISES DOUGLAS ULMER 1. Meromorphic functions on the Riemann sphere It s often useful to allow functions to take the value. This exercise outlines one way to

More information

Solutions to Problem Set 4

Solutions to Problem Set 4 UC Berkeley, CS 174: Combinatorics and Discrete Probability (Fall 010 Solutions to Problem Set 4 1. (MU 5.4 In a lecture hall containing 100 people, you consider whether or not there are three people in

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 10 September 27, 2016

Lecture 10 September 27, 2016 CS 395T: Sublinear Algorithms Fall 2016 Prof. Eric Price Lecture 10 September 27, 2016 Scribes: Quinten McNamara & William Hoza 1 Overview In this lecture, we focus on constructing coresets, which are

More information

MTH 3102 Complex Variables Solutions: Practice Exam 2 Mar. 26, 2017

MTH 3102 Complex Variables Solutions: Practice Exam 2 Mar. 26, 2017 Name Last name, First name): MTH 31 omplex Variables Solutions: Practice Exam Mar. 6, 17 Exam Instructions: You have 1 hour & 1 minutes to complete the exam. There are a total of 7 problems. You must show

More information