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

Size: px
Start display at page:

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

Transcription

1 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, computer vision, statistics, etc. that can be solved with fast multipole methods. Historical review of the fast multipole method. Review of Complexit Homework. Course Mechanics Background Needed Linear Algebra Matrices, Vectors, Linear Sstems, LU Decomposition, Eigenvalue problem, SVD Numerical Analsis (Interpolation, Approximation, Finite Differences, Talor Series, etc.) Programming Matlab, C/C++ and/or FORTRAN Participation essential! Course Requirements Ideall ou have a problem in mind would like to explore how FMM could be applied At the end of the course ou will have a familiarit with Application of FMM to different problems Data structures for FMM, and analsis related to it. Course focus is on appling the methods to achieve solution. Theor as needed to proceed Homework Will tr to have it ever week Will not be excessive Essential for learning --- must do as opposed to just read. Homework handed out last class of a week. Due last class of next week Thanksgiving week no homework (ou can turn in the previous homework after thanksgiving) Projects & Exams There will be a final project that will require ou to implement an FMM algorithm in a field of our choice, account for 0% of the grade. Project to be chosen around October 14. Implementation (reimplementation) of an FMM algorithm (hints and help will be given) Exams intermediate exam worth 10%, week of October 14 final exam worth 0%. Finals Week 1

2 Class web & Mailing List 78r Homework will be posted on web No late homework (except b timel prior arrangement) (no web or submissions) Solutions will be posted after homework collected Links to papers etc. Introductions addresses What are our interests? What do ou want us to cover? An outline is posted at What is the Fast Multipole Method? An algorithm for achieving fast products of particular dense matrices with vectors Similar to the Fast Fourier Transform Matrix entries are uniforml sampled complex exponentials For FMM, matrix entries are Derived from particular functions Functions satisf known translation theorems Name is a bit unfortunate What the heck is a multipole? We will return to this Vectors and Matrices d dimensional column vector x and its transpose n d dimensional matrix M and its transpose M t Matrix vector product Fast Fourier Transform s 1 = m 11 x 1 + m 1 x + + m 1d x d s = m 1 x 1 + m x + + m d x d s n = m n1 x 1 + m n x + + m nd x d Matrix vector product is identical to a sum s i = j=1d m ij x j So algorithm for fast matrix vector products is also a fast summation algorithm d products and sums per line N lines Total Nd products and Nd sums to calculate N entries If entries of matrix are m kn = e π i k n where k and n are integers Then complexit of matrix vector product goes from O(N ) to O(N log N) Allowed several industries to develop A crucial invention of the nd half of the 0 th centur (see numerical recipes

3 Fast Multipole Methods (FMM) Introduced b Rokhlin & Greengard in 1987 Called one of the 10 most significant advances in computing of the 0 th centur Speeds up matrix-vector products (sums) of a particular tpe Above sum requires O(MN) operations. For a given precision ε the FMM achieves the evaluation in O(M+N) operations. Can accelerate matrix vector products Convert O(N ) to O(N log N) However, can also accelerate linear sstem solution Convert O(N 3 ) to O(kN log N) Linear Sstem Solution Solution of most problems in scientific computing reduces to solution of a linear sstem A x = b For dense A, direct solution requires O(N 3 ) operations For large N (e.g ) this is prohibitive Iterative methods can achieve solutions in k steps Each step tpicall involves matrix vector multiplications and thus solution time is O( k * cost of matrix-vector multiplication) For general dense matrices this cost is O(kN ) With FMM this cost becomes O(kN) or O(kN log N) If k is independent of N reduction is significant Memor complexit Sometimes we are not able to fit a problem in available memor Don t care how long solution takes, just if we can solve it To store a N N matrix we need N locations 1 GB RAM = =1,073,741,84 btes => largest N is 3,768 Out of core algorithms cop partial results to disk, and keep onl necessar part of the matrix in memor FMM allows reduction of memor complexit as well Elements of the matrix required for the product can be generated as needed A ver simple algorithm Not FMM, but has some ke ideas Consider S(x i )= j=1n α j (x i j ) i=1,,m Naïve wa to evaluate the sum will require MN operations Instead can write the sum as S(x i )=( j=1n α j )x i + ( j=1n α j j ) -x i ( j=1n α j j ) Can evaluate each bracketed sum over j and evaluate an expression of the tpe S(x i )=β x i + γ -x i δ Requires O(M+N) operations Ke idea use of analtical manipulation of series to achieve faster summation Approximate evaluation FMM introduces another ke idea or philosoph In scientific computing we almost never seek exact answers At best, exact means to machine precision So instead of solving the problem we can solve a nearb problem that gives almost the same answer If this nearb problem is much easier to solve, and we can bound the error analticall we are done. In the case of the FMM Manipulate series to achieve approximate evaluation Use analtical expression to bound the error FFT is exact FMM can be arbitraril accurate 3

4 Some FMM algorithms Molecular and stellar dnamics Computation of force fields and dnamics Interpolation with Radial Basis Functions Solution of acoustical scattering problems Helmholtz Equation Electromagnetic Wave scattering Maxwell s equations Fluid Mechanics: Potential flow, vortex flow Laplace/Poisson equations Fast nonuniform Fourier transform Applications I Interpolation Given a scattered data set with points and values {x i, f i } Build a representation of the function f(x) That satisfies f(x i )=f i Can be evaluated at new points One approach use radial-basis functions f(x)= in α i R(x-x i ) + p(x) f j = in α i R(x j -x i ) + p(x j ) Two problems Determining α i Knowing α i determine the product at man new points x j Both can be solved via FMM (Cherrie et al, 001) RBF interpolation Applications Cherrie et al 001 Applications Sound scattering off rooms and bodies Need to know the scattering properties of the head and bod (our interest) P P P+ k P = 0 + i σ P = g lim r ikp = 0 r n r p ( ) Gxk (, ; ) Cxpx ( ) ( ) = Gxk (, ; ) p ( ) dγ n n (, ) ik x e G x = Γ 4π x Applications: EM wave scattering Similar to acoustic scattering Send waves and measure scattered waves Attempt to figure out object from the measured waves Need to know Radar cross-section Man applications Light scattering Radar Antenna design Darve 001. Molecular and stellar dnamics Man particles distributed in space Particles exert a force on each other Simplest case force obes an inversesquare law (gravit, coulombic interaction) dxi = Fi, dt N ( xi x j ) Fi = qi q j 3 j = 1 xi x j j i 4

5 Fluid mechanics Incompressible Navier Stokes Equation u = 0 u ρ + t + ( u ) u p = µ u u = φ + A ω = A Laplace equation for potential and Poisson equation for vorticit Solved via particle methods 5

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

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

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

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

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

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

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

Partial Differential Equations. Examples of PDEs

Partial Differential Equations. Examples of PDEs Partial Differential Equations Almost all the elementary and numerous advanced parts of theoretical physics are formulated in terms of differential equations (DE). Newton s Laws Maxwell equations Schrodinger

More information

Vibration of Plate on Foundation with Four Edges Free by Finite Cosine Integral Transform Method

Vibration of Plate on Foundation with Four Edges Free by Finite Cosine Integral Transform Method 854 Vibration of Plate on Foundation with Four Edges Free b Finite Cosine Integral Transform Method Abstract The analtical solutions for the natural frequencies and mode shapes of the rectangular plate

More information

Conservation of Linear Momentum for a Differential Control Volume

Conservation of Linear Momentum for a Differential Control Volume Conservation of Linear Momentum for a Differential Control Volume When we applied the rate-form of the conservation of mass equation to a differential control volume (open sstem in Cartesian coordinates,

More information

Joel A. Shapiro January 20, 2011

Joel A. Shapiro January 20, 2011 Joel A. shapiro@physics.rutgers.edu January 20, 2011 Course Information Instructor: Joel Serin 325 5-5500 X 3886, shapiro@physics Book: Jackson: Classical Electrodynamics (3rd Ed.) Web home page: www.physics.rutgers.edu/grad/504

More information

Physics Gravitational force. 2. Strong or color force. 3. Electroweak force

Physics Gravitational force. 2. Strong or color force. 3. Electroweak force Phsics 360 Notes on Griffths - pluses and minuses No tetbook is perfect, and Griffithsisnoeception. Themajorplusisthat it is prett readable. For minuses, see below. Much of what G sas about the del operator

More information

Mechanics Physics 151

Mechanics Physics 151 Mechanics Phsics 151 Lecture 8 Rigid Bod Motion (Chapter 4) What We Did Last Time! Discussed scattering problem! Foundation for all experimental phsics! Defined and calculated cross sections! Differential

More information

Time-Frequency Analysis: Fourier Transforms and Wavelets

Time-Frequency Analysis: Fourier Transforms and Wavelets Chapter 4 Time-Frequenc Analsis: Fourier Transforms and Wavelets 4. Basics of Fourier Series 4.. Introduction Joseph Fourier (768-83) who gave his name to Fourier series, was not the first to use Fourier

More information

Conservation of Linear Momentum

Conservation of Linear Momentum Conservation of Linear Momentum Once we have determined the continuit equation in di erential form we proceed to derive the momentum equation in di erential form. We start b writing the integral form of

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

Lecture 11: CMSC 878R/AMSC698R. Iterative Methods An introduction. Outline. Inverse, LU decomposition, Cholesky, SVD, etc.

Lecture 11: CMSC 878R/AMSC698R. Iterative Methods An introduction. Outline. Inverse, LU decomposition, Cholesky, SVD, etc. Lecture 11: CMSC 878R/AMSC698R Iterative Methods An introduction Outline Direct Solution of Linear Systems Inverse, LU decomposition, Cholesky, SVD, etc. Iterative methods for linear systems Why? Matrix

More information

Spotlight on the Extended Method of Frobenius

Spotlight on the Extended Method of Frobenius 113 Spotlight on the Extended Method of Frobenius See Sections 11.1 and 11.2 for the model of an aging spring. Reference: Section 11.4 and SPOTLIGHT ON BESSEL FUNCTIONS. Bessel functions of the first kind

More information

Second-Order Linear Differential Equations C 2

Second-Order Linear Differential Equations C 2 C8 APPENDIX C Additional Topics in Differential Equations APPENDIX C. Second-Order Homogeneous Linear Equations Second-Order Linear Differential Equations Higher-Order Linear Differential Equations Application

More information

MATH 417 Homework 6 Instructor: D. Cabrera Due July Find the radius of convergence for each power series below. c n+1 c n (n + 1) 2 (z 3) n+1

MATH 417 Homework 6 Instructor: D. Cabrera Due July Find the radius of convergence for each power series below. c n+1 c n (n + 1) 2 (z 3) n+1 MATH 47 Homework 6 Instructor: D. Cabrera Due Jul 2. Find the radius of convergence for each power series below. (a) (b) n 2 (z 3) n n=2 e n (z + i) n n=4 Solution: (a) Using the Ratio Test we have L =

More information

Simulation of Acoustic and Vibro-Acoustic Problems in LS-DYNA using Boundary Element Method

Simulation of Acoustic and Vibro-Acoustic Problems in LS-DYNA using Boundary Element Method 10 th International LS-DYNA Users Conference Simulation Technolog (2) Simulation of Acoustic and Vibro-Acoustic Problems in LS-DYNA using Boundar Element Method Yun Huang Livermore Software Technolog Corporation

More information

Eigenvectors and Eigenvalues 1

Eigenvectors and Eigenvalues 1 Ma 2015 page 1 Eigenvectors and Eigenvalues 1 In this handout, we will eplore eigenvectors and eigenvalues. We will begin with an eploration, then provide some direct eplanation and worked eamples, and

More information

Methods for Advanced Mathematics (C3) Coursework Numerical Methods

Methods for Advanced Mathematics (C3) Coursework Numerical Methods Woodhouse College 0 Page Introduction... 3 Terminolog... 3 Activit... 4 Wh use numerical methods?... Change of sign... Activit... 6 Interval Bisection... 7 Decimal Search... 8 Coursework Requirements on

More information

Chapter 18 Quadratic Function 2

Chapter 18 Quadratic Function 2 Chapter 18 Quadratic Function Completed Square Form 1 Consider this special set of numbers - the square numbers or the set of perfect squares. 4 = = 9 = 3 = 16 = 4 = 5 = 5 = Numbers like 5, 11, 15 are

More information

Cubic and quartic functions

Cubic and quartic functions 3 Cubic and quartic functions 3A Epanding 3B Long division of polnomials 3C Polnomial values 3D The remainder and factor theorems 3E Factorising polnomials 3F Sum and difference of two cubes 3G Solving

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

Lab 5 Forces Part 1. Physics 211 Lab. You will be using Newton s 2 nd Law to help you examine the nature of these forces.

Lab 5 Forces Part 1. Physics 211 Lab. You will be using Newton s 2 nd Law to help you examine the nature of these forces. b Lab 5 Forces Part 1 Phsics 211 Lab Introduction This is the first week of a two part lab that deals with forces and related concepts. A force is a push or a pull on an object that can be caused b a variet

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

MAE 323: Lecture 1. Review

MAE 323: Lecture 1. Review This review is divided into two parts. The first part is a mini-review of statics and solid mechanics. The second part is a review of matrix/vector fundamentals. The first part is given as an refresher

More information

Equilibrium at a Point

Equilibrium at a Point Equilibrium at a Point Never slap a man who's chewing tobacco. - Will Rogers Objec3ves Understand the concept of sta3c equilibrium Understand the use of the free- bod diagram to isolate a sstem for analsis

More information

FEM/FMBEM coupling for acoustic structure interaction and acoustic design sensitivity analysis with sound-absorbing materials

FEM/FMBEM coupling for acoustic structure interaction and acoustic design sensitivity analysis with sound-absorbing materials Boundary Elements and Other Mesh Reduction Methods XXXVIII 113 FEM/FMBEM coupling for acoustic structure interaction and acoustic design sensitivity analysis with sound-absorbing materials Y. M. Xu, H.

More information

Improved Fast Gauss Transform

Improved Fast Gauss Transform Improved Fast Gauss Transform Changjiang Yang Department of Computer Science University of Maryland Fast Gauss Transform (FGT) Originally proposed by Greengard and Strain (1991) to efficiently evaluate

More information

Advanced Introduction to Machine Learning: Homework 2 MLE, MAP and Naive Bayes

Advanced Introduction to Machine Learning: Homework 2 MLE, MAP and Naive Bayes 10-715 Advanced Introduction to Machine Learning: Homework 2 MLE, MAP and Naive Baes Released: Wednesda, September 12, 2018 Due: 11:59 p.m. Wednesda, September 19, 2018 Instructions Late homework polic:

More information

PRINCIPLES OF MATHEMATICS 11 Chapter 2 Quadratic Functions Lesson 1 Graphs of Quadratic Functions (2.1) where a, b, and c are constants and a 0

PRINCIPLES OF MATHEMATICS 11 Chapter 2 Quadratic Functions Lesson 1 Graphs of Quadratic Functions (2.1) where a, b, and c are constants and a 0 PRINCIPLES OF MATHEMATICS 11 Chapter Quadratic Functions Lesson 1 Graphs of Quadratic Functions (.1) Date A. QUADRATIC FUNCTIONS A quadratic function is an equation that can be written in the following

More information

Physics 202 Laboratory 5. Linear Algebra 1. Laboratory 5. Physics 202 Laboratory

Physics 202 Laboratory 5. Linear Algebra 1. Laboratory 5. Physics 202 Laboratory Physics 202 Laboratory 5 Linear Algebra Laboratory 5 Physics 202 Laboratory We close our whirlwind tour of numerical methods by advertising some elements of (numerical) linear algebra. There are three

More information

Breaking Computational Barriers: Multi-GPU High-Order RBF Kernel Problems with Millions of Points

Breaking Computational Barriers: Multi-GPU High-Order RBF Kernel Problems with Millions of Points Breaking Computational Barriers: Multi-GPU High-Order RBF Kernel Problems with Millions of Points Michael Griebel Christian Rieger Peter Zaspel Institute for Numerical Simulation Rheinische Friedrich-Wilhelms-Universität

More information

Some practical remarks (recap) Statistical Natural Language Processing. Today s lecture. Linear algebra. Why study linear algebra?

Some practical remarks (recap) Statistical Natural Language Processing. Today s lecture. Linear algebra. Why study linear algebra? Some practical remarks (recap) Statistical Natural Language Processing Mathematical background: a refresher Çağrı Çöltekin Universit of Tübingen Seminar für Sprachwissenschaft Summer Semester 017 Course

More information

SOLVING SOME PHYSICAL PROBLEMS USING THE METHODS OF NUMERICAL MATHEMATICS WITH THE HELP OF SYSTEM MATHEMATICA

SOLVING SOME PHYSICAL PROBLEMS USING THE METHODS OF NUMERICAL MATHEMATICS WITH THE HELP OF SYSTEM MATHEMATICA SOLVING SOME PHYSICAL PROBLEMS USING THE METHODS OF NUMERICAL MATHEMATICS WITH THE HELP OF SYSTEM MATHEMATICA Pavel Trojovský Jaroslav Seibert Antonín Slabý ABSTRACT Ever future teacher of mathematics

More information

Physics 106a/196a Problem Set 7 Due Dec 2, 2005

Physics 106a/196a Problem Set 7 Due Dec 2, 2005 Physics 06a/96a Problem Set 7 Due Dec, 005 Version 3, Nov 7, 005 In this set we finish up the SHO and study coupled oscillations/normal modes and waves. Problems,, and 3 are for 06a students only, 4, 5,

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

This ensures that we walk downhill. For fixed λ not even this may be the case.

This ensures that we walk downhill. For fixed λ not even this may be the case. Gradient Descent Objective Function Some differentiable function f : R n R. Gradient Descent Start with some x 0, i = 0 and learning rate λ repeat x i+1 = x i λ f(x i ) until f(x i+1 ) ɛ Line Search Variant

More information

Linear algebra in turn is built on two basic elements, MATRICES and VECTORS.

Linear algebra in turn is built on two basic elements, MATRICES and VECTORS. M-Lecture():.-. Linear algebra provides concepts that are crucial to man areas of information technolog and computing, including: Graphics Image processing Crptograph Machine learning Computer vision Optimiation

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

Periodic Structures in FDTD

Periodic Structures in FDTD EE 5303 Electromagnetic Analsis Using Finite Difference Time Domain Lecture #19 Periodic Structures in FDTD Lecture 19 These notes ma contain coprighted material obtained under fair use rules. Distribution

More information

Week 4. Outline Review electric Forces Review electric Potential

Week 4. Outline Review electric Forces Review electric Potential Week 4 Outline Review electric Forces Review electric Potential Electric Charge - A property of matter Matter is made up of two kinds of electric charges (positive and negative). Like charges repel, unlike

More information

Linear Transformations

Linear Transformations inear Transformations 6 The main objects of stud in an course in linear algebra are linear functions: Definition A function : V! W is linear if V and W are vector spaces and (ru + sv) r(u)+s(v) for all

More information

Physics of Tsunamis. This is an article from my home page: Ole Witt-Hansen 2011 (2016)

Physics of Tsunamis. This is an article from my home page:   Ole Witt-Hansen 2011 (2016) Phsics of Tsunamis This is an article from m home page: www.olewitthansen.dk Ole Witt-Hansen 11 (16) Contents 1. Constructing a differential equation for the Tsunami wave...1. The velocit of propagation

More information

Additional Topics in Differential Equations

Additional Topics in Differential Equations 6 Additional Topics in Differential Equations 6. Eact First-Order Equations 6. Second-Order Homogeneous Linear Equations 6.3 Second-Order Nonhomogeneous Linear Equations 6.4 Series Solutions of Differential

More information

Finding Limits Graphically and Numerically. An Introduction to Limits

Finding Limits Graphically and Numerically. An Introduction to Limits 8 CHAPTER Limits and Their Properties Section Finding Limits Graphicall and Numericall Estimate a it using a numerical or graphical approach Learn different was that a it can fail to eist Stud and use

More information

Experimental Uncertainty Review. Abstract. References. Measurement Uncertainties and Uncertainty Propagation

Experimental Uncertainty Review. Abstract. References. Measurement Uncertainties and Uncertainty Propagation Experimental Uncertaint Review Abstract This is intended as a brief summar of the basic elements of uncertaint analsis, and a hand reference for laborator use. It provides some elementar "rules-of-thumb"

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

Green s Functions, Boundary Integral Equations and Rotational Symmetry

Green s Functions, Boundary Integral Equations and Rotational Symmetry Green s Functions, Boundary Integral Equations and Rotational Symmetry...or, How to Construct a Fast Solver for Stokes Equation Saibal De Advisor: Shravan Veerapaneni University of Michigan, Ann Arbor

More information

Linear Algebra and Eigenproblems

Linear Algebra and Eigenproblems Appendix A A Linear Algebra and Eigenproblems A working knowledge of linear algebra is key to understanding many of the issues raised in this work. In particular, many of the discussions of the details

More information

CONTINUOUS SPATIAL DATA ANALYSIS

CONTINUOUS SPATIAL DATA ANALYSIS CONTINUOUS SPATIAL DATA ANALSIS 1. Overview of Spatial Stochastic Processes The ke difference between continuous spatial data and point patterns is that there is now assumed to be a meaningful value, s

More information

Chapter 5: Systems of Equations

Chapter 5: Systems of Equations Chapter : Sstems of Equations Section.: Sstems in Two Variables... 0 Section. Eercises... 9 Section.: Sstems in Three Variables... Section. Eercises... Section.: Linear Inequalities... Section.: Eercises.

More information

AE/ME 339. K. M. Isaac Professor of Aerospace Engineering. December 21, 2001 topic13_grid_generation 1

AE/ME 339. K. M. Isaac Professor of Aerospace Engineering. December 21, 2001 topic13_grid_generation 1 AE/ME 339 Professor of Aerospace Engineering December 21, 2001 topic13_grid_generation 1 The basic idea behind grid generation is the creation of the transformation laws between the phsical space and the

More information

1 Lecture 8: Interpolating polynomials.

1 Lecture 8: Interpolating polynomials. 1 Lecture 8: Interpolating polynomials. 1.1 Horner s method Before turning to the main idea of this part of the course, we consider how to evaluate a polynomial. Recall that a polynomial is an expression

More information

MMJ1153 COMPUTATIONAL METHOD IN SOLID MECHANICS PRELIMINARIES TO FEM

MMJ1153 COMPUTATIONAL METHOD IN SOLID MECHANICS PRELIMINARIES TO FEM B Course Content: A INTRODUCTION AND OVERVIEW Numerical method and Computer-Aided Engineering; Phsical problems; Mathematical models; Finite element method;. B Elements and nodes, natural coordinates,

More information

arxiv: v1 [cs.lg] 26 Jul 2017

arxiv: v1 [cs.lg] 26 Jul 2017 Updating Singular Value Decomposition for Rank One Matrix Perturbation Ratnik Gandhi, Amoli Rajgor School of Engineering & Applied Science, Ahmedabad University, Ahmedabad-380009, India arxiv:70708369v

More information

Trusses - Method of Sections

Trusses - Method of Sections Trusses - Method of Sections ME 202 Methods of Truss Analsis Method of joints (previous notes) Method of sections (these notes) 2 MOS - Concepts Separate the structure into two parts (sections) b cutting

More information

SOME PROPERTIES OF CONJUGATE HARMONIC FUNCTIONS IN A HALF-SPACE

SOME PROPERTIES OF CONJUGATE HARMONIC FUNCTIONS IN A HALF-SPACE SOME PROPERTIES OF CONJUGATE HARMONIC FUNCTIONS IN A HALF-SPACE ANATOLY RYABOGIN AND DMITRY RYABOGIN Abstract. We prove a multi-dimensional analog of the Theorem of Hard and Littlewood about the logarithmic

More information

1 Exercise: Linear, incompressible Stokes flow with FE

1 Exercise: Linear, incompressible Stokes flow with FE Figure 1: Pressure and velocity solution for a sinking, fluid slab impinging on viscosity contrast problem. 1 Exercise: Linear, incompressible Stokes flow with FE Reading Hughes (2000), sec. 4.2-4.4 Dabrowski

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

Applications of Randomized Methods for Decomposing and Simulating from Large Covariance Matrices

Applications of Randomized Methods for Decomposing and Simulating from Large Covariance Matrices Applications of Randomized Methods for Decomposing and Simulating from Large Covariance Matrices Vahid Dehdari and Clayton V. Deutsch Geostatistical modeling involves many variables and many locations.

More information

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

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

More information

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

Approximation of Continuous Functions

Approximation of Continuous Functions Approximation of Continuous Functions Francis J. Narcowich October 2014 1 Modulus of Continuit Recall that ever function continuous on a closed interval < a x b < is uniforml continuous: For ever ɛ > 0,

More information

QUADRATIC FUNCTION REVIEW

QUADRATIC FUNCTION REVIEW Name: Date: QUADRATIC FUNCTION REVIEW Linear and eponential functions are used throughout mathematics and science due to their simplicit and applicabilit. Quadratic functions comprise another ver important

More information

Introduction to Differential Equations. National Chiao Tung University Chun-Jen Tsai 9/14/2011

Introduction to Differential Equations. National Chiao Tung University Chun-Jen Tsai 9/14/2011 Introduction to Differential Equations National Chiao Tung Universit Chun-Jen Tsai 9/14/011 Differential Equations Definition: An equation containing the derivatives of one or more dependent variables,

More information

Math 671: Tensor Train decomposition methods

Math 671: Tensor Train decomposition methods Math 671: Eduardo Corona 1 1 University of Michigan at Ann Arbor December 8, 2016 Table of Contents 1 Preliminaries and goal 2 Unfolding matrices for tensorized arrays The Tensor Train decomposition 3

More information

Partial Differential Equations II

Partial Differential Equations II Partial Differential Equations II CS 205A: Mathematical Methods for Robotics, Vision, and Graphics Justin Solomon CS 205A: Mathematical Methods Partial Differential Equations II 1 / 28 Almost Done! Homework

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

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

1 GSW Gaussian Elimination

1 GSW Gaussian Elimination Gaussian elimination is probabl the simplest technique for solving a set of simultaneous linear equations, such as: = A x + A x + A x +... + A x,,,, n n = A x + A x + A x +... + A x,,,, n n... m = Am,x

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

MATH 315 Linear Algebra Homework #1 Assigned: August 20, 2018

MATH 315 Linear Algebra Homework #1 Assigned: August 20, 2018 Homework #1 Assigned: August 20, 2018 Review the following subjects involving systems of equations and matrices from Calculus II. Linear systems of equations Converting systems to matrix form Pivot entry

More information

Laboratory and Rotating frames

Laboratory and Rotating frames Laborator and Rotating frames The coordinate sstem that we used for the previous eample (laborator frame) is reall pathetic. The whole sstem is spinning at ω o, which makes an kind of analsis impossible.

More information

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

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

More information

8.7 Systems of Non-Linear Equations and Inequalities

8.7 Systems of Non-Linear Equations and Inequalities 8.7 Sstems of Non-Linear Equations and Inequalities 67 8.7 Sstems of Non-Linear Equations and Inequalities In this section, we stud sstems of non-linear equations and inequalities. Unlike the sstems of

More information

CS168: The Modern Algorithmic Toolbox Lecture #11: The Fourier Transform and Convolution

CS168: The Modern Algorithmic Toolbox Lecture #11: The Fourier Transform and Convolution CS168: The Modern Algorithmic Toolbox Lecture #11: The Fourier Transform and Convolution Tim Roughgarden & Gregory Valiant May 8, 2015 1 Intro Thus far, we have seen a number of different approaches to

More information

LESSON #48 - INTEGER EXPONENTS COMMON CORE ALGEBRA II

LESSON #48 - INTEGER EXPONENTS COMMON CORE ALGEBRA II LESSON #8 - INTEGER EXPONENTS COMMON CORE ALGEBRA II We just finished our review of linear functions. Linear functions are those that grow b equal differences for equal intervals. In this unit we will

More information

Wave Phenomena Physics 15c

Wave Phenomena Physics 15c Wave Phenomena Phsics 15c Lecture 13 Multi-Dimensional Waves (H&L Chapter 7) Term Paper Topics! Have ou found a topic for the paper?! 2/3 of the class have, or have scheduled a meeting with me! If ou haven

More information

Lab 5 Forces Part 1. Physics 225 Lab. You will be using Newton s 2 nd Law to help you examine the nature of these forces.

Lab 5 Forces Part 1. Physics 225 Lab. You will be using Newton s 2 nd Law to help you examine the nature of these forces. b Lab 5 orces Part 1 Introduction his is the first week of a two part lab that deals with forces and related concepts. A force is a push or a pull on an object that can be caused b a variet of reasons.

More information

ABSTRACT MATRICES WITH APPLICATIONS TO THE FAST MULTIPOLE METHOD. Zhihui Tang, Doctor of Philosophy, 2004

ABSTRACT MATRICES WITH APPLICATIONS TO THE FAST MULTIPOLE METHOD. Zhihui Tang, Doctor of Philosophy, 2004 ABSTRACT Title of Dissertation: FAST TRANSFORMS BASED ON STRUCTURED MATRICES WITH APPLICATIONS TO THE FAST MULTIPOLE METHOD Zhihui Tang, Doctor of Philosophy, 2004 Dissertation directed by: Professor Ramani

More information

ABSTRACT. Title of thesis: IMPROVING RADIAL BASIS FUNCTION INTER- POLATION VIA RANDOM SVD PRECONDITION- ERS AND FAST MULTIPOLE METHODS

ABSTRACT. Title of thesis: IMPROVING RADIAL BASIS FUNCTION INTER- POLATION VIA RANDOM SVD PRECONDITION- ERS AND FAST MULTIPOLE METHODS ABSTRACT Title of thesis: IMPROVING RADIAL BASIS FUNCTION INTER- POLATION VIA RANDOM SVD PRECONDITION- ERS AND FAST MULTIPOLE METHODS Kerry Cheng, Master of Science, 2013 Thesis directed by: Professor

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

MA 510 ASSIGNMENT SHEET Spring 2009 Text: Vector Calculus, J. Marsden and A. Tromba, fifth edition

MA 510 ASSIGNMENT SHEET Spring 2009 Text: Vector Calculus, J. Marsden and A. Tromba, fifth edition MA 510 ASSIGNMENT SHEET Spring 2009 Text: Vector Calculus, J. Marsden and A. Tromba, fifth edition This sheet will be updated as the semester proceeds, and I expect to give several quizzes/exams. the calculus

More information

Sample Solutions for Assignment 3.

Sample Solutions for Assignment 3. AMath 383, Autumn Sample Solutions for Assignment 3. Reading: Chs. 4-5.. Eercise 7 of Chapter 3. If $X is invested toda at 3% interest compounded continuousl, then in ears it will be worth Xe (.3 ) = Xe.6.

More information

Exponents are a short-hand notation for writing very large or very. small numbers. The exponent gives the number of times that a number

Exponents are a short-hand notation for writing very large or very. small numbers. The exponent gives the number of times that a number UNIT 3 EXPONENTS Math 11 Unit 3 Introduction p. 1 of 1 A. Algebraic Skills Unit 3 Exponents Introduction Exponents are a short-hand notation for writing ver large or ver small numbers. The exponent gives

More information

Week 3 September 5-7.

Week 3 September 5-7. MA322 Weekl topics and quiz preparations Week 3 September 5-7. Topics These are alread partl covered in lectures. We collect the details for convenience.. Solutions of homogeneous equations AX =. 2. Using

More information

Review for Exam #3 MATH 3200

Review for Exam #3 MATH 3200 Review for Exam #3 MATH 3 Lodwick/Kawai You will have hrs. to complete Exam #3. There will be one full problem from Laplace Transform with the unit step function. There will be linear algebra, but hopefull,

More information

Wave Phenomena Physics 15c

Wave Phenomena Physics 15c Wave Phenomena Phsics 15c Lecture 13 Multi-Dimensional Waves (H&L Chapter 7) Term Paper Topics! Have ou found a topic for the paper?! 2/3 of the class have, or have scheduled a meeting with me! If ou haven

More information

FACULTY OF MATHEMATICAL STUDIES MATHEMATICS FOR PART I ENGINEERING. Lectures AB = BA = I,

FACULTY OF MATHEMATICAL STUDIES MATHEMATICS FOR PART I ENGINEERING. Lectures AB = BA = I, FACULTY OF MATHEMATICAL STUDIES MATHEMATICS FOR PART I ENGINEERING Lectures MODULE 7 MATRICES II Inverse of a matri Sstems of linear equations Solution of sets of linear equations elimination methods 4

More information

ELECTROMAGNETIC THEORY

ELECTROMAGNETIC THEORY Phys 311 Fall 2014 ELECTROMAGNETIC THEORY Phys 311 Fall 2014 Instructor: Office: Professor David Collins WS 228B Phone: 248-1787 email: Office Hours: dacollin@coloradomesa.edu MT 9:00 9:50am, MWF 2:00

More information

ADI iterations for. general elliptic problems. John Strain Mathematics Department UC Berkeley July 2013

ADI iterations for. general elliptic problems. John Strain Mathematics Department UC Berkeley July 2013 ADI iterations for general elliptic problems John Strain Mathematics Department UC Berkeley July 2013 1 OVERVIEW Classical alternating direction implicit (ADI) iteration Essentially optimal in simple domains

More information

Math 353 Lecture Notes Week 6 Laplace Transform: Fundamentals

Math 353 Lecture Notes Week 6 Laplace Transform: Fundamentals Math 353 Lecture Notes Week 6 Laplace Transform: Fundamentals J. Wong (Fall 217) October 7, 217 What did we cover this week? Introduction to the Laplace transform Basic theory Domain and range of L Key

More information

Uniform continuity of sinc x

Uniform continuity of sinc x Uniform continuit of sinc Peter Haggstrom www.gotohaggstrom.com mathsatbondibeach@gmail.com August 3, 03 Introduction The function sinc = sin as follows: is well known to those who stud Fourier theor.

More information

Symmetry Arguments and the Role They Play in Using Gauss Law

Symmetry Arguments and the Role They Play in Using Gauss Law Smmetr Arguments and the Role The la in Using Gauss Law K. M. Westerberg (9/2005) Smmetr plas a ver important role in science in general, and phsics in particular. Arguments based on smmetr can often simplif

More information

Time-Frequency Analysis: Fourier Transforms and Wavelets

Time-Frequency Analysis: Fourier Transforms and Wavelets Chapter 4 Time-Frequenc Analsis: Fourier Transforms and Wavelets 4. Basics of Fourier Series 4.. Introduction Joseph Fourier (768-83) who gave his name to Fourier series, was not the first to use Fourier

More information