Introduction to Numerical Methods for Solving Partial Differential Equations

Size: px
Start display at page:

Download "Introduction to Numerical Methods for Solving Partial Differential Equations"

Transcription

1 Introduction to Numerical Methods for Solving Partial Differential Equations Benson Muite benson 25 March 2015

2 Outline Review Aim The heat equation Methods for solving the heat equation Fourier Series The Allen Cahn Equation Summary References

3 Ordinary Differential Equations: Numerical Schemes Forward Euler method y n+1 y n = f ( y n) δt Backward Euler method Implicit Midpoint rule y n+1 y n δt y n+1 y n δt Crank Nicolson Method y n+1 y n δt = f (y n+1) ( y n+1 + y n ) = f 2 = f ( y n+1) + f (y n ) 2 Other Methods: Runge Kutta, Adams Bashforth, Backward differentiation, splitting

4 The Heat Equation Used to model diffusion of heat, species, 1D 2D 3D u t u t u t = 2 u x 2 = 2 u x u y 2 = 2 u x u y u z 2 Not always a good model, since it has infinite speed of propagation Strong coupling of all points in domain make it computationally intensive to solve in parallel

5 Linear Schrödinger Equation Used to model quantum mechanical phenomena and often appears in simplified wave propagation models 1D 2D 3D i u t i u t i u t = 2 u x 2 = 2 u x u y 2 = 2 u x u y u z 2 Looks like a heat equation with imaginary time Strong coupling of all points in domain make it computationally intensive to solve in parallel

6 The Wave Equation Used to model propagation of sound, light 1D 2 u t 2 = 2 u x 2 2D 2 u t 2 = 2 u x u y 2 3D 2 u t 2 = 2 u x u y u z 2 Has finite speed of propagation Finite signal propagation speed sometimes useful in parallelization since there is no coupling between grid points that are far apart, hence smaller communication requirements If propagation speed is very fast, communication requirements still important

7 The Poisson Equation Used to model static deflection of a drumhead 1D 2D 3D f (x) = 2 u x 2 f (x, y) = 2 u x u y 2 f (x, y, z) = 2 u x u y u z 2 No time dependence, but also arises in time discretizations of time dependent partial differential equations

8 Burgers Equation Simple model for gas dynamics, also traffic Inviscid form (can develop shocks) Viscous form u t = uu x u t = uu x + ɛu xx

9 Navier-Stokes Equations Models motion of fluids Consider incompressible case only (low speed motion relative to speed of sound) ( ) u ρ t + u u u = 0. p pressure, µ viscosity, ρ, density 2D u(x, y) = (u(x, y), v(x, y)) = p + µ u 3D u(x, y, z) = (u(x, y, z), v(x, y, z), w(x, y, z))

10 Maxwells Equations Model propagation of electromagnetic waves D t H = 0 B t + E = 0 with the relation between the electromagnetic components given by the constitutive relations: D = ε o (x, y, z) E B = µ o (x, y, z) H

11 Summary on Models Many diverse models In 2D and 3D, parallel computing is very useful for getting numerical solutions in reasonable time Typical applications are in physics, chemistry, biology and engineering Related models also appear in social sciences, though usefulness for predictability of real world data is less clear

12 Aim to simulate this, Visualization around Formula 1 Race Car by Renato N. Elias, Rio de Janeiro, Brazil

13 or this Visualization around Formula 1 Race Car by Renato N. Elias, Rio de Janeiro, Brazil

14 Maybe even this

15 A simple model: The Heat Equation

16 The Heat Equation How does the temperature of the rod vary with time?

17 The Heat Equation: Model 1 Middle of rod is initially hot due to previous heating (eg. oven in house that has just been turned off) Temperature on the two sides is 0 (winter and cold outside the house) Assume discrete uniformly space time, and discrete space with molecules at each coordinate point Assume temperature in bar is directly proportional to heat, with the same proportionality constant throughout the bar At next time step, a molecule will with probability 0.5 not transfer its current heat with probability 0.25 transfer half of its heat to its left neighbor with probability 0.25 transfer half of its heat to its right neighbor

18 The Heat Equation: Model 1 Let Ti n denote the temperature at position i at time n. Particles at the end have a fixed temperature/heat they can transfer, but they always remain at the same temperature. T n+1 i = Not transfer heat 0.0T n i 1 + T n i 0.5T n i 1 + T n i 0.5T n i 1 + T n i 0.0T n i 1 + T n i Transfer heat left 0.0T n i T n i 0.5T n i T n i 0.5T n i T n i 0.0T n i T n i Transfer heat right 0.0T n i T n i 0.5T n i T n i 0.5T n i T n i 0.0T n i T n i + 0.5T n i+1 probability T n i+1 probability T n i+1 probability T n i+1 probability T n i+1 probability T n i+1 probability T n i+1 probability T n i+1 probability T n i+1 probability T n i+1 probability T n i+1 probability T n i+1 probability

19 DEMO The Heat Equation: Model 1

20 The Heat Equation: Model 2 Probability is hard! It takes a long time May only interested in average temperature/heat, not instantaneous fluctuations Take averages T n+1 i = ( )Ti 1 n n + ( )Ti + ( )Ti+1 n T n+1 i or T n+1 i = 0.125Ti 1 n T i n Ti+1 n = T n i + T i 1 n 2T i n + Ti+1 n 8 The last line looks like a difference approximation for a differential equation

21 The Heat Equation: Model 3 Let us find a differential equation! Make the time increment small T n+1 i T n+1 i = T n i T n i δt + T i 1 n 2T i n + Ti+1 n 8 = T i 1 n 2T i n 8δt + T n i+1

22 The Heat Equation: Model 3 Let us find a differential equation! Make the space increment small T n+1 i T n+1 i T n i δt T n i δt = T i 1 n 2T i n + Ti+1 n 8δt = (δx)2 8δt Ti 1 n T i n δx T i n Ti+1 n δx δx Let δx 0 and δt 0 such that (δx) 2 = δt we get T t = 1 2 T 8 x 2 Constant in continuum formulation depends on physics and is usually measured experimentally, or determined from microscopic (many particle) simulations.

23 The Heat Equation: Numerical Solution Methods Probabalistic Finite Difference Finite Volume Finite Element Spectral

24 Finite Difference Method Approximate derivatives by difference quotients Simple method to derive and implement Convergence rates tend not to be great Difficult to use for complicated geometries Tends to scale well since communication requirements are low

25 Finite Difference Method for Heat Equation u t = 8u xx Using backward Euler time stepping: u n+1 i u n i δt = 8 un+1 i 1 2un+1 i + u n+1 i+1 (δx) 2 Using forward Euler time stepping (strong stability restrictions): u n+1 i u n i δt = 8 un i 1 2un i + u n i+1 (δx) 2

26 Finite Difference Method for Heat Equation Simple method to derive and implement Hardest part for implicit schemes is solution of resulting linear system of equations Explicit schemes typically have stability restrictions or can always be unstable Convergence rates tend not to be great to get an accurate solution, a large number of grid points are needed Difficult to use for complicated geometries Tends to scale well since communication requirements are low

27 Finite Volume Method for Heat Equation u = v and t = v x Consider a cell averaged integral, then use implicit midpoint rule xi+1 x i u x dx = x i+1 x i vdx u i+1 u i = x i+1 x i vdx u t = 2 u or u x 2 x u n+1 i+1 +un i+1 un+1 u i i n 2 = v n+1 i+1 +v i+1 n n+1 +v +v i i n xi+1 xi+1 x i u n+1 i+1 +un+1 u i i+1 n un i x i u t dx = x i+1 v x dx x i u t dx = v i+1 v i 2δt δx = v n+1 2 δx i+1 +v i+1 n n+1 v v i i n 2 Several ways of approximating the integrals. The one above is a little unusual, most finite volume schemes use left sided or right sided approximations.

28 Finite Volume Method for Heat Equation For implicit schemes, hardest part is solving the system of equations that results Explicit schemes parallelize very well, however a large number of grid points are usually needed to get accurate results Automated construction of simple finite volume schemes is possible, making them popular in packages No convergence theory for high order finite volume schemes Tricky to do complicated geometries accurately

29 Finite Element Method for Heat Equation u t = 2 u x 2 Assume u(x, t) ũ(x, t) = i φ i(x)t i (t), where φ i (x) is zero for x > x i+1 and x < x i 1. A simple choice is ψ is the triangle hat function, x i+1 x for x [x i, x i+1 ] and x x i 1 for x [x i 1, x i ] Now need to find T i (t), which will be evaluated using finite differences.

30 Finite Element Method for Heat Equation Consider multiplying the heat equation by a polynomial, φ j that is only non zero over a few grid points, then integrate by parts, xi+1 x i 1 xi+1 x i 1 ũ t φ idx = x i+1 2 ũ x i 1 x 2 φ i dx ũ t φ idx = x i+1 ũ φ i x i 1 x x dx

31 Finite Element Method for Heat Equation Then use implicit midpoint rule xi+1 x i 1 xi+1 ũ x i 1 t φ idx = x i+1 ũ n+1 ũ n δt φ i dx = x i+1 1 x i 1 2 ũ x ( ũ n x x i 1 φ i x dx + ũn+1 x ) φi x dx [ 1 ũn+1 2 = i+1 ũn i+1 δt [ 1 2 [ 1 2 ( ũ n+1 x ( ũ n+1 x φ i xi+1 + ũn+1 i 1 ũn i 1 ] δt φ i xi 1 2δx ) ] + ũn φ xi+1 x i xi+1 x 2δx xi+1 ) ] + ũn 2δx xi 1 xi 1 xi 1 Since φ are known before hand, can re-write this as matrix vector products, so need to solve a linear system at each time step. x φ i x

32 Finite Element Method for Heat Equation Several other ways of approximating the integrals, can extend to multiple dimensions. Weak formulation allows for solution of equations where second derivative is not naturally defined Large mathematical community developing convergence theory for these methods Well suited to complicated geometries Rather difficult to implement compared to other schemes because of integrals that need to be computed Used in many codes, but typically codes are hand written to obtain high efficiency For implicit time discretizations, solving the linear system of equations that results can be most time consuming part

33 Fourier Spectral Method for Heat Equation

34 Fourier Series: Separation of Variables 1 dy dt = y dy = dt y dy = dt y ln y + a = t + b e ln y+a = e t+b e ln y e a = e t e b y = eb e a et y(t) = ce t

35 Fourier Series: Separation of Variables 2 Suppose u = X(x)T (t) u t = 2 u x 2 dt dt (t) d2x T (t) = (x) dx 2 X(x) = C, Solving each of these separately and then using linearity we get a general solution α n exp( C n t) sin( C n x) + β n exp( C n t) cos( C n x) n=0

36 Fourier Series: Separation of Variables 3 How do we find a particular solution? Suppose u(x, t = 0) = f (x) Suppose u(0, t) = u(2π, t) and u x (0, t) = u x (2π, t) then recall 2π 0 2π 0 2π 0 { π m = n sin(nx) sin(mx) = 0 m n, { π m = n cos(nx) cos(mx) = 0 m n, cos(nx) sin(mx) = 0.

37 Fourier Series: Separation of Variables 4 So if then and u(x, t) = f (x) = α n sin(nx) + β n cos(nx). n=0 α n = β n = 2π 0 f (x) sin(nx)dx 2π 0 sin 2 (nx)dx 2π 0 f (x) cos(nx)dx 2π 0 cos 2 (nx)dx. exp( n 2 t) [α n sin(nx) + β n cos(nx)] n=0

38 Fourier Series: Separation of Variables 5 The Fast Fourier Transform allows one to find good approximations to α n and β n when the solution is found at a finite number of evenly spaced grid points By rescaling, can consider intervals other than [0, 2π) Fourier transform also works on infinite intervals, but require function to decay to the same constant value at ±

39 Complex Fourier Series By using Euler s formula, one can get a simpler expression for a Fourier series where sine and cosine are combined u = n= γ n exp(inx) x [0, 2π) Source:

40 A Computational Algorithm for Computing An Approximate Fourier Transform 1 Analytic method of computing Fourier transform can be tedious Can use quadrature to numerically evaluate Fourier transforms O(n 2 ) operations Gauss and then Cooley and Tukey found O(n log n) algorithm Key observation is to use factorization and recursion Modern computers use variants of this idea that are more suitable for computer hardware where moving data is more expensive than floating point operations

41 A Computational Algorithm for Computing An Approximate Fourier Transform 2 Example pseudo code to compute a radix 2 out of place DFT where x has length that is a power of 2 1: procedure X 0,...,N 1 (ditfft2(x,n,s)) 2: DFT of (x 0, x s, x 2 s,..., x (N 1)s ) 3: if N=1 then 4: trivial size-1 DFT of base case 5: X 0 X 0 6: else 7: DFT of (x 0, x 2s, x 4s,...) 8: X 0,...,N/2 1 ditfft2(x, N/2, 2s) 9: DFT of (x s, x s+2s, x s+4s,...) 10: X N/2,...,N 1 ditfft2(x + s, N/2, 2s) 11: Combine DFTs of two halves into full DFT 12: for k = 0 N/2 1 do 13: t X k 14: X k t + exp( 2πik/N)X k+n/2 15: X k+n/2 t exp( 2πik/N)X k+n/2 16: end for 17: end if 18: end procedure Sources:

42 The Heat Equation: Finding Derivatives and Timestepping Let u(x) = û k exp(ikx) k then d ν u dx ν = (ik) ν û k exp(ikx). Consider u t = u xx, which is approximated by û n+1 k û k t û n k δt = (ik) 2 û k û n+1 k [1 δt(ik) 2 ] = û n k û n+1 k = = (ik) 2 û n+1 k û n k [1 δt(ik) 2 ].

43 The Heat Equation: Finding Derivatives and Timestepping Python demonstration

44 The Allen Cahn Equation: Implicit-Explicit Method Consider u t = ɛu xx + u u 3, which is approximated by backward Euler for the linear terms and forward Euler for the nonlinear terms û t û n+1 û n δt = ɛ(ik) 2 û + û û3 = ɛ(ik) 2 u n+1 ˆ + uˆ n (u ˆn ) 3

45 The Allen Cahn Equation: Implicit-Explicit Method Python demonstration

46 Key Concepts Differential equations used to model physical phenomena - approximate model Microscopic model can suggest ways to find approximate solutions on computers Several methods introduced, probabilistic, finite difference, finite element, spectral (Fourier transform) Need to check simulations for discretization errors, then before using for prediction, understand modeling errors Time stepping, Forward Euler, Backward Euler, Implicit Midpoint Rule, Implicit-Explicit

47 References Barth, T. and Ohlberger, M. Finite Volume Methods: Foundation and Analysis Boyd, J.P. Chebyshev and Fourier Spectral Methods 2nd. edition http: //www-personal.umich.edu/ jpboyd/book_spectral2000.html Chen G., Cloutier B., Li N., Muite B.K., Rigge P. and Balakrishnan S., Souza A., West J. Parallel Spectral Numerical Methods petascale/materials/upmodules/parallel_spectral_methods/ Corral M. Vector Calculus Cooley J.W. and Tukey J.W. An algorithm for the machine calculation of complex Fourier series Math. Comput. 19, , (1965) Eymard, R. Gallouët, T. and Herbin, R. Finite Volume Methods herbin/book/bookevol.pdf Greenbaum A. and Chartier T.P. Numerical Methods Princeton University Press (2012) Heideman M.T., Johnson D.H. and Burrus C.S. Gauss and the History of the Fast Fourier Transform IEEE ASSP Magazine 1, 14 21, (1984) Ketcheson, D. Hyperpython Lawler, G.F. Random Walk and the Heat Equation American Mathematical Society (2010) Macqueron, C. Computational Fluid Dynamics Modeling of a wood-burning stove-heated sauna using NIST s Fire Dynamics Simulator

48 References McGrattan, K. et al. Fire Dynamics Simulator Petersen W.P. and Arbenz P. Introduction to Parallel Computing Oxford University Press (2004) Quarteroni, A. Sacco, R. and Saleri, F. Numerical Mathematics Sauer T. Numerical Analysis Pearson (2012) Süli, E. Finite element methods for partial differential equations people.maths.ox.ac.uk/suli/fem.pdf Trefethen, L.N. Finite Difference and Spectral Methods for Ordinary and Partial Differential Equations Vainikko E. Scientific Computing Lectures Vainikko E. Fortran 95 Ja MPI Tartu Ülikool Kirjastus (2004) eero/pc/f95jampi.pdf

49 Acknowledgements Oleg Batra sev Leonid Dorogin Michael Quell Eero Vainikko The Blue Waters Undergraduate Petascale Education Program administered by the Shodor foundation The Division of Literature, Sciences and Arts at the University of Michigan

50 Extra Slides

51 Fun with Fourier Series A Fourier series can represent a regular k-gon in the complex plane f (t) = + n= (1 + kn) 2 exp [i(1 + kn)t] t ( π, π) Robert, A Fourier Series of Polygons Amer. Math. Monthly 101(5) pp (1994) Schonberg, IJ The Finite Fourier Series And Elementary Geometry Amer. Math. Monthly 57(6) pp (1950)

52 Monte Carlo Method: A Probabilistic Way to Calculate Integrals Recall Hence given f 1 b f = f (x) dx b a a b a f (x)dx = (b a) f Doing the same in 2 dimensions and estimating the error using the standard deviation f f (x, y) da A(R) f ± A(R) 2 ( f ) 2, N R Approximate f by random sampling N f i=1 f (x i, y i ) N and f N 2 i=1 (f (x i, y i )) 2 N

53 # we scale the i n t e g r a l by the t o t a l area and d i v i d e by the number of # p o i n t s used I2d=I2d / numpoints I2dsquare=I2dsquare / numpoints EstimError =4.0 numpy. sqrt ( ( I2dsquare I2d 2)/ numpoints ) # estimated e r r o r I2d=I2d 4.0 p r i n t Value : %f %I2d p r i n t Error estimate : %f %EstimError Listing 1: A Python program which demonstrates how to use the Monte Carlo method to calculate the volume below z = x 2 + 2y 2, with (x, y) (0, 1) (0, 4). Monte Carlo Method: Python Program A program to approximate an i n t e g r a l using a Monte Carlo method This could be made faster by using vectorization, however i t is kept as simple as possible for c l a r i t y and ease of translation into other languages import math import numpy import time numpoints=65536 # number of random sample p o i n t s I2d =0.0 # i n i t i a l i z e value I2dsquare =0.0 # i n i t i a l i z e to allow for calculation of variance for n in xrange ( numpoints ) : x=numpy. random. uniform ( ) y=4.0 numpy. random. uniform ( ) I2d=I2d+x x+2.0 y y I2dsquare=I2dsquare +( x x+2.0 y y) 2

54 Sample Results of Monte Carlo Program N Value Error Estimate / / / / See Spectral_Numerical_Methods/Introduction_to_ Parallel_Programming for more information

Introduction to Scientific Computing

Introduction to Scientific Computing Introduction to Scientific Computing Benson Muite benson.muite@ut.ee http://kodu.ut.ee/ benson https://courses.cs.ut.ee/218/isc/spring 5 March 218 [Public Domain, https://commons.wikimedia.org/wiki/file:curie

More information

Spectral Methods and Inverse Problems

Spectral Methods and Inverse Problems Spectral Methods and Inverse Problems Omid Khanmohamadi Department of Mathematics Florida State University Outline Outline 1 Fourier Spectral Methods Fourier Transforms Trigonometric Polynomial Interpolants

More information

Navier-Stokes equations

Navier-Stokes equations 1 Navier-Stokes equations Introduction to spectral methods for the CSC Lunchbytes Seminar Series. Incompressible, hydrodynamic turbulence is described completely by the Navier-Stokes equations where t

More information

Parallel Spectral Numerical Methods

Parallel Spectral Numerical Methods Parallel Spectral Numerical Methods Gong Chen, Brandon Cloutier, Ning Li, Benson K. Muite and Paul Rigge with contributions from Sudarshan Balakrishnan, Andre Souza and Jeremy West September 3, 2012 Contents

More information

Appendix C: Recapitulation of Numerical schemes

Appendix C: Recapitulation of Numerical schemes Appendix C: Recapitulation of Numerical schemes August 31, 2009) SUMMARY: Certain numerical schemes of general use are regrouped here in order to facilitate implementations of simple models C1 The tridiagonal

More information

Lecture 7 January 26, 2016

Lecture 7 January 26, 2016 MATH 262/CME 372: Applied Fourier Analysis and Winter 26 Elements of Modern Signal Processing Lecture 7 January 26, 26 Prof Emmanuel Candes Scribe: Carlos A Sing-Long, Edited by E Bates Outline Agenda:

More information

Numerical methods for the Navier- Stokes equations

Numerical methods for the Navier- Stokes equations Numerical methods for the Navier- Stokes equations Hans Petter Langtangen 1,2 1 Center for Biomedical Computing, Simula Research Laboratory 2 Department of Informatics, University of Oslo Dec 6, 2012 Note:

More information

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

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

More information

Dedalus: An Open-Source Spectral Magnetohydrodynamics Code

Dedalus: An Open-Source Spectral Magnetohydrodynamics Code Dedalus: An Open-Source Spectral Magnetohydrodynamics Code Keaton Burns University of California Berkeley Jeff Oishi SLAC National Accelerator Laboratory Received ; accepted ABSTRACT We developed the magnetohydrodynamic

More information

MIT (Spring 2014)

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

More information

Partial Differential Equations

Partial Differential Equations Partial Differential Equations Introduction Deng Li Discretization Methods Chunfang Chen, Danny Thorne, Adam Zornes CS521 Feb.,7, 2006 What do You Stand For? A PDE is a Partial Differential Equation This

More information

Numerical Solutions of the Burgers System in Two Dimensions under Varied Initial and Boundary Conditions

Numerical Solutions of the Burgers System in Two Dimensions under Varied Initial and Boundary Conditions Applied Mathematical Sciences, Vol. 6, 22, no. 3, 563-565 Numerical Solutions of the Burgers System in Two Dimensions under Varied Initial and Boundary Conditions M. C. Kweyu, W. A. Manyonge 2, A. Koross

More information

Finite Difference Methods for

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

More information

LEAST-SQUARES FINITE ELEMENT MODELS

LEAST-SQUARES FINITE ELEMENT MODELS LEAST-SQUARES FINITE ELEMENT MODELS General idea of the least-squares formulation applied to an abstract boundary-value problem Works of our group Application to Poisson s equation Application to flows

More information

Introduction to Scientific Computing

Introduction to Scientific Computing Introduction to Scientific Computing Benson Muite benson.muite@ut.ee http://kodu.ut.ee/ benson https://courses.cs.ut.ee/2018/isc/spring 26 March 2018 [Public Domain,https://commons.wikimedia.org/wiki/File1

More information

FDM for parabolic equations

FDM for parabolic equations FDM for parabolic equations Consider the heat equation where Well-posed problem Existence & Uniqueness Mass & Energy decreasing FDM for parabolic equations CNFD Crank-Nicolson + 2 nd order finite difference

More information

An Introduction to Differential Algebra

An Introduction to Differential Algebra An Introduction to Differential Algebra Alexander Wittig1, P. Di Lizia, R. Armellin, et al. 1 ESA Advanced Concepts Team (TEC-SF) SRL, Milan Dinamica Outline 1 Overview Five Views of Differential Algebra

More information

ME Computational Fluid Mechanics Lecture 5

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

More information

CS 450 Numerical Analysis. Chapter 9: Initial Value Problems for Ordinary Differential Equations

CS 450 Numerical Analysis. Chapter 9: Initial Value Problems for Ordinary Differential Equations Lecture slides based on the textbook Scientific Computing: An Introductory Survey by Michael T. Heath, copyright c 2018 by the Society for Industrial and Applied Mathematics. http://www.siam.org/books/cl80

More information

The Orchestra of Partial Differential Equations. Adam Larios

The Orchestra of Partial Differential Equations. Adam Larios The Orchestra of Partial Differential Equations Adam Larios 19 January 2017 Landscape Seminar Outline 1 Fourier Series 2 Some Easy Differential Equations 3 Some Not-So-Easy Differential Equations Outline

More information

Computational Methods in Plasma Physics

Computational Methods in Plasma Physics Computational Methods in Plasma Physics Richard Fitzpatrick Institute for Fusion Studies University of Texas at Austin Purpose of Talk Describe use of numerical methods to solve simple problem in plasma

More information

A Brief Introduction to Numerical Methods for Differential Equations

A Brief Introduction to Numerical Methods for Differential Equations A Brief Introduction to Numerical Methods for Differential Equations January 10, 2011 This tutorial introduces some basic numerical computation techniques that are useful for the simulation and analysis

More information

Implicit-explicit exponential integrators

Implicit-explicit exponential integrators Implicit-explicit exponential integrators Bawfeh Kingsley Kometa joint work with Elena Celledoni MaGIC 2011 Finse, March 1-4 1 Introduction Motivation 2 semi-lagrangian Runge-Kutta exponential integrators

More information

Math 201 Assignment #11

Math 201 Assignment #11 Math 21 Assignment #11 Problem 1 (1.5 2) Find a formal solution to the given initial-boundary value problem. = 2 u x, < x < π, t > 2 u(, t) = u(π, t) =, t > u(x, ) = x 2, < x < π Problem 2 (1.5 5) Find

More information

A Bound-Preserving Fourth Order Compact Finite Difference Scheme for Scalar Convection Diffusion Equations

A Bound-Preserving Fourth Order Compact Finite Difference Scheme for Scalar Convection Diffusion Equations A Bound-Preserving Fourth Order Compact Finite Difference Scheme for Scalar Convection Diffusion Equations Hao Li Math Dept, Purdue Univeristy Ocean University of China, December, 2017 Joint work with

More information

Final Exam May 4, 2016

Final Exam May 4, 2016 1 Math 425 / AMCS 525 Dr. DeTurck Final Exam May 4, 2016 You may use your book and notes on this exam. Show your work in the exam book. Work only the problems that correspond to the section that you prepared.

More information

Computational Modeling for Physical Sciences

Computational Modeling for Physical Sciences Computational Modeling for Physical Sciences Since the invention of computers the use of computational modeling and simulations have revolutionized the way we study physical systems. Their applications

More information

FOURIER SERIES, HAAR WAVELETS AND FAST FOURIER TRANSFORM

FOURIER SERIES, HAAR WAVELETS AND FAST FOURIER TRANSFORM FOURIER SERIES, HAAR WAVELETS AD FAST FOURIER TRASFORM VESA KAARIOJA, JESSE RAILO AD SAMULI SILTAE Abstract. This handout is for the course Applications of matrix computations at the University of Helsinki

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

Open boundary conditions in numerical simulations of unsteady incompressible flow

Open boundary conditions in numerical simulations of unsteady incompressible flow Open boundary conditions in numerical simulations of unsteady incompressible flow M. P. Kirkpatrick S. W. Armfield Abstract In numerical simulations of unsteady incompressible flow, mass conservation can

More information

Improvements of Unsteady Simulations for Compressible Navier Stokes Based on a RK/Implicit Smoother Scheme

Improvements of Unsteady Simulations for Compressible Navier Stokes Based on a RK/Implicit Smoother Scheme Improvements of Unsteady Simulations for Compressible Navier Stokes Based on a RK/Implicit Smoother Scheme Oren Peles and Eli Turkel Department of Applied Mathematics, Tel-Aviv University In memoriam of

More information

Numerical Methods for PDEs

Numerical Methods for PDEs Numerical Methods for PDEs Problems 1. Numerical Differentiation. Find the best approximation to the second drivative d 2 f(x)/dx 2 at x = x you can of a function f(x) using (a) the Taylor series approach

More information

Spectral Methods for Reaction Diffusion Systems

Spectral Methods for Reaction Diffusion Systems WDS'13 Proceedings of Contributed Papers, Part I, 97 101, 2013. ISBN 978-80-7378-250-4 MATFYZPRESS Spectral Methods for Reaction Diffusion Systems V. Rybář Institute of Mathematics of the Academy of Sciences

More information

Lecture Notes to Accompany. Scientific Computing An Introductory Survey. by Michael T. Heath. Chapter 9

Lecture Notes to Accompany. Scientific Computing An Introductory Survey. by Michael T. Heath. Chapter 9 Lecture Notes to Accompany Scientific Computing An Introductory Survey Second Edition by Michael T. Heath Chapter 9 Initial Value Problems for Ordinary Differential Equations Copyright c 2001. Reproduction

More information

MATH 251 Final Examination December 19, 2012 FORM A. Name: Student Number: Section:

MATH 251 Final Examination December 19, 2012 FORM A. Name: Student Number: Section: MATH 251 Final Examination December 19, 2012 FORM A Name: Student Number: Section: This exam has 17 questions for a total of 150 points. In order to obtain full credit for partial credit problems, all

More information

16. Solution of elliptic partial differential equation

16. Solution of elliptic partial differential equation 16. Solution of elliptic partial differential equation Recall in the first lecture of this course. Assume you know how to use a computer to compute; but have not done any serious numerical computations

More information

The integrating factor method (Sect. 1.1)

The integrating factor method (Sect. 1.1) The integrating factor method (Sect. 1.1) Overview of differential equations. Linear Ordinary Differential Equations. The integrating factor method. Constant coefficients. The Initial Value Problem. Overview

More information

Fast Numerical Methods for Stochastic Computations

Fast Numerical Methods for Stochastic Computations Fast AreviewbyDongbinXiu May 16 th,2013 Outline Motivation 1 Motivation 2 3 4 5 Example: Burgers Equation Let us consider the Burger s equation: u t + uu x = νu xx, x [ 1, 1] u( 1) =1 u(1) = 1 Example:

More information

Research Article L-Stable Derivative-Free Error-Corrected Trapezoidal Rule for Burgers Equation with Inconsistent Initial and Boundary Conditions

Research Article L-Stable Derivative-Free Error-Corrected Trapezoidal Rule for Burgers Equation with Inconsistent Initial and Boundary Conditions International Mathematics and Mathematical Sciences Volume 212, Article ID 82197, 13 pages doi:1.1155/212/82197 Research Article L-Stable Derivative-Free Error-Corrected Trapezoidal Rule for Burgers Equation

More information

The discrete and fast Fourier transforms

The discrete and fast Fourier transforms The discrete and fast Fourier transforms Marcel Oliver Revised April 7, 1 1 Fourier series We begin by recalling the familiar definition of the Fourier series. For a periodic function u: [, π] C, we define

More information

Problem Set Number 01, MIT (Winter-Spring 2018)

Problem Set Number 01, MIT (Winter-Spring 2018) Problem Set Number 01, 18.377 MIT (Winter-Spring 2018) Rodolfo R. Rosales (MIT, Math. Dept., room 2-337, Cambridge, MA 02139) February 28, 2018 Due Thursday, March 8, 2018. Turn it in (by 3PM) at the Math.

More information

Math background. Physics. Simulation. Related phenomena. Frontiers in graphics. Rigid fluids

Math background. Physics. Simulation. Related phenomena. Frontiers in graphics. Rigid fluids Fluid dynamics Math background Physics Simulation Related phenomena Frontiers in graphics Rigid fluids Fields Domain Ω R2 Scalar field f :Ω R Vector field f : Ω R2 Types of derivatives Derivatives measure

More information

Physically Based Simulations (on the GPU)

Physically Based Simulations (on the GPU) Physically Based Simulations (on the GPU) (some material from slides of Mark Harris) CS535 Fall 2014 Daniel G. Aliaga Department of Computer Science Purdue University Simulating the world Floating point

More information

Evolution equations with spectral methods: the case of the wave equation

Evolution equations with spectral methods: the case of the wave equation Evolution equations with spectral methods: the case of the wave equation Jerome.Novak@obspm.fr Laboratoire de l Univers et de ses Théories (LUTH) CNRS / Observatoire de Paris, France in collaboration with

More information

Physics 584 Computational Methods

Physics 584 Computational Methods Physics 584 Computational Methods Introduction to Matlab and Numerical Solutions to Ordinary Differential Equations Ryan Ogliore April 18 th, 2016 Lecture Outline Introduction to Matlab Numerical Solutions

More information

Modified Fourier Spectral Method for Non-periodic CFD

Modified Fourier Spectral Method for Non-periodic CFD Modified Fourier Spectral Method for Non-periodic CFD Huankun Fu Chaoqun Liu Technical Report 2011-14 http://www.uta.edu/math/preprint/ Modified Fourier Spectral Method for Non-periodic CFD Huankun Fu

More information

2.29 Numerical Fluid Mechanics Fall 2011 Lecture 7

2.29 Numerical Fluid Mechanics Fall 2011 Lecture 7 Numerical Fluid Mechanics Fall 2011 Lecture 7 REVIEW of Lecture 6 Material covered in class: Differential forms of conservation laws Material Derivative (substantial/total derivative) Conservation of Mass

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

Math 225 Differential Equations Notes Chapter 1

Math 225 Differential Equations Notes Chapter 1 Math 225 Differential Equations Notes Chapter 1 Michael Muscedere September 9, 2004 1 Introduction 1.1 Background In science and engineering models are used to describe physical phenomena. Often these

More information

Multivariable calculus: What is it good for?

Multivariable calculus: What is it good for? : What is it good for? Department of Mathematics and Statistics, UMBC http://www.math.umbc.edu/ rouben/ January 2011 Purpose The purpose of these slides is to show that the material that one learns in

More information

FUNDAMENTALS OF FINITE DIFFERENCE METHODS

FUNDAMENTALS OF FINITE DIFFERENCE METHODS FUNDAMENTALS OF FINITE DIFFERENCE METHODS By Deep Gupta 3 rd Year undergraduate, Mechanical Engg. Deptt., IIT Bombay Supervised by: Prof. Gautam Biswas, IIT Kanpur Acknowledgements It has been a pleasure

More information

2.20 Fall 2018 Math Review

2.20 Fall 2018 Math Review 2.20 Fall 2018 Math Review September 10, 2018 These notes are to help you through the math used in this class. This is just a refresher, so if you never learned one of these topics you should look more

More information

UNIVERSITY of LIMERICK

UNIVERSITY of LIMERICK UNIVERSITY of LIMERICK OLLSCOIL LUIMNIGH Faculty of Science and Engineering END OF SEMESTER ASSESSMENT PAPER MODULE CODE: MA4607 SEMESTER: Autumn 2012-13 MODULE TITLE: Introduction to Fluids DURATION OF

More information

Partial Differential Equations

Partial Differential Equations M3M3 Partial Differential Equations Solutions to problem sheet 3/4 1* (i) Show that the second order linear differential operators L and M, defined in some domain Ω R n, and given by Mφ = Lφ = j=1 j=1

More information

Scientific Computing: An Introductory Survey

Scientific Computing: An Introductory Survey Scientific Computing: An Introductory Survey Chapter 9 Initial Value Problems for Ordinary Differential Equations Prof. Michael T. Heath Department of Computer Science University of Illinois at Urbana-Champaign

More information

FDM for wave equations

FDM for wave equations FDM for wave equations Consider the second order wave equation Some properties Existence & Uniqueness Wave speed finite!!! Dependence region Analytical solution in 1D Finite difference discretization Finite

More information

Finite Difference and Finite Element Methods

Finite Difference and Finite Element Methods Finite Difference and Finite Element Methods Georgy Gimel farb COMPSCI 369 Computational Science 1 / 39 1 Finite Differences Difference Equations 3 Finite Difference Methods: Euler FDMs 4 Finite Element

More information

AMS 147 Computational Methods and Applications Lecture 17 Copyright by Hongyun Wang, UCSC

AMS 147 Computational Methods and Applications Lecture 17 Copyright by Hongyun Wang, UCSC Lecture 17 Copyright by Hongyun Wang, UCSC Recap: Solving linear system A x = b Suppose we are given the decomposition, A = L U. We solve (LU) x = b in 2 steps: *) Solve L y = b using the forward substitution

More information

ENO and WENO schemes. Further topics and time Integration

ENO and WENO schemes. Further topics and time Integration ENO and WENO schemes. Further topics and time Integration Tefa Kaisara CASA Seminar 29 November, 2006 Outline 1 Short review ENO/WENO 2 Further topics Subcell resolution Other building blocks 3 Time Integration

More information

An Overly Simplified and Brief Review of Differential Equation Solution Methods. 1. Some Common Exact Solution Methods for Differential Equations

An Overly Simplified and Brief Review of Differential Equation Solution Methods. 1. Some Common Exact Solution Methods for Differential Equations An Overly Simplified and Brief Review of Differential Equation Solution Methods We will be dealing with initial or boundary value problems. A typical initial value problem has the form y y 0 y(0) 1 A typical

More information

Numerical Methods for Problems with Moving Fronts Orthogonal Collocation on Finite Elements

Numerical Methods for Problems with Moving Fronts Orthogonal Collocation on Finite Elements Electronic Text Provided with the Book Numerical Methods for Problems with Moving Fronts by Bruce A. Finlayson Ravenna Park Publishing, Inc., 635 22nd Ave. N. E., Seattle, WA 985-699 26-524-3375; ravenna@halcyon.com;www.halcyon.com/ravenna

More information

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

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

More information

Chapter 4. MAC Scheme. The MAC scheme is a numerical method used to solve the incompressible Navier-Stokes. u = 0

Chapter 4. MAC Scheme. The MAC scheme is a numerical method used to solve the incompressible Navier-Stokes. u = 0 Chapter 4. MAC Scheme 4.1. MAC Scheme and the Staggered Grid. The MAC scheme is a numerical method used to solve the incompressible Navier-Stokes equation in the velocity-pressure formulation: (4.1.1)

More information

A Space-Time Expansion Discontinuous Galerkin Scheme with Local Time-Stepping for the Ideal and Viscous MHD Equations

A Space-Time Expansion Discontinuous Galerkin Scheme with Local Time-Stepping for the Ideal and Viscous MHD Equations A Space-Time Expansion Discontinuous Galerkin Scheme with Local Time-Stepping for the Ideal and Viscous MHD Equations Ch. Altmann, G. Gassner, F. Lörcher, C.-D. Munz Numerical Flow Models for Controlled

More information

Lecture 3: From Random Walks to Continuum Diffusion

Lecture 3: From Random Walks to Continuum Diffusion Lecture 3: From Random Walks to Continuum Diffusion Martin Z. Bazant Department of Mathematics, MIT February 3, 6 Overview In the previous lecture (by Prof. Yip), we discussed how individual particles

More information

Worksheet 8 Sample Solutions

Worksheet 8 Sample Solutions Technische Universität München WS 2016/17 Lehrstuhl für Informatik V Scientific Computing Univ.-Prof. Dr. M. Bader 19.12.2016/21.12.2016 M.Sc. S. Seckler, M.Sc. D. Jarema Worksheet 8 Sample Solutions Ordinary

More information

MATH 251 Final Examination December 16, 2015 FORM A. Name: Student Number: Section:

MATH 251 Final Examination December 16, 2015 FORM A. Name: Student Number: Section: MATH 5 Final Examination December 6, 5 FORM A Name: Student Number: Section: This exam has 7 questions for a total of 5 points. In order to obtain full credit for partial credit problems, all work must

More information

Integration of Ordinary Differential Equations

Integration of Ordinary Differential Equations Integration of Ordinary Differential Equations Com S 477/577 Nov 7, 00 1 Introduction The solution of differential equations is an important problem that arises in a host of areas. Many differential equations

More information

Efficient outdoor sound propagation modelling in time-domain

Efficient outdoor sound propagation modelling in time-domain Efficient outdoor sound propagation modelling in time-domain Timothy Van Renterghem Acoustics Group Department of Information Technology Ghent University/iMinds CEAS, X-Noise : Atm. and ground effects

More information

Diffusion Equation and Mean Free Path

Diffusion Equation and Mean Free Path Diffusion Equation and Mean Free Path Speaker: Xiaolei Chen Advisor: Prof. Xiaolin Li Department of Applied Mathematics and Statistics Stony Brook University (SUNY) Content General Introduction Analytic

More information

Finite Difference Solution of the Heat Equation

Finite Difference Solution of the Heat Equation Finite Difference Solution of the Heat Equation Adam Powell 22.091 March 13 15, 2002 In example 4.3 (p. 10) of his lecture notes for March 11, Rodolfo Rosales gives the constant-density heat equation as:

More information

Mathematics Qualifying Exam Study Material

Mathematics Qualifying Exam Study Material Mathematics Qualifying Exam Study Material The candidate is expected to have a thorough understanding of engineering mathematics topics. These topics are listed below for clarification. Not all instructors

More information

AMath 483/583 Lecture 26. Notes: Notes: Announcements. Notes: AMath 483/583 Lecture 26. Outline:

AMath 483/583 Lecture 26. Notes: Notes: Announcements. Notes: AMath 483/583 Lecture 26. Outline: AMath 483/583 Lecture 26 Outline: Monte Carlo methods Random number generators Monte Carlo integrators Random walk solution of Poisson problem Announcements Part of Final Project will be available tomorrow.

More information

Math 5587 Midterm II Solutions

Math 5587 Midterm II Solutions Math 5587 Midterm II Solutions Prof. Jeff Calder November 3, 2016 Name: Instructions: 1. I recommend looking over the problems first and starting with those you feel most comfortable with. 2. Unless otherwise

More information

Differential equations, comprehensive exam topics and sample questions

Differential equations, comprehensive exam topics and sample questions Differential equations, comprehensive exam topics and sample questions Topics covered ODE s: Chapters -5, 7, from Elementary Differential Equations by Edwards and Penney, 6th edition.. Exact solutions

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

MATH 251 Final Examination May 4, 2015 FORM A. Name: Student Number: Section:

MATH 251 Final Examination May 4, 2015 FORM A. Name: Student Number: Section: MATH 251 Final Examination May 4, 2015 FORM A Name: Student Number: Section: This exam has 16 questions for a total of 150 points. In order to obtain full credit for partial credit problems, all work must

More information

Fluid Equations for Rarefied Gases

Fluid Equations for Rarefied Gases 1 Fluid Equations for Rarefied Gases Jean-Luc Thiffeault Department of Applied Physics and Applied Mathematics Columbia University http://plasma.ap.columbia.edu/~jeanluc 23 March 2001 with E. A. Spiegel

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

Differentiation and Integration

Differentiation and Integration Differentiation and Integration (Lectures on Numerical Analysis for Economists II) Jesús Fernández-Villaverde 1 and Pablo Guerrón 2 February 12, 2018 1 University of Pennsylvania 2 Boston College Motivation

More information

Preface. 2 Linear Equations and Eigenvalue Problem 22

Preface. 2 Linear Equations and Eigenvalue Problem 22 Contents Preface xv 1 Errors in Computation 1 1.1 Introduction 1 1.2 Floating Point Representation of Number 1 1.3 Binary Numbers 2 1.3.1 Binary number representation in computer 3 1.4 Significant Digits

More information

NUMERICAL METHODS FOR ENGINEERING APPLICATION

NUMERICAL METHODS FOR ENGINEERING APPLICATION NUMERICAL METHODS FOR ENGINEERING APPLICATION Second Edition JOEL H. FERZIGER A Wiley-Interscience Publication JOHN WILEY & SONS, INC. New York / Chichester / Weinheim / Brisbane / Singapore / Toronto

More information

Lecture 4: Numerical solution of ordinary differential equations

Lecture 4: Numerical solution of ordinary differential equations Lecture 4: Numerical solution of ordinary differential equations Department of Mathematics, ETH Zürich General explicit one-step method: Consistency; Stability; Convergence. High-order methods: Taylor

More information

Finite Volume Method

Finite Volume Method Finite Volume Method An Introduction Praveen. C CTFD Division National Aerospace Laboratories Bangalore 560 037 email: praveen@cfdlab.net April 7, 2006 Praveen. C (CTFD, NAL) FVM CMMACS 1 / 65 Outline

More information

Math 126 Final Exam Solutions

Math 126 Final Exam Solutions Math 126 Final Exam Solutions 1. (a) Give an example of a linear homogeneous PE, a linear inhomogeneous PE, and a nonlinear PE. [3 points] Solution. Poisson s equation u = f is linear homogeneous when

More information

EAD 115. Numerical Solution of Engineering and Scientific Problems. David M. Rocke Department of Applied Science

EAD 115. Numerical Solution of Engineering and Scientific Problems. David M. Rocke Department of Applied Science EAD 115 Numerical Solution of Engineering and Scientific Problems David M. Rocke Department of Applied Science Computer Representation of Numbers Counting numbers (unsigned integers) are the numbers 0,

More information

PART IV Spectral Methods

PART IV Spectral Methods PART IV Spectral Methods Additional References: R. Peyret, Spectral methods for incompressible viscous flow, Springer (2002), B. Mercier, An introduction to the numerical analysis of spectral methods,

More information

Numerical Methods in Geophysics. Introduction

Numerical Methods in Geophysics. Introduction : Why numerical methods? simple geometries analytical solutions complex geometries numerical solutions Applications in geophysics seismology geodynamics electromagnetism... in all domains History of computers

More information

AIMS Exercise Set # 1

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

More information

Research Computing with Python, Lecture 7, Numerical Integration and Solving Ordinary Differential Equations

Research Computing with Python, Lecture 7, Numerical Integration and Solving Ordinary Differential Equations Research Computing with Python, Lecture 7, Numerical Integration and Solving Ordinary Differential Equations Ramses van Zon SciNet HPC Consortium November 25, 2014 Ramses van Zon (SciNet HPC Consortium)Research

More information

Sequential Monte Carlo Samplers for Applications in High Dimensions

Sequential Monte Carlo Samplers for Applications in High Dimensions Sequential Monte Carlo Samplers for Applications in High Dimensions Alexandros Beskos National University of Singapore KAUST, 26th February 2014 Joint work with: Dan Crisan, Ajay Jasra, Nik Kantas, Alex

More information

2.29 Numerical Fluid Mechanics Fall 2011 Lecture 20

2.29 Numerical Fluid Mechanics Fall 2011 Lecture 20 2.29 Numerical Fluid Mechanics Fall 2011 Lecture 20 REVIEW Lecture 19: Finite Volume Methods Review: Basic elements of a FV scheme and steps to step-up a FV scheme One Dimensional examples d x j x j 1/2

More information

The Spectral-Element Method: Introduction

The Spectral-Element Method: Introduction The Spectral-Element Method: Introduction Heiner Igel Department of Earth and Environmental Sciences Ludwig-Maximilians-University Munich Computational Seismology 1 / 59 Outline 1 Introduction 2 Lagrange

More information

International Journal of Scientific & Engineering Research, Volume 4, Issue 6, June ISSN

International Journal of Scientific & Engineering Research, Volume 4, Issue 6, June ISSN International Journal of Scientific & Engineering Research, Volume 4, Issue 6, June-2013 1405 Numerical Solution of Burger s equation via Cole-Hopf transformed diffusion equation Ronobir C. Sarer 1 and

More information

KINGS COLLEGE OF ENGINEERING DEPARTMENT OF MATHEMATICS ACADEMIC YEAR / EVEN SEMESTER QUESTION BANK

KINGS COLLEGE OF ENGINEERING DEPARTMENT OF MATHEMATICS ACADEMIC YEAR / EVEN SEMESTER QUESTION BANK KINGS COLLEGE OF ENGINEERING MA5-NUMERICAL METHODS DEPARTMENT OF MATHEMATICS ACADEMIC YEAR 00-0 / EVEN SEMESTER QUESTION BANK SUBJECT NAME: NUMERICAL METHODS YEAR/SEM: II / IV UNIT - I SOLUTION OF EQUATIONS

More information

Borel Summability in PDE initial value problems

Borel Summability in PDE initial value problems Borel Summability in PDE initial value problems Saleh Tanveer (Ohio State University) Collaborator Ovidiu Costin & Guo Luo Research supported in part by Institute for Math Sciences (IC), EPSRC & NSF. Main

More information

PowerPoints organized by Dr. Michael R. Gustafson II, Duke University

PowerPoints organized by Dr. Michael R. Gustafson II, Duke University Part 5 Chapter 21 Numerical Differentiation PowerPoints organized by Dr. Michael R. Gustafson II, Duke University 1 All images copyright The McGraw-Hill Companies, Inc. Permission required for reproduction

More information

examples of equations: what and why intrinsic view, physical origin, probability, geometry

examples of equations: what and why intrinsic view, physical origin, probability, geometry Lecture 1 Introduction examples of equations: what and why intrinsic view, physical origin, probability, geometry Intrinsic/abstract F ( x, Du, D u, D 3 u, = 0 Recall algebraic equations such as linear

More information

Integration of Differential Equations

Integration of Differential Equations Integration of Differential Equations Gabriel S. Cabrera August 4, 018 Contents 1 Introduction 1 Theory.1 Linear 1 st Order ODEs................................. 3.1.1 Analytical Solution...............................

More information

PowerPoints organized by Dr. Michael R. Gustafson II, Duke University

PowerPoints organized by Dr. Michael R. Gustafson II, Duke University Part 6 Chapter 20 Initial-Value Problems PowerPoints organized by Dr. Michael R. Gustafson II, Duke University All images copyright The McGraw-Hill Companies, Inc. Permission required for reproduction

More information