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

Size: px
Start display at page:

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

Transcription

1 A Fast N-Body Solver for the Poisson(-Boltzmann) Equation Robert D. Skeel Departments of Computer Science (and Mathematics) Purdue University 1

2 Thesis Poisson(-Boltzmann) equation can be solved much faster. Using a fast N-body solver as preconditioner is key. Especially suited for modern computers. Work with D. Yershov and S. Bond. Multilevel summation is the method of choice for molecular biophysics / structural biology. Work with D. Hardy. 2

3 Poisson(-Boltzmann) equation Generalized Poisson equation with explicit ions.: (ε ( r) Φ ( r)) = 4π N i=1 q i δ ( r r i ). Extension to other equations possible. 3

4 Outline I. Multilevel summation: an approximation II. Multilevel summation: an algorithm III. Types of N-body solvers IV. Comparison of N-body solvers 4

5 Creating a fast N-body solver derive an approximation construct an algorithm Please defer any thoughts about an algorithm until later. 5

6 Interactions in 1 dimension An N-body solver calculates O(N 2 ) 2-body nonbonded interactions, U el = 1 2 N i=1 N j=1,j i q i q j k(x i, x j ), k(x, x ) = 1 x x where x i are particle positions and q i are partial charges. 6

7 Matrix form where q = charges, K ij = U el = 1 2 qt Kq, e = Kq = potentials { k(xi, x j ), j i 0, j = i Matrix form best reveals structure of algorithms. 7

8 Kernel splitting Separate length scales by splitting k = k 0 + k k ν where (i) the range of k µ increases with µ, but also (ii) the smoothness of k µ increases with µ. (k 1,..., k ν are approximated on grids of increasing coarseness.) A corresponding matrix splitting: K = K 0 + K K ν 8

9 Distant-dependent kernel If k(x, x ) = g( x x ), define k µ (x, x ) = g µ ( x x ) where g(r) = g 0 (r) + g 1 (r) + + g ν (r) e.g., 1/r (softened 1/r) softened 1/r 1 r = r }{{} g 0 (r) 0 0 r }{{} g 1 (r) 9

10 Banded matrices Also, if 0 x 1 < x 2 < < x n L, the values k µ (x i, x j ) = 0 for large enough i j, so the matrices K µ are banded with increasing bandwidth. The slowly varying parts k 1 (x, x ),..., k ν (x, x ) are approximated... 10

11 Digression: approximation in 1D Consider f(x) = k µ (x, x ) with x an arbitrary parameter. Goal is to approximate f(x) in terms of its values (and derivs.) on a uniform grid 0 = x h 0 < x h 1 < < x h M = L: f(x) φ 0 (x)f(x h 0) + φ 1 (x)f(x h 1) + + φ M (x)f(x h M) where the φ m (x) are basis functions having local support, e.g., piecewise polynomials: 11

12 Matrix form of approximation f(x) φ(x) T f h where φ(x) = [φ 0 (x), φ 1 (x),..., φ M (x)] T and f h = [ f(x h 0), f(x h 1),..., f(x h M) ] T. At particle positions f(x 1 ) φ(x 1 ) T f h. f(x N ) φ(x N ) T f h 12

13 Approximation operator f(x 1 ). f(x N ) φ(x 1 ) T. φ(x N ) T f h def = I h f h The operator I h maps gridded values to particle values. Only a fixed number, e.g., 4, of nonzeros for each row of I h. 13

14 Approximation in 2D Analogous to f(x) φ(x) T f h, it can be shown that with K h µ = we have k µ (x h 0, x h 0) k µ (x h 0, x h 1) k µ (x h 0, x h M ) k µ (x h 1, x h 0) k µ (x h 1, x h 1) k µ (x h 1, x h M ) k µ (x h M, xh 0) k µ (x h M, xh 1) k µ (x h M, xh M ) a separable approximation. k µ (x, x ) φ(x) T K h µφ(x ), 14

15 Therefore, tabulation of k µ (x, x ) tabulation of φ(x) T K h µφ(x ) and K µ = k µ (x 1, x 1 ).... k µ (x 1, x N ). k µ (x N, x 1 ) k µ (x N, x N ) φ(x 1 ) T. φ(x N ) T K h µ [ φ(x1 ) φ(x N ) ] = I h K h µi T h. 15

16 Multilevel summation approximation A 4-level summation method splits the kernel as k = k 0 + k 1 + k 2 + k 3, where each term has twice the range of its predecessor. With interpolation from successively coarser grids, the corresponding matrix decomposition is K K 0 + I h K h 1 I T h + I 2h K 2h 2 I T 2h + I 4h K 4h 3 I T 4h. 16

17 Outline I. Multilevel summation: an approximation II. Multilevel summation: an algorithm III. Types of N-body solvers IV. Comparison of N-body solvers 17

18 An O(N log N) method anterpolation: q h = I T hq, q 2h = I T 2hq, q 4h = I T 4hq U 1 ( q T K 0 q + (q h ) T K1 h q h + (q 2h ) T K2 2h q 2h + (q 4h ) T K3 4h q 4h). 2 With O(log N) terms the number of operations per term is only O(N). 18

19 An O(N) method For finite element-style interpolation I 2h = I h I h 2h and I 4h = I h I h 2hI 2h 4h. Not quite true for finite difference-style interpolation, e.g., for nodal basis functions Substituting and factoring out common factors gives... 19

20 Nested multilevel summation method K K 0 + I h ( K h 1 + I h 2h ( K 2h 2 + I 2h 4hK 4h 3 (I 2h 4h) T) (I h 2h) T) I T h. e Kq is computed as follows for a 5-level method: 20

21 q h = I T hq O(N) ops q 2h = (I h 2h) T q h O(M) ops q 4h = (I 2h 4h) T q 2h O(M/2) ops q 8h = (I 4h 8h) T q 4h O(M/4) ops e 8h = K 8h 4 q 8h O((M/8) 2 ) ops e 4h = K 4h 3 q 4h + I 4h 8he 8h e 2h = K 2h 2 q 2h + I 2h 4he 4h O(M/4) ops O(M/2) ops e h = K h 1 q h + I h 2he 2h O(M) ops e = K 0 q + I h e h O(N) ops 21

22 Nested multilevel summation method, diagram 22

23 Basis for all fast N-body solvers separable approximation for kernel k(x, x ), associativity (and distributivity) of matrix operations. 23

24 Outline I. Multilevel summation: an approximation II. Multilevel summation: an algorithm III. Types of N-body solvers IV. Comparison of N-body solvers 24

25 More generally, Nonbonded 2-body interactions U nb = U nb ( r 1, r 2,..., r N ) = 1 2 where r i are particle positions, the primed sum omits excluded pairs, kernels other than r r 1 possible, periodicity in any dimension possible, extension to dipoles, etc. possible. N i=1 N q i q j k( r i, r j ) j=1 25

26 Forces F nb i = i U nb ( r 1, r 2,..., r N ) are best obtained by differentiating the approximation to U nb ( r 1, r 2,..., r N ). 26

27 Types of N-body solvers I. kernel splitting method (KSM): multilevel summation, PME, P 3 M II. hierarchical clustering method (HCM): FMM, tree methods Another classification: 2-level: uses FFT for gridded values multilevel: uses O(log N) levels of grids/cells nested multilevel: reduces cost to O(N) 27

28 History of multilevel summation integral transforms, Brandt & Lubrecht (1990) particle monopoles and dipoles in 2D, Sandak (2001) C 1 potentials for particles in 3D, Skeel, Tezcan & Hardy (2002) generalized Born potentials, Lee, Salsbury & Olson (2004) higher order accuracy, analysis, periodicity, Hardy (2006) 28

29 Two-level method w/ real space FFT In K 1 I h K1 h Ih T k 1 (0 k 1 ( h) k 1 ( Mh) K1 h k = 1 (h) k 1 (0) k 1 (h Mh) k 1 (Mh) k 1 (Mh h) k 1 (0), is a nonperiodic convolution computable by an FFT if the dimension of the matrix is doubled. 29

30 Two-level method w/ reciprocal space FFT Modify g 1 (r) to be constant for r L + L and let κ 1 (r) be a periodic extension of g 1 (r) with period 2(L + L). Truncate Fourier series: k 1 (x, x ) = κ 1 (x x ) ψ(x ) T Dψ(x) where D is diagonal matrix and ψ(x) is Fourier basis. 30

31 Interpolating from gridded values F of the Fourier basis hence Tabulating at particle positions ψ(x) T φ(x) T F κ 1 (x x ) φ(x ) T F T DF φ(x) K 1 I h F T DF I T h. This is particle mesh Ewald (PME), a variant of an older approach, viz., particle particle particle mesh Ewald (P 3 M). 31

32 Hierarchical clustering methods employ an oct-tree decomposition of space to partition the interactions into different levels: K = K 0 + K 1 + K 2 + K 3, with higher level interactions for more separated particles. Short range directly. Longer range are partitioned into pairs of particle clusters, each using a different localized (polynomial) approximation for the kernel k( r, r ). 32

33 Truncated Taylor expansions are used in practice. For r r 1, each polynomial is harmonic and can expressed in terms of p 2 spherical harmonics, where p 1 is the degree of the polynomial, instead of 1 6 p p p monomials. The entries of K h 1, K 2h 2,... are then multipoles. 33

34 Outline I. Multilevel summation: an approximation II. Multilevel summation: an algorithm III. Types of N-body solvers IV. Comparison of N-body solvers 34

35 KSMs vs. HCMs Advantages of KSMs over HCMs: HCMs yield a U that is a discontinuous function of r, r ; KSMs can attain any degree of continuity. KSMs are simpler they do not need interaction lists. KSMs are faster in comparisons I have seen. Advantage of HCMs over KSMs: HCMs can exploit special properties of kernel. However, this depends on the kernel, and it can greatly complicate the algorithm. 35

36 Nonissue: Only HCMs honor Newton s 3rd Law. Unknown: Is adaptivity as efficient for KSMs as it is for HCMs? 36

37 Energy drift for HCMs HCMs compute discontinuous forces, so are not usable unless high accuracy is requested terms in FMA 12 terms in FMA 16 terms in FMA total energy (kcal/mol) time (fs) Our multisummation method is 11 times faster than a fast multipole method for MD, partly because the latter needs 12 terms to avoid rapid energy growth. 37

38 7 6 Multisummation vs. multipole CPU time vs. error for 10,002 waters DPMTA (FMM), theta=0.50 DPMTA (FMM), theta=0.75 C1 nonic, C5 Taylor, h=3 C1 septic, C4 Taylor, h=3 C1 quintic, C3 Taylor, h=3 cubic, sigma[2,6], h=3 Hermite, C3 Taylor, h=6 5 time in seconds e percent relative error in average force 38

39 Conservation of linear momentum HCM approximations yield forces that obey Newton s 3rd Law. KSM approximations lack this property. (And produce self forces!) The usual remedy F i (1/N) j F j yields nonconservative forces. However, the mass-weighted correction F i (...) m i m tot j F j (...) is the gradient of a potential. Skeel, Hardy & Phillips (2007) 39

40 Multilevel vs. 2-level Advantages of multilevel over 2-level methods: FFT-based methods require doubling the dimension in each direction that is nonperiodic. FFT-based methods are very difficult to parallelize. adaptivity not possible for 2-level methods multilevel methods are faster in comparisons we have done. Our multisummation method is twice as fast as PME. 40

41 20 15 Multisummation vs. particle mesh Ewald CPU time vs. error for 21,950 waters PME, quintic, 64 divisions PME, cubic, 64 divisions C1 nonic, C5 Taylor, 32 divisions C1 septic, C4 Taylor, 32 divisions C1 quintic, C3 Taylor, 32 divisions cubic, sigma[2,6], 32 divisions Hermite, C3 Taylor, 16 divisions time in seconds e percent relative error in average force 41

Laplacian-Centered Poisson Solvers and Multilevel Summation Algorithms

Laplacian-Centered Poisson Solvers and Multilevel Summation Algorithms Laplacian-Centered Poisson Solvers and Multilevel Summation Algorithms Dmitry Yershov 1 Stephen Bond 1 Robert Skeel 2 1 University of Illinois at Urbana-Champaign 2 Purdue University 2009 SIAM Annual Meeting

More information

Accepted Manuscript. Correcting Mesh-Based Force Calculations to Conserve Both Energy and Momentum in Molecular Dynamics Simulations

Accepted Manuscript. Correcting Mesh-Based Force Calculations to Conserve Both Energy and Momentum in Molecular Dynamics Simulations Accepted Manuscript Correcting Mesh-Based Force Calculations to Conserve Both Energy and Momentum in Molecular Dynamics Simulations Robert D. Seel, David J. Hardy, James C. Phillips PII: S001-1(0)001-1

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

Molecular Dynamics Simulations

Molecular Dynamics Simulations Molecular Dynamics Simulations Dr. Kasra Momeni www.knanosys.com Outline Long-range Interactions Ewald Sum Fast Multipole Method Spherically Truncated Coulombic Potential Speeding up Calculations SPaSM

More information

Non-bonded interactions

Non-bonded interactions speeding up the number-crunching continued Marcus Elstner and Tomáš Kubař December 3, 2013 why care? number of individual pair-wise interactions bonded interactions proportional to N: O(N) non-bonded interactions

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

Non-bonded interactions

Non-bonded interactions speeding up the number-crunching Marcus Elstner and Tomáš Kubař May 8, 2015 why care? key to understand biomolecular structure and function binding of a ligand efficiency of a reaction color of a chromophore

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

MATH 590: Meshfree Methods

MATH 590: Meshfree Methods MATH 590: Meshfree Methods Chapter 34: Improving the Condition Number of the Interpolation Matrix Greg Fasshauer Department of Applied Mathematics Illinois Institute of Technology Fall 2010 fasshauer@iit.edu

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

An FPGA Implementation of Reciprocal Sums for SPME

An FPGA Implementation of Reciprocal Sums for SPME An FPGA Implementation of Reciprocal Sums for SPME Sam Lee and Paul Chow Edward S. Rogers Sr. Department of Electrical and Computer Engineering University of Toronto Objectives Accelerate part of Molecular

More information

H 2 -matrices with adaptive bases

H 2 -matrices with adaptive bases 1 H 2 -matrices with adaptive bases Steffen Börm MPI für Mathematik in den Naturwissenschaften Inselstraße 22 26, 04103 Leipzig http://www.mis.mpg.de/ Problem 2 Goal: Treat certain large dense matrices

More information

(f(x) P 3 (x)) dx. (a) The Lagrange formula for the error is given by

(f(x) P 3 (x)) dx. (a) The Lagrange formula for the error is given by 1. QUESTION (a) Given a nth degree Taylor polynomial P n (x) of a function f(x), expanded about x = x 0, write down the Lagrange formula for the truncation error, carefully defining all its elements. How

More information

Downloaded 06/02/16 to Redistribution subject to SIAM license or copyright; see

Downloaded 06/02/16 to Redistribution subject to SIAM license or copyright; see SIAM J. SCI. COMPUT. Vol. 38, No. 3, pp. A1538 A1560 c 2016 Society for Industrial and Applied Mathematics A FINITE ELEMENT BASED P 3 MMETHODFORN-BODY PROBLEMS NATALIE N. BEAMS, LUKE N. OLSON, AND JONATHAN

More information

3.1 Interpolation and the Lagrange Polynomial

3.1 Interpolation and the Lagrange Polynomial MATH 4073 Chapter 3 Interpolation and Polynomial Approximation Fall 2003 1 Consider a sample x x 0 x 1 x n y y 0 y 1 y n. Can we get a function out of discrete data above that gives a reasonable estimate

More information

LA Support for Scalable Kernel Methods. David Bindel 29 Sep 2018

LA Support for Scalable Kernel Methods. David Bindel 29 Sep 2018 LA Support for Scalable Kernel Methods David Bindel 29 Sep 2018 Collaborators Kun Dong (Cornell CAM) David Eriksson (Cornell CAM) Jake Gardner (Cornell CS) Eric Lee (Cornell CS) Hannes Nickisch (Phillips

More information

MOLECULAR DYNAMICS SIMULATIONS OF BIOMOLECULES: Long-Range Electrostatic Effects

MOLECULAR DYNAMICS SIMULATIONS OF BIOMOLECULES: Long-Range Electrostatic Effects Annu. Rev. Biophys. Biomol. Struct. 1999. 28:155 79 Copyright c 1999 by Annual Reviews. All rights reserved MOLECULAR DYNAMICS SIMULATIONS OF BIOMOLECULES: Long-Range Electrostatic Effects Celeste Sagui

More information

Neighbor Tables Long-Range Potentials

Neighbor Tables Long-Range Potentials Neighbor Tables Long-Range Potentials Today we learn how we can handle long range potentials. Neighbor tables Long-range potential Ewald sums MSE485/PHY466/CSE485 1 Periodic distances Minimum Image Convention:

More information

The spectral transform method

The spectral transform method The spectral transform method by Nils Wedi European Centre for Medium-Range Weather Forecasts wedi@ecmwf.int Advanced Numerical Methods for Earth-System Modelling Slide 1 Advanced Numerical Methods for

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

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

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

INTRODUCTION TO FINITE ELEMENT METHODS ON ELLIPTIC EQUATIONS LONG CHEN

INTRODUCTION TO FINITE ELEMENT METHODS ON ELLIPTIC EQUATIONS LONG CHEN INTROUCTION TO FINITE ELEMENT METHOS ON ELLIPTIC EQUATIONS LONG CHEN CONTENTS 1. Poisson Equation 1 2. Outline of Topics 3 2.1. Finite ifference Method 3 2.2. Finite Element Method 3 2.3. Finite Volume

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

Domain Decomposition Preconditioners for Spectral Nédélec Elements in Two and Three Dimensions

Domain Decomposition Preconditioners for Spectral Nédélec Elements in Two and Three Dimensions Domain Decomposition Preconditioners for Spectral Nédélec Elements in Two and Three Dimensions Bernhard Hientzsch Courant Institute of Mathematical Sciences, New York University, 51 Mercer Street, New

More information

An Accurate Fourier-Spectral Solver for Variable Coefficient Elliptic Equations

An Accurate Fourier-Spectral Solver for Variable Coefficient Elliptic Equations An Accurate Fourier-Spectral Solver for Variable Coefficient Elliptic Equations Moshe Israeli Computer Science Department, Technion-Israel Institute of Technology, Technion city, Haifa 32000, ISRAEL Alexander

More information

Aspects of Multigrid

Aspects of Multigrid Aspects of Multigrid Kees Oosterlee 1,2 1 Delft University of Technology, Delft. 2 CWI, Center for Mathematics and Computer Science, Amsterdam, SIAM Chapter Workshop Day, May 30th 2018 C.W.Oosterlee (CWI)

More information

An Efficient Algorithm Based on Quadratic Spline Collocation and Finite Difference Methods for Parabolic Partial Differential Equations.

An Efficient Algorithm Based on Quadratic Spline Collocation and Finite Difference Methods for Parabolic Partial Differential Equations. An Efficient Algorithm Based on Quadratic Spline Collocation and Finite Difference Methods for Parabolic Partial Differential Equations by Tong Chen A thesis submitted in conformity with the requirements

More information

Scientific Computing: An Introductory Survey

Scientific Computing: An Introductory Survey Scientific Computing: An Introductory Survey Chapter 7 Interpolation Prof. Michael T. Heath Department of Computer Science University of Illinois at Urbana-Champaign Copyright c 2002. Reproduction permitted

More information

Lecture 9 Approximations of Laplace s Equation, Finite Element Method. Mathématiques appliquées (MATH0504-1) B. Dewals, C.

Lecture 9 Approximations of Laplace s Equation, Finite Element Method. Mathématiques appliquées (MATH0504-1) B. Dewals, C. Lecture 9 Approximations of Laplace s Equation, Finite Element Method Mathématiques appliquées (MATH54-1) B. Dewals, C. Geuzaine V1.2 23/11/218 1 Learning objectives of this lecture Apply the finite difference

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

Poisson Solvers. William McLean. April 21, Return to Math3301/Math5315 Common Material.

Poisson Solvers. William McLean. April 21, Return to Math3301/Math5315 Common Material. Poisson Solvers William McLean April 21, 2004 Return to Math3301/Math5315 Common Material 1 Introduction Many problems in applied mathematics lead to a partial differential equation of the form a 2 u +

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

Cubic Splines MATH 375. J. Robert Buchanan. Fall Department of Mathematics. J. Robert Buchanan Cubic Splines

Cubic Splines MATH 375. J. Robert Buchanan. Fall Department of Mathematics. J. Robert Buchanan Cubic Splines Cubic Splines MATH 375 J. Robert Buchanan Department of Mathematics Fall 2006 Introduction Given data {(x 0, f(x 0 )), (x 1, f(x 1 )),...,(x n, f(x n ))} which we wish to interpolate using a polynomial...

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

Computer simulation methods (2) Dr. Vania Calandrini

Computer simulation methods (2) Dr. Vania Calandrini Computer simulation methods (2) Dr. Vania Calandrini in the previous lecture: time average versus ensemble average MC versus MD simulations equipartition theorem (=> computing T) virial theorem (=> computing

More information

Multipoles, Electrostatics of Macroscopic Media, Dielectrics

Multipoles, Electrostatics of Macroscopic Media, Dielectrics Multipoles, Electrostatics of Macroscopic Media, Dielectrics 1 Reading: Jackson 4.1 through 4.4, 4.7 Consider a distribution of charge, confined to a region with r < R. Let's expand the resulting potential

More information

Computational Molecular Biophysics. Computational Biophysics, GRS Jülich SS 2013

Computational Molecular Biophysics. Computational Biophysics, GRS Jülich SS 2013 Computational Molecular Biophysics Computational Biophysics, GRS Jülich SS 2013 Computational Considerations Number of terms for different energy contributions / E el ~N ~N ~N ~N 2 Computational cost for

More information

Brad Gibson Centre for Astrophysics & Supercomputing Swinburne University

Brad Gibson Centre for Astrophysics & Supercomputing Swinburne University N-body Simulations: Tree and Mesh Approaches Brad Gibson Centre for Astrophysics & Supercomputing Swinburne University Demystifying the Jargon Trees Collisionless Boltzmann Equation Symplectic Time Integration

More information

Exam 2. Average: 85.6 Median: 87.0 Maximum: Minimum: 55.0 Standard Deviation: Numerical Methods Fall 2011 Lecture 20

Exam 2. Average: 85.6 Median: 87.0 Maximum: Minimum: 55.0 Standard Deviation: Numerical Methods Fall 2011 Lecture 20 Exam 2 Average: 85.6 Median: 87.0 Maximum: 100.0 Minimum: 55.0 Standard Deviation: 10.42 Fall 2011 1 Today s class Multiple Variable Linear Regression Polynomial Interpolation Lagrange Interpolation Newton

More information

Math 4263 Homework Set 1

Math 4263 Homework Set 1 Homework Set 1 1. Solve the following PDE/BVP 2. Solve the following PDE/BVP 2u t + 3u x = 0 u (x, 0) = sin (x) u x + e x u y = 0 u (0, y) = y 2 3. (a) Find the curves γ : t (x (t), y (t)) such that that

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

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

Optimal multilevel preconditioning of strongly anisotropic problems.part II: non-conforming FEM. p. 1/36

Optimal multilevel preconditioning of strongly anisotropic problems.part II: non-conforming FEM. p. 1/36 Optimal multilevel preconditioning of strongly anisotropic problems. Part II: non-conforming FEM. Svetozar Margenov margenov@parallel.bas.bg Institute for Parallel Processing, Bulgarian Academy of Sciences,

More information

Advanced Molecular Molecular Dynamics

Advanced Molecular Molecular Dynamics Advanced Molecular Molecular Dynamics Technical details May 12, 2014 Integration of harmonic oscillator r m period = 2 k k and the temperature T determine the sampling of x (here T is related with v 0

More information

Chapter 5 HIGH ACCURACY CUBIC SPLINE APPROXIMATION FOR TWO DIMENSIONAL QUASI-LINEAR ELLIPTIC BOUNDARY VALUE PROBLEMS

Chapter 5 HIGH ACCURACY CUBIC SPLINE APPROXIMATION FOR TWO DIMENSIONAL QUASI-LINEAR ELLIPTIC BOUNDARY VALUE PROBLEMS Chapter 5 HIGH ACCURACY CUBIC SPLINE APPROXIMATION FOR TWO DIMENSIONAL QUASI-LINEAR ELLIPTIC BOUNDARY VALUE PROBLEMS 5.1 Introduction When a physical system depends on more than one variable a general

More information

Finite Elements. Colin Cotter. January 18, Colin Cotter FEM

Finite Elements. Colin Cotter. January 18, Colin Cotter FEM Finite Elements January 18, 2019 The finite element Given a triangulation T of a domain Ω, finite element spaces are defined according to 1. the form the functions take (usually polynomial) when restricted

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

Moving interface problems. for elliptic systems. John Strain Mathematics Department UC Berkeley June 2010

Moving interface problems. for elliptic systems. John Strain Mathematics Department UC Berkeley June 2010 Moving interface problems for elliptic systems John Strain Mathematics Department UC Berkeley June 2010 1 ALGORITHMS Implicit semi-lagrangian contouring moves interfaces with arbitrary topology subject

More information

Numerical Methods I Orthogonal Polynomials

Numerical Methods I Orthogonal Polynomials Numerical Methods I Orthogonal Polynomials Aleksandar Donev Courant Institute, NYU 1 donev@courant.nyu.edu 1 Course G63.2010.001 / G22.2420-001, Fall 2010 Nov. 4th and 11th, 2010 A. Donev (Courant Institute)

More information

2. The Schrödinger equation for one-particle problems. 5. Atoms and the periodic table of chemical elements

2. The Schrödinger equation for one-particle problems. 5. Atoms and the periodic table of chemical elements 1 Historical introduction The Schrödinger equation for one-particle problems 3 Mathematical tools for quantum chemistry 4 The postulates of quantum mechanics 5 Atoms and the periodic table of chemical

More information

The Fast Multipole Method in molecular dynamics

The Fast Multipole Method in molecular dynamics The Fast Multipole Method in molecular dynamics Berk Hess KTH Royal Institute of Technology, Stockholm, Sweden ADAC6 workshop Zurich, 20-06-2018 Slide BioExcel Slide Molecular Dynamics of biomolecules

More information

Hierarchical Matrices. Jon Cockayne April 18, 2017

Hierarchical Matrices. Jon Cockayne April 18, 2017 Hierarchical Matrices Jon Cockayne April 18, 2017 1 Sources Introduction to Hierarchical Matrices with Applications [Börm et al., 2003] 2 Sources Introduction to Hierarchical Matrices with Applications

More information

LECTURE NOTES ELEMENTARY NUMERICAL METHODS. Eusebius Doedel

LECTURE NOTES ELEMENTARY NUMERICAL METHODS. Eusebius Doedel LECTURE NOTES on ELEMENTARY NUMERICAL METHODS Eusebius Doedel TABLE OF CONTENTS Vector and Matrix Norms 1 Banach Lemma 20 The Numerical Solution of Linear Systems 25 Gauss Elimination 25 Operation Count

More information

Fast Ewald Summation based on NFFT with Mixed Periodicity

Fast Ewald Summation based on NFFT with Mixed Periodicity Fast Ewald Summation based on NFFT with Mixed Periodicity Franziska Nestler, Michael Pippig and Daniel Potts In this paper we develop new fast Fourier-based methods for the Coulomb problem. We combine

More information

Multigrid and Domain Decomposition Methods for Electrostatics Problems

Multigrid and Domain Decomposition Methods for Electrostatics Problems Multigrid and Domain Decomposition Methods for Electrostatics Problems Michael Holst and Faisal Saied Abstract. We consider multigrid and domain decomposition methods for the numerical solution of electrostatics

More information

Multiscale Modelling, taking into account Collisions

Multiscale Modelling, taking into account Collisions Multiscale Modelling, taking into account Collisions Andreas Adelmann (Paul Scherrer Institut) October 28, 2017 Multiscale Modelling, taking into account Collisions October 28, 2017 Page 1 / 22 1 Motivation

More information

Poisson Solver, Pseudopotentials, Atomic Forces in the BigDFT code

Poisson Solver, Pseudopotentials, Atomic Forces in the BigDFT code CECAM Tutorial on Wavelets in DFT, CECAM - LYON,, in the BigDFT code Kernel Luigi Genovese L_Sim - CEA Grenoble 28 November 2007 Outline, Kernel 1 The with Interpolating Scaling Functions in DFT for Interpolating

More information

A FAST SOLVER FOR ELLIPTIC EQUATIONS WITH HARMONIC COEFFICIENT APPROXIMATIONS

A FAST SOLVER FOR ELLIPTIC EQUATIONS WITH HARMONIC COEFFICIENT APPROXIMATIONS Proceedings of ALGORITMY 2005 pp. 222 229 A FAST SOLVER FOR ELLIPTIC EQUATIONS WITH HARMONIC COEFFICIENT APPROXIMATIONS ELENA BRAVERMAN, MOSHE ISRAELI, AND ALEXANDER SHERMAN Abstract. Based on a fast subtractional

More information

arxiv: v2 [physics.comp-ph] 4 Feb 2014

arxiv: v2 [physics.comp-ph] 4 Feb 2014 Fast and accurate solution of the Poisson equation in an immersed setting arxiv:1401.8084v2 [physics.comp-ph] 4 Feb 2014 Alexandre Noll Marques a, Jean-Christophe Nave b, Rodolfo Ruben Rosales c Abstract

More information

TOPOLOGICAL COMPLEXITY OF 2-TORSION LENS SPACES AND ku-(co)homology

TOPOLOGICAL COMPLEXITY OF 2-TORSION LENS SPACES AND ku-(co)homology TOPOLOGICAL COMPLEXITY OF 2-TORSION LENS SPACES AND ku-(co)homology DONALD M. DAVIS Abstract. We use ku-cohomology to determine lower bounds for the topological complexity of mod-2 e lens spaces. In the

More information

Treecodes for Cosmology Thomas Quinn University of Washington N-Body Shop

Treecodes for Cosmology Thomas Quinn University of Washington N-Body Shop Treecodes for Cosmology Thomas Quinn University of Washington N-Body Shop Outline Motivation Multipole Expansions Tree Algorithms Periodic Boundaries Time integration Gravitational Softening SPH Parallel

More information

Algebraic Multigrid as Solvers and as Preconditioner

Algebraic Multigrid as Solvers and as Preconditioner Ò Algebraic Multigrid as Solvers and as Preconditioner Domenico Lahaye domenico.lahaye@cs.kuleuven.ac.be http://www.cs.kuleuven.ac.be/ domenico/ Department of Computer Science Katholieke Universiteit Leuven

More information

Explicit kernel-split panel-based Nyström schemes for planar or axisymmetric Helmholtz problems

Explicit kernel-split panel-based Nyström schemes for planar or axisymmetric Helmholtz problems z Explicit kernel-split panel-based Nyström schemes for planar or axisymmetric Helmholtz problems Johan Helsing Lund University Talk at Integral equation methods: fast algorithms and applications, Banff,

More information

Department of Applied Mathematics and Theoretical Physics. AMA 204 Numerical analysis. Exam Winter 2004

Department of Applied Mathematics and Theoretical Physics. AMA 204 Numerical analysis. Exam Winter 2004 Department of Applied Mathematics and Theoretical Physics AMA 204 Numerical analysis Exam Winter 2004 The best six answers will be credited All questions carry equal marks Answer all parts of each question

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

Numerical Programming I (for CSE)

Numerical Programming I (for CSE) Technische Universität München WT 1/13 Fakultät für Mathematik Prof. Dr. M. Mehl B. Gatzhammer January 1, 13 Numerical Programming I (for CSE) Tutorial 1: Iterative Methods 1) Relaxation Methods a) Let

More information

Quintic beam closed form matrices (revised 2/21, 2/23/12) General elastic beam with an elastic foundation

Quintic beam closed form matrices (revised 2/21, 2/23/12) General elastic beam with an elastic foundation General elastic beam with an elastic foundation Figure 1 shows a beam-column on an elastic foundation. The beam is connected to a continuous series of foundation springs. The other end of the foundation

More information

1. Fast Iterative Solvers of SLE

1. Fast Iterative Solvers of SLE 1. Fast Iterative Solvers of crucial drawback of solvers discussed so far: they become slower if we discretize more accurate! now: look for possible remedies relaxation: explicit application of the multigrid

More information

First-order overdetermined systems. for elliptic problems. John Strain Mathematics Department UC Berkeley July 2012

First-order overdetermined systems. for elliptic problems. John Strain Mathematics Department UC Berkeley July 2012 First-order overdetermined systems for elliptic problems John Strain Mathematics Department UC Berkeley July 2012 1 OVERVIEW Convert elliptic problems to first-order overdetermined form Control error via

More information

Scientific Computing: An Introductory Survey

Scientific Computing: An Introductory Survey Scientific Computing: An Introductory Survey Chapter 12 Prof. Michael T. Heath Department of Computer Science University of Illinois at Urbana-Champaign Copyright c 2002. Reproduction permitted for noncommercial,

More information

Filtering and Edge Detection

Filtering and Edge Detection Filtering and Edge Detection Local Neighborhoods Hard to tell anything from a single pixel Example: you see a reddish pixel. Is this the object s color? Illumination? Noise? The next step in order of complexity

More information

Boundary Value Problems - Solving 3-D Finite-Difference problems Jacob White

Boundary Value Problems - Solving 3-D Finite-Difference problems Jacob White Introduction to Simulation - Lecture 2 Boundary Value Problems - Solving 3-D Finite-Difference problems Jacob White Thanks to Deepak Ramaswamy, Michal Rewienski, and Karen Veroy Outline Reminder about

More information

arxiv: v1 [math.co] 3 Nov 2014

arxiv: v1 [math.co] 3 Nov 2014 SPARSE MATRICES DESCRIBING ITERATIONS OF INTEGER-VALUED FUNCTIONS BERND C. KELLNER arxiv:1411.0590v1 [math.co] 3 Nov 014 Abstract. We consider iterations of integer-valued functions φ, which have no fixed

More information

Coarse-Grained Models!

Coarse-Grained Models! Coarse-Grained Models! Large and complex molecules (e.g. long polymers) can not be simulated on the all-atom level! Requires coarse-graining of the model! Coarse-grained models are usually also particles

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

A High-Order Galerkin Solver for the Poisson Problem on the Surface of the Cubed Sphere

A High-Order Galerkin Solver for the Poisson Problem on the Surface of the Cubed Sphere A High-Order Galerkin Solver for the Poisson Problem on the Surface of the Cubed Sphere Michael Levy University of Colorado at Boulder Department of Applied Mathematics August 10, 2007 Outline 1 Background

More information

Bindel, Spring 2012 Intro to Scientific Computing (CS 3220) Week 12: Monday, Apr 16. f(x) dx,

Bindel, Spring 2012 Intro to Scientific Computing (CS 3220) Week 12: Monday, Apr 16. f(x) dx, Panel integration Week 12: Monday, Apr 16 Suppose we want to compute the integral b a f(x) dx In estimating a derivative, it makes sense to use a locally accurate approximation to the function around the

More information

A Tutorial on Wavelets and their Applications. Martin J. Mohlenkamp

A Tutorial on Wavelets and their Applications. Martin J. Mohlenkamp A Tutorial on Wavelets and their Applications Martin J. Mohlenkamp University of Colorado at Boulder Department of Applied Mathematics mjm@colorado.edu This tutorial is designed for people with little

More information

Computational Astrophysics 1 Particle Mesh methods

Computational Astrophysics 1 Particle Mesh methods Computational Astrophysics 1 Particle Mesh methods Oscar Agertz Outline - The Vlassov-Poisson equation - The Particle-Mesh method in a nut shell - Symplectic Integrators - Mass assignment and force interpolation

More information

Why Proteins Fold? (Parts of this presentation are based on work of Ashok Kolaskar) CS490B: Introduction to Bioinformatics Mar.

Why Proteins Fold? (Parts of this presentation are based on work of Ashok Kolaskar) CS490B: Introduction to Bioinformatics Mar. Why Proteins Fold? (Parts of this presentation are based on work of Ashok Kolaskar) CS490B: Introduction to Bioinformatics Mar. 25, 2002 Molecular Dynamics: Introduction At physiological conditions, the

More information

UNCONVENTIONAL FINITE ELEMENT MODELS FOR NONLINEAR ANALYSIS OF BEAMS AND PLATES

UNCONVENTIONAL FINITE ELEMENT MODELS FOR NONLINEAR ANALYSIS OF BEAMS AND PLATES UNCONVENTIONAL FINITE ELEMENT MODELS FOR NONLINEAR ANALYSIS OF BEAMS AND PLATES A Thesis by WOORAM KIM Submitted to the Office of Graduate Studies of Texas A&M University in partial fulfillment of the

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

Max-Planck-Institut fur Mathematik in den Naturwissenschaften Leipzig H 2 -matrix approximation of integral operators by interpolation by Wolfgang Hackbusch and Steen Borm Preprint no.: 04 200 H 2 -Matrix

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

Scientific Computing I

Scientific Computing I Scientific Computing I Module 8: An Introduction to Finite Element Methods Tobias Neckel Winter 2013/2014 Module 8: An Introduction to Finite Element Methods, Winter 2013/2014 1 Part I: Introduction to

More information

A SHORT NOTE COMPARING MULTIGRID AND DOMAIN DECOMPOSITION FOR PROTEIN MODELING EQUATIONS

A SHORT NOTE COMPARING MULTIGRID AND DOMAIN DECOMPOSITION FOR PROTEIN MODELING EQUATIONS A SHORT NOTE COMPARING MULTIGRID AND DOMAIN DECOMPOSITION FOR PROTEIN MODELING EQUATIONS MICHAEL HOLST AND FAISAL SAIED Abstract. We consider multigrid and domain decomposition methods for the numerical

More information

Applied Numerical Analysis Quiz #2

Applied Numerical Analysis Quiz #2 Applied Numerical Analysis Quiz #2 Modules 3 and 4 Name: Student number: DO NOT OPEN UNTIL ASKED Instructions: Make sure you have a machine-readable answer form. Write your name and student number in the

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

Problem descriptions: Non-uniform fast Fourier transform

Problem descriptions: Non-uniform fast Fourier transform Problem descriptions: Non-uniform fast Fourier transform Lukas Exl 1 1 University of Vienna, Institut für Mathematik, Oskar-Morgenstern-Platz 1, A-1090 Wien, Austria December 11, 2015 Contents 0.1 Software

More information

Preface to the Second Edition. Preface to the First Edition

Preface to the Second Edition. Preface to the First Edition n page v Preface to the Second Edition Preface to the First Edition xiii xvii 1 Background in Linear Algebra 1 1.1 Matrices................................. 1 1.2 Square Matrices and Eigenvalues....................

More information

2 Two-Point Boundary Value Problems

2 Two-Point Boundary Value Problems 2 Two-Point Boundary Value Problems Another fundamental equation, in addition to the heat eq. and the wave eq., is Poisson s equation: n j=1 2 u x 2 j The unknown is the function u = u(x 1, x 2,..., x

More information

Lehrstuhl Informatik V. Lehrstuhl Informatik V. 1. solve weak form of PDE to reduce regularity properties. Lehrstuhl Informatik V

Lehrstuhl Informatik V. Lehrstuhl Informatik V. 1. solve weak form of PDE to reduce regularity properties. Lehrstuhl Informatik V Part I: Introduction to Finite Element Methods Scientific Computing I Module 8: An Introduction to Finite Element Methods Tobias Necel Winter 4/5 The Model Problem FEM Main Ingredients Wea Forms and Wea

More information

Scientific Computing: An Introductory Survey

Scientific Computing: An Introductory Survey Scientific Computing: An Introductory Survey Chapter 11 Partial Differential Equations Prof. Michael T. Heath Department of Computer Science University of Illinois at Urbana-Champaign Copyright c 2002.

More information

CME342 Parallel Methods in Numerical Analysis. Matrix Computation: Iterative Methods II. Sparse Matrix-vector Multiplication.

CME342 Parallel Methods in Numerical Analysis. Matrix Computation: Iterative Methods II. Sparse Matrix-vector Multiplication. CME342 Parallel Methods in Numerical Analysis Matrix Computation: Iterative Methods II Outline: CG & its parallelization. Sparse Matrix-vector Multiplication. 1 Basic iterative methods: Ax = b r = b Ax

More information

Discrete Orthogonal Harmonic Transforms

Discrete Orthogonal Harmonic Transforms Discrete Orthogonal Harmonic Transforms Speaker: Chun-Lin Liu, Advisor: Soo-Chang Pei Ph. D Image Processing Laboratory, EEII 530, Graduate Institute of Communication Engineering, National Taiwan University.

More information

Algorithms for Scientific Computing

Algorithms for Scientific Computing Algorithms for Scientific Computing Finite Element Methods Michael Bader Technical University of Munich Summer 2016 Part I Looking Back: Discrete Models for Heat Transfer and the Poisson Equation Modelling

More information

Multigrid Methods and their application in CFD

Multigrid Methods and their application in CFD Multigrid Methods and their application in CFD Michael Wurst TU München 16.06.2009 1 Multigrid Methods Definition Multigrid (MG) methods in numerical analysis are a group of algorithms for solving differential

More information

Constrained Minimization and Multigrid

Constrained Minimization and Multigrid Constrained Minimization and Multigrid C. Gräser (FU Berlin), R. Kornhuber (FU Berlin), and O. Sander (FU Berlin) Workshop on PDE Constrained Optimization Hamburg, March 27-29, 2008 Matheon Outline Successive

More information

Department of Applied Mathematics Preliminary Examination in Numerical Analysis August, 2013

Department of Applied Mathematics Preliminary Examination in Numerical Analysis August, 2013 Department of Applied Mathematics Preliminary Examination in Numerical Analysis August, 013 August 8, 013 Solutions: 1 Root Finding (a) Let the root be x = α We subtract α from both sides of x n+1 = x

More information