Introduction to multiscale modeling and simulation. Explicit methods for ODEs : forward Euler. y n+1 = y n + tf(y n ) dy dt = f(y), y(0) = y 0

Size: px
Start display at page:

Download "Introduction to multiscale modeling and simulation. Explicit methods for ODEs : forward Euler. y n+1 = y n + tf(y n ) dy dt = f(y), y(0) = y 0"

Transcription

1 Introduction to multiscale modeling and simulation Lecture 5 Numerical methods for ODEs, SDEs and PDEs The need for multiscale methods Two generic frameworks for multiscale computation Explicit methods for ODEs : forward Euler We consider an initial value problem dy dt = f(y), y(0) = y 0 An analytical solution y(t) cannot be obtained, so we resort to numerical methods. y n y(t n ) t n = n t The simplest method of this type is forward Euler y n+ = y n + tf(y n )

2 Consistency of the forward Euler method Forward Euler method is given by y n+ = y n + tf(y n ) Let us fill in the exact solution and Taylor expand y(t n+ ) y(t n )+ tf(y(t n )) + t 2 y (t n ) 2 Thus, in one step, we make an error of O( t 2 ) n = t / t To get at a given time t, we must take steps The global error is then O( t), i.e. first order Higher-order methods can be developed (see a dedicated course) Stability of the forward Euler method Consistency shows that the method converges for t 0 What happens for finite t? Look at stability of the method! Consider the test equation y = λy Re(λ) < 0 Solutions of the forward Euler scheme need to tend to 0 for y n+ = y n ( + λ t) t Im(λ t) λ R : t<2/ λ -2 - Re(λ t) -

3 Possibly unphysical behavior of forward Euler Just because a numerical method is stable, does not imply desired behavior! y n+ = y n ( + λ t) =ρy n λ R : t<2/ λ Exact solution : y(t n )=exp( λn t) y 0 Numerical approximation : y n =(+λ t) n y 0 = ρ n y 0 amplification factor 0.75 ( + λ t) > 0 ( + λ t) < y(t) 0.5 y(t) t t Forward Euler for a two-scale test equation Consider a linear system with two time scales dx dt = λx dy dt = y λ / λ R This system has eigenvalues and. Consider Then, forward Euler is stable if both λ t <2 t/ < 2 So, for 0, we have the condition t <2

4 Forward Euler does not always represent fast modes well y(t) x n+ = x n ( + λ t) =ρ λ x n y n+ = y n ( t/) =ρ y n t = /2 When t = O(), time-scales of fast equation are changed! - Im(ρ) Re(ρ) t t =.8 Fast decaying modes may become slowly decaying, but oscillatory! - Im(ρ) y(t) Re(ρ) t - Slow modes are unaffected by the time step Im(ρ) x n+ = x n ( + λ t) =ρ λ x n y n+ = y n ( t/) =ρ y n Im(ρ) - Re(ρ) - Re(ρ) t = /2 2.5 t =.8 x(t) x(t) t t

5 Stiffness Consider a slow-fast system du = u u 2 +2 dt du 2 = dt (u3 u 2 ) Quickly relaxes to du dt = u u 3 +2 u 2 = u 3 A discrepancy between t - the (large) time step that can be taken to obtain required accuracy u u 2 - the (small) time step for that is needed for stability δt = O() Alternative approach : Implicit methods for ODEs dy dt = f(y), y(0) = y 0 An alternative to forward Euler is backward Euler y n+ = y n + tf(y n+ ) Now, the solution y n+ is found as the solution of a nonlinear system (more work per time-step!) Method is still first order accurate y(t n+ ) y(t n ) t = f(y(t n+ )) + O( t)

6 Stability of the backward Euler method Again consider the test equation y = λy Then, backward Euler gives y n+ = y n + tλy n+ ( λ t) y n+ = y n y n+ = λ t yn When Re(λ) < 0 ρ = λ t yn < Im(λ t) 2 - Re(λ t) When Re(λ) ρ 0 Explicit methods for SDEs : Euler-Maruyama We consider an initial value problem dy = g(y)dt + β(y)dw, y(0) = y 0 Discretizing in time gives y n+ = y n + g(y n ) t + β(y n ) W The Brownian increments W have mean zero and variance The scheme then can be written as t y n+ = y n + g(y n ) t + β(y n ) tξ n, ξ n N(0, )

7 Consistency of the Euler-Maruyama method We will only state some results without proof. Order of consistency depends on how the error is defined. Strong convergence tells something about the expectation of the error y n y(t n ) = O( t /2 ) -... measures convergence of individual trajectories Weak convergence tells something about the error in expectations y n y(t n ) = O( t) -... measures convergence in a distribution sense Stability of the Euler-Maruyama method () As for consistency, stability can be defined in different ways. Consider a linear test equation dy = λy dt + µy dw Method is stable if solutions tends to 0 for t Mean-square stability lim y(t) 2 =0 t Asymptotic stability lim y(t) =0, a.s. t

8 Stability of the Euler-Maruyama method (2) Stability can crucially depend on the type of test equation considered. Consider for instance an Ornstein-Uhlenbeck process dy = λy dt + µdw, Re(λ) < 0 The previous definitions are useless here, since the process itself approximates a normal distribution for t. We define the numerical method to be stable if its solution also approaches a normal distribution for t. One can show that the Euler-Maruyama scheme for the SDE is stable for a given time step t, if and only if the forward Euler method is stable for the deterministic part. Euler-Maruyama for a two-scale test equation Consider a fast Ornstein-Uhlenbeck process dy = ydt+ 2 dw At the macroscopic level, equivalent to (see lecture 4) dµ dt = µ dσ dt = 2 Σ+2 µ = y Σ= (y µ) 2 It is easy to show that (exercise!) Euler-Maruyama gives us µ n+ = t µ n Σ n+ = 2 t + t2 2 Σ n

9 Euler-Maruyama may affect time-scale separation Effect of Euler-Maruyama on mean and variance µ n+ = t µ n As for the deterministic case, choosing behavior : t Σ n+ = 2 t + t2 2 Σ n + 2 t t = O() significantly affects the - : very quick relaxation to equilibrium distribution t 2 - : very slow (oscillatory) relaxation to equilibrium distribution Implicit Euler doesn t capture invariant distribution Consider a stochastic version of implicit Euler y n+ = y n + g(y n+ ) t + β(y n ) W Apply this method to the fast Ornstein-Uhlenbeck process dy = 2 ydt+ dw This gives + 2 t t y n+ = y n + ξn Then (do as an exercise! ) lim n yn =0 lim n (y n ) 2 = + t/(2)

10 Explicit methods for PDEs Method of lines semi-discretization + forward Euler Consider an advection-diffusion equation t u(x, t)+c x u(x, t) =D xx u(x, t) Discretize the spatial derivatives with finite differences du(x i,t) dt + c u(x i,t) u(x i,t) x Results in a coupled system of ODEs du dt = Au, A = tridiag Apply forward Euler to this system of ODEs u n+ =(I + A t)u n = D u(x i+,t) 2u(x i,t)+u(x i,t) x 2 c x + D x 2, c x 2 D x 2, D x 2 Stability of forward Euler for PDE discretization Consider the method-of-lines system, and define the spectrum of A du dt = Au, σ(a) ={λ i} N i= Forward Euler is stable if the stability criterion is satisfied for all eigenvalues +λ i t < For pure diffusion D>0,c=0, this leads to For pure advection D =0,c>0, this leads to t x2 2D t x c

11 Overview of the lecture Numerical methods for ODEs, SDEs, and PDEs Multiscale challenges Computational frameworks : - equation-free methods - heterogeneous multiscale methods Challenge for multiscale ODEs We have a multiscale ODE dx dt dy dt = f(x, y) = g(x, y) lim t ϕt ξ(y) =η(ξ) g(ξ,η(ξ)) = 0 Explicit methods have time-step limitation δt = O() We know that a macroscopic model exists when dx dt = F 0(X) =f(x, η(x)) 0 For this macroscopic model, we have t = O()

12 Challenge for multiscale SDEs We have a multiscale SDE dx = f(x, y)dt dy = g(x, y)dt + β(x, y)dw lim ρ ξ(y, t) =ρ ξ (y) t Implicit methods don t work; explicit methods have a time-step restriction We know that a macroscopic model exists when dx dt = F (X) = δt = O() For this macroscopic model, we have t = O() 0 f(x, y)dµ X (y) = f(x, y)ρ X (y)dy Challenge for PDE homogenization problems We have a PDE with heterogeneous coefficient t u (x, t) x A x x u (x, t)) = f(x) Explicit methods have a time-step restriction δt = O(δx 2 )=O( 2 ) We know that a macroscopic model exists for 0 t U(x, t) x Ā x U(x, t) = f(x) For this macroscopic model, we have t = O( x 2 )=O()

13 Challenge for kinetic equations We have a kinetic equation for the phase-space density t f (x, v, t)+ v xf (x, v, t) = f f 2 Explicit discretization has a time-step restriction δt = O( 2 ) We know that a macroscopic model exists when 0 ρ ρ : t ρ = D xx ρ For this macroscopic model, we have t = O( x 2 ) 25 Challenge for Monte Carlo simulation of SDEs This is a slightly different setting : we do not impose an infinite time-scale separation here. We have an SDE for behavior of an individual particle (here: FENE model) dx = ux 2ζ F (X) dt + σ 2 dw t, F(X) = ζ X X 2 /b Direct Monte Carlo simulation requires an ensemble of M particles, with time step δt. We assume an approximate macroscopic model exists in terms of some macroscopic state variables U i = f i (X) du dt = H(U, u) τ p = T (U)

14 Overview of the lecture Numerical methods for ODEs, SDEs, and PDEs Multiscale challenges Computational frameworks : - equation-free methods - heterogeneous multiscale methods Equation-free multiscale framework Generic strategy for the development of multiscale methods Coarse time-stepper as a building block for efficient algorithms Microscopic level model known simulation code available Macroscopic level only state variables corresponding evolution law unknown Simulatie Lifting Restrictie t* t* +!t Kevrekidis et al., / Kevrekidis & S, Annual Review on Physical Chemistry 60:32-344,

15 Coarse projective integration t* t* + "t t* +!t Extrapolate macroscopic state forward in time using an estimated time derivative Resembles a forward Euler method for just the macroscopic state variables 29 Related strategy: heterogeneous multiscale methods Postulate a general form for the unknown macroscopic equation Supplement this equation with an estimation of missing macroscopic quantities from a microscopic simulation - Initialization of the microscopic model from a given macroscopic state - Estimation of a macroscopic quantity from microscopic data This formulation has advantages from a numerical analysis viewpoint E, Engquist, Vanden-Eijnden, et al.,

16 Bifurcation analysis Consider a system that depends on a number of physical parameters dx dt = F (X; λ) Find asymptotic states (equilibria, periodic solutions,...) F (X; λ) =0 Solutions are located on branches (X(s),λ(s)) Multiple solutions possible for the same parameter value Stability can change along a branch 3 Equation-free bifurcation analysis U(t) U(t + τ) =Φ τ (U(t)) Time-stepper is a black box Compute directly macroscopic steady states and their stability U Φ τ (U )=0 Use iterative methods (like Newton-Krylov) Matrix-vector products Φ τ (Ū) DΦ τ Ū (Ū) v Φ τ (Ū + v) Ū + v 32

17 Goals for the remaining lectures The equation-free and heterogeneous multiscale frameworks provide a common algorithmic structure to design and analyze multiscale methods. For each concrete problem, specific methods can be constructed : - Lifting and restriction operators need to be developed - Accuracy, stability, efficiency need to be examined We will discuss numerical techniques for each of the model problems. We will also look into alternative techniques and relate them to the generic frameworks of this course. 33

1. Introduction Systems evolving on widely separated time-scales represent a challenge for numerical simulations. A generic example is

1. Introduction Systems evolving on widely separated time-scales represent a challenge for numerical simulations. A generic example is COMM. MATH. SCI. Vol. 1, No. 2, pp. 385 391 c 23 International Press FAST COMMUNICATIONS NUMERICAL TECHNIQUES FOR MULTI-SCALE DYNAMICAL SYSTEMS WITH STOCHASTIC EFFECTS ERIC VANDEN-EIJNDEN Abstract. Numerical

More information

Gillespie s Algorithm and its Approximations. Des Higham Department of Mathematics and Statistics University of Strathclyde

Gillespie s Algorithm and its Approximations. Des Higham Department of Mathematics and Statistics University of Strathclyde Gillespie s Algorithm and its Approximations Des Higham Department of Mathematics and Statistics University of Strathclyde djh@maths.strath.ac.uk The Three Lectures 1 Gillespie s algorithm and its relation

More information

A review of stability and dynamical behaviors of differential equations:

A review of stability and dynamical behaviors of differential equations: A review of stability and dynamical behaviors of differential equations: scalar ODE: u t = f(u), system of ODEs: u t = f(u, v), v t = g(u, v), reaction-diffusion equation: u t = D u + f(u), x Ω, with boundary

More information

Lecture 12: Detailed balance and Eigenfunction methods

Lecture 12: Detailed balance and Eigenfunction methods Lecture 12: Detailed balance and Eigenfunction methods Readings Recommended: Pavliotis [2014] 4.5-4.7 (eigenfunction methods and reversibility), 4.2-4.4 (explicit examples of eigenfunction methods) Gardiner

More information

Finite difference methods for the diffusion equation

Finite difference methods for the diffusion equation Finite difference methods for the diffusion equation D150, Tillämpade numeriska metoder II Olof Runborg May 0, 003 These notes summarize a part of the material in Chapter 13 of Iserles. They are based

More information

Lecture 12: Detailed balance and Eigenfunction methods

Lecture 12: Detailed balance and Eigenfunction methods Miranda Holmes-Cerfon Applied Stochastic Analysis, Spring 2015 Lecture 12: Detailed balance and Eigenfunction methods Readings Recommended: Pavliotis [2014] 4.5-4.7 (eigenfunction methods and reversibility),

More information

Introduction to asymptotic techniques for stochastic systems with multiple time-scales

Introduction to asymptotic techniques for stochastic systems with multiple time-scales Introduction to asymptotic techniques for stochastic systems with multiple time-scales Eric Vanden-Eijnden Courant Institute Motivating examples Consider the ODE {Ẋ = Y 3 + sin(πt) + cos( 2πt) X() = x

More information

Introduction to multiscale modeling and simulation. Almost every system is multiscale.

Introduction to multiscale modeling and simulation. Almost every system is multiscale. Introduction to multiscale modeling and simulation Giovanni Samaey, Scientific Computing Dept. of Computer Science, K.U.Leuven Lecture 1: Course introduction Almost every system is multiscale. We are interested

More information

Lecture No 1 Introduction to Diffusion equations The heat equat

Lecture No 1 Introduction to Diffusion equations The heat equat Lecture No 1 Introduction to Diffusion equations The heat equation Columbia University IAS summer program June, 2009 Outline of the lectures We will discuss some basic models of diffusion equations and

More information

Last time: Diffusion - Numerical scheme (FD) Heat equation is dissipative, so why not try Forward Euler:

Last time: Diffusion - Numerical scheme (FD) Heat equation is dissipative, so why not try Forward Euler: Lecture 7 18.086 Last time: Diffusion - Numerical scheme (FD) Heat equation is dissipative, so why not try Forward Euler: U j,n+1 t U j,n = U j+1,n 2U j,n + U j 1,n x 2 Expected accuracy: O(Δt) in time,

More information

PROBABILITY: LIMIT THEOREMS II, SPRING HOMEWORK PROBLEMS

PROBABILITY: LIMIT THEOREMS II, SPRING HOMEWORK PROBLEMS PROBABILITY: LIMIT THEOREMS II, SPRING 218. HOMEWORK PROBLEMS PROF. YURI BAKHTIN Instructions. You are allowed to work on solutions in groups, but you are required to write up solutions on your own. Please

More information

Homework 4 will be posted tonight, due Wednesday, May 8.

Homework 4 will be posted tonight, due Wednesday, May 8. Multiscale Computing and Escape Problems Friday, April 26, 2013 2:01 PM Homework 4 will be posted tonight, due Wednesday, May 8. Multiscale computation is a way to use the ideas of asymptotic reductions

More information

Lecture 1: Pragmatic Introduction to Stochastic Differential Equations

Lecture 1: Pragmatic Introduction to Stochastic Differential Equations Lecture 1: Pragmatic Introduction to Stochastic Differential Equations Simo Särkkä Aalto University, Finland (visiting at Oxford University, UK) November 13, 2013 Simo Särkkä (Aalto) Lecture 1: Pragmatic

More information

u n 2 4 u n 36 u n 1, n 1.

u n 2 4 u n 36 u n 1, n 1. Exercise 1 Let (u n ) be the sequence defined by Set v n = u n 1 x+ u n and f (x) = 4 x. 1. Solve the equations f (x) = 1 and f (x) =. u 0 = 0, n Z +, u n+1 = u n + 4 u n.. Prove that if u n < 1, then

More information

Numerical Analysis of Differential Equations Numerical Solution of Parabolic Equations

Numerical Analysis of Differential Equations Numerical Solution of Parabolic Equations Numerical Analysis of Differential Equations 215 6 Numerical Solution of Parabolic Equations 6 Numerical Solution of Parabolic Equations TU Bergakademie Freiberg, SS 2012 Numerical Analysis of Differential

More information

Controlled Diffusions and Hamilton-Jacobi Bellman Equations

Controlled Diffusions and Hamilton-Jacobi Bellman Equations Controlled Diffusions and Hamilton-Jacobi Bellman Equations Emo Todorov Applied Mathematics and Computer Science & Engineering University of Washington Winter 2014 Emo Todorov (UW) AMATH/CSE 579, Winter

More information

Week 9 Generators, duality, change of measure

Week 9 Generators, duality, change of measure Week 9 Generators, duality, change of measure Jonathan Goodman November 18, 013 1 Generators This section describes a common abstract way to describe many of the differential equations related to Markov

More information

The first order quasi-linear PDEs

The first order quasi-linear PDEs Chapter 2 The first order quasi-linear PDEs The first order quasi-linear PDEs have the following general form: F (x, u, Du) = 0, (2.1) where x = (x 1, x 2,, x 3 ) R n, u = u(x), Du is the gradient of u.

More information

Numerical Methods for ODEs. Lectures for PSU Summer Programs Xiantao Li

Numerical Methods for ODEs. Lectures for PSU Summer Programs Xiantao Li Numerical Methods for ODEs Lectures for PSU Summer Programs Xiantao Li Outline Introduction Some Challenges Numerical methods for ODEs Stiff ODEs Accuracy Constrained dynamics Stability Coarse-graining

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

Lecture 5: Single Step Methods

Lecture 5: Single Step Methods Lecture 5: Single Step Methods J.K. Ryan@tudelft.nl WI3097TU Delft Institute of Applied Mathematics Delft University of Technology 1 October 2012 () Single Step Methods 1 October 2012 1 / 44 Outline 1

More information

Logistic Map, Euler & Runge-Kutta Method and Lotka-Volterra Equations

Logistic Map, Euler & Runge-Kutta Method and Lotka-Volterra Equations Logistic Map, Euler & Runge-Kutta Method and Lotka-Volterra Equations S. Y. Ha and J. Park Department of Mathematical Sciences Seoul National University Sep 23, 2013 Contents 1 Logistic Map 2 Euler and

More information

Local vs. Nonlocal Diffusions A Tale of Two Laplacians

Local vs. Nonlocal Diffusions A Tale of Two Laplacians Local vs. Nonlocal Diffusions A Tale of Two Laplacians Jinqiao Duan Dept of Applied Mathematics Illinois Institute of Technology Chicago duan@iit.edu Outline 1 Einstein & Wiener: The Local diffusion 2

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

Mathematical Methods for Neurosciences. ENS - Master MVA Paris 6 - Master Maths-Bio ( )

Mathematical Methods for Neurosciences. ENS - Master MVA Paris 6 - Master Maths-Bio ( ) Mathematical Methods for Neurosciences. ENS - Master MVA Paris 6 - Master Maths-Bio (2014-2015) Etienne Tanré - Olivier Faugeras INRIA - Team Tosca November 26th, 2014 E. Tanré (INRIA - Team Tosca) Mathematical

More information

Finite Differences for Differential Equations 28 PART II. Finite Difference Methods for Differential Equations

Finite Differences for Differential Equations 28 PART II. Finite Difference Methods for Differential Equations Finite Differences for Differential Equations 28 PART II Finite Difference Methods for Differential Equations Finite Differences for Differential Equations 29 BOUNDARY VALUE PROBLEMS (I) Solving a TWO

More information

p 1 ( Y p dp) 1/p ( X p dp) 1 1 p

p 1 ( Y p dp) 1/p ( X p dp) 1 1 p Doob s inequality Let X(t) be a right continuous submartingale with respect to F(t), t 1 P(sup s t X(s) λ) 1 λ {sup s t X(s) λ} X + (t)dp 2 For 1 < p

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

Xt i Xs i N(0, σ 2 (t s)) and they are independent. This implies that the density function of X t X s is a product of normal density functions:

Xt i Xs i N(0, σ 2 (t s)) and they are independent. This implies that the density function of X t X s is a product of normal density functions: 174 BROWNIAN MOTION 8.4. Brownian motion in R d and the heat equation. The heat equation is a partial differential equation. We are going to convert it into a probabilistic equation by reversing time.

More information

Diffusion of a density in a static fluid

Diffusion of a density in a static fluid Diffusion of a density in a static fluid u(x, y, z, t), density (M/L 3 ) of a substance (dye). Diffusion: motion of particles from places where the density is higher to places where it is lower, due to

More information

Katholieke Universiteit Leuven Department of Computer Science

Katholieke Universiteit Leuven Department of Computer Science An analysis of equivalent operator preconditioning for equation-free Newton-Krylov methods Giovanni Samaey Wim Vanroose Report TW 537, March 29 Katholieke Universiteit Leuven Department of Computer Science

More information

PROBABILITY: LIMIT THEOREMS II, SPRING HOMEWORK PROBLEMS

PROBABILITY: LIMIT THEOREMS II, SPRING HOMEWORK PROBLEMS PROBABILITY: LIMIT THEOREMS II, SPRING 15. HOMEWORK PROBLEMS PROF. YURI BAKHTIN Instructions. You are allowed to work on solutions in groups, but you are required to write up solutions on your own. Please

More information

SPDEs, criticality, and renormalisation

SPDEs, criticality, and renormalisation SPDEs, criticality, and renormalisation Hendrik Weber Mathematics Institute University of Warwick Potsdam, 06.11.2013 An interesting model from Physics I Ising model Spin configurations: Energy: Inverse

More information

Qualitative behaviour of numerical methods for SDEs and application to homogenization

Qualitative behaviour of numerical methods for SDEs and application to homogenization Qualitative behaviour of numerical methods for SDEs and application to homogenization K. C. Zygalakis Oxford Centre For Collaborative Applied Mathematics, University of Oxford. Center for Nonlinear Analysis,

More information

Nonlinear stability of time-periodic viscous shocks. Margaret Beck Brown University

Nonlinear stability of time-periodic viscous shocks. Margaret Beck Brown University Nonlinear stability of time-periodic viscous shocks Margaret Beck Brown University Motivation Time-periodic patterns in reaction-diffusion systems: t x Experiment: chemical reaction chlorite-iodite-malonic-acid

More information

Stochastic Gradient Descent in Continuous Time

Stochastic Gradient Descent in Continuous Time Stochastic Gradient Descent in Continuous Time Justin Sirignano University of Illinois at Urbana Champaign with Konstantinos Spiliopoulos (Boston University) 1 / 27 We consider a diffusion X t X = R m

More information

2tdt 1 y = t2 + C y = which implies C = 1 and the solution is y = 1

2tdt 1 y = t2 + C y = which implies C = 1 and the solution is y = 1 Lectures - Week 11 General First Order ODEs & Numerical Methods for IVPs In general, nonlinear problems are much more difficult to solve than linear ones. Unfortunately many phenomena exhibit nonlinear

More information

Chapter 10 Exercises

Chapter 10 Exercises Chapter 10 Exercises From: Finite Difference Methods for Ordinary and Partial Differential Equations by R. J. LeVeque, SIAM, 2007. http://www.amath.washington.edu/ rl/fdmbook Exercise 10.1 (One-sided and

More information

Stochastic differential equation models in biology Susanne Ditlevsen

Stochastic differential equation models in biology Susanne Ditlevsen Stochastic differential equation models in biology Susanne Ditlevsen Introduction This chapter is concerned with continuous time processes, which are often modeled as a system of ordinary differential

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

Weak Convergence of Numerical Methods for Dynamical Systems and Optimal Control, and a relation with Large Deviations for Stochastic Equations

Weak Convergence of Numerical Methods for Dynamical Systems and Optimal Control, and a relation with Large Deviations for Stochastic Equations Weak Convergence of Numerical Methods for Dynamical Systems and, and a relation with Large Deviations for Stochastic Equations Mattias Sandberg KTH CSC 2010-10-21 Outline The error representation for weak

More information

Chapter 3 Second Order Linear Equations

Chapter 3 Second Order Linear Equations Partial Differential Equations (Math 3303) A Ë@ Õæ Aë áöß @. X. @ 2015-2014 ú GA JË@ É Ë@ Chapter 3 Second Order Linear Equations Second-order partial differential equations for an known function u(x,

More information

Adaptive timestepping for SDEs with non-globally Lipschitz drift

Adaptive timestepping for SDEs with non-globally Lipschitz drift Adaptive timestepping for SDEs with non-globally Lipschitz drift Mike Giles Wei Fang Mathematical Institute, University of Oxford Workshop on Numerical Schemes for SDEs and SPDEs Université Lille June

More information

Differential Equations

Differential Equations Differential Equations Overview of differential equation! Initial value problem! Explicit numeric methods! Implicit numeric methods! Modular implementation Physics-based simulation An algorithm that

More information

Numerical Integration of SDEs: A Short Tutorial

Numerical Integration of SDEs: A Short Tutorial Numerical Integration of SDEs: A Short Tutorial Thomas Schaffter January 19, 010 1 Introduction 1.1 Itô and Stratonovich SDEs 1-dimensional stochastic differentiable equation (SDE) is given by [6, 7] dx

More information

Path integrals for classical Markov processes

Path integrals for classical Markov processes Path integrals for classical Markov processes Hugo Touchette National Institute for Theoretical Physics (NITheP) Stellenbosch, South Africa Chris Engelbrecht Summer School on Non-Linear Phenomena in Field

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

Process Modelling. Table of Contents

Process Modelling. Table of Contents Process Modelling 1 Process Modelling prepared by Wm. J. Garland, Professor, Department of Engineering Physics, McMaster University, Hamilton, Ontario, Canada More about this document Summary: The general

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

The second-order 1D wave equation

The second-order 1D wave equation C The second-order D wave equation C. Homogeneous wave equation with constant speed The simplest form of the second-order wave equation is given by: x 2 = Like the first-order wave equation, it responds

More information

Additional Homework Problems

Additional Homework Problems Additional Homework Problems These problems supplement the ones assigned from the text. Use complete sentences whenever appropriate. Use mathematical terms appropriately. 1. What is the order of a differential

More information

B8.3 Mathematical Models for Financial Derivatives. Hilary Term Solution Sheet 2

B8.3 Mathematical Models for Financial Derivatives. Hilary Term Solution Sheet 2 B8.3 Mathematical Models for Financial Derivatives Hilary Term 18 Solution Sheet In the following W t ) t denotes a standard Brownian motion and t > denotes time. A partition π of the interval, t is a

More information

Numerical Solutions to Partial Differential Equations

Numerical Solutions to Partial Differential Equations Numerical Solutions to Partial Differential Equations Zhiping Li LMAM and School of Mathematical Sciences Peking University The Implicit Schemes for the Model Problem The Crank-Nicolson scheme and θ-scheme

More information

x R d, λ R, f smooth enough. Goal: compute ( follow ) equilibrium solutions as λ varies, i.e. compute solutions (x, λ) to 0 = f(x, λ).

x R d, λ R, f smooth enough. Goal: compute ( follow ) equilibrium solutions as λ varies, i.e. compute solutions (x, λ) to 0 = f(x, λ). Continuation of equilibria Problem Parameter-dependent ODE ẋ = f(x, λ), x R d, λ R, f smooth enough. Goal: compute ( follow ) equilibrium solutions as λ varies, i.e. compute solutions (x, λ) to 0 = f(x,

More information

MATH 220 solution to homework 5

MATH 220 solution to homework 5 MATH 220 solution to homework 5 Problem. (i Define E(t = k(t + p(t = then E (t = 2 = 2 = 2 u t u tt + u x u xt dx u 2 t + u 2 x dx, u t u xx + u x u xt dx x [u tu x ] dx. Because f and g are compactly

More information

Lecture 1. Finite difference and finite element methods. Partial differential equations (PDEs) Solving the heat equation numerically

Lecture 1. Finite difference and finite element methods. Partial differential equations (PDEs) Solving the heat equation numerically Finite difference and finite element methods Lecture 1 Scope of the course Analysis and implementation of numerical methods for pricing options. Models: Black-Scholes, stochastic volatility, exponential

More information

CHAPTER 5: Linear Multistep Methods

CHAPTER 5: Linear Multistep Methods CHAPTER 5: Linear Multistep Methods Multistep: use information from many steps Higher order possible with fewer function evaluations than with RK. Convenient error estimates. Changing stepsize or order

More information

Numerical explorations of a forward-backward diffusion equation

Numerical explorations of a forward-backward diffusion equation Numerical explorations of a forward-backward diffusion equation Newton Institute KIT Programme Pauline Lafitte 1 C. Mascia 2 1 SIMPAF - INRIA & U. Lille 1, France 2 Univ. La Sapienza, Roma, Italy September

More information

Random attractors and the preservation of synchronization in the presence of noise

Random attractors and the preservation of synchronization in the presence of noise Random attractors and the preservation of synchronization in the presence of noise Peter Kloeden Institut für Mathematik Johann Wolfgang Goethe Universität Frankfurt am Main Deterministic case Consider

More information

Introduction LECTURE 1

Introduction LECTURE 1 LECTURE 1 Introduction The source of all great mathematics is the special case, the concrete example. It is frequent in mathematics that every instance of a concept of seemingly great generality is in

More information

Introduction to Partial Differential Equation - I. Quick overview

Introduction to Partial Differential Equation - I. Quick overview Introduction to Partial Differential Equation - I. Quick overview To help explain the correspondence between a PDE and a real world phenomenon, we will use t to denote time and (x, y, z) to denote the

More information

Chapter 18. Remarks on partial differential equations

Chapter 18. Remarks on partial differential equations Chapter 8. Remarks on partial differential equations If we try to analyze heat flow or vibration in a continuous system such as a building or an airplane, we arrive at a kind of infinite system of ordinary

More information

MATH3203 Lecture 1 Mathematical Modelling and ODEs

MATH3203 Lecture 1 Mathematical Modelling and ODEs MATH3203 Lecture 1 Mathematical Modelling and ODEs Dion Weatherley Earth Systems Science Computational Centre, University of Queensland February 27, 2006 Abstract Contents 1 Mathematical Modelling 2 1.1

More information

Consistency and Convergence

Consistency and Convergence Jim Lambers MAT 77 Fall Semester 010-11 Lecture 0 Notes These notes correspond to Sections 1.3, 1.4 and 1.5 in the text. Consistency and Convergence We have learned that the numerical solution obtained

More information

Chapter 3. Finite Difference Methods for Hyperbolic Equations Introduction Linear convection 1-D wave equation

Chapter 3. Finite Difference Methods for Hyperbolic Equations Introduction Linear convection 1-D wave equation Chapter 3. Finite Difference Methods for Hyperbolic Equations 3.1. Introduction Most hyperbolic problems involve the transport of fluid properties. In the equations of motion, the term describing the transport

More information

4 Stability analysis of finite-difference methods for ODEs

4 Stability analysis of finite-difference methods for ODEs MATH 337, by T. Lakoba, University of Vermont 36 4 Stability analysis of finite-difference methods for ODEs 4.1 Consistency, stability, and convergence of a numerical method; Main Theorem In this Lecture

More information

x n+1 = x n f(x n) f (x n ), n 0.

x n+1 = x n f(x n) f (x n ), n 0. 1. Nonlinear Equations Given scalar equation, f(x) = 0, (a) Describe I) Newtons Method, II) Secant Method for approximating the solution. (b) State sufficient conditions for Newton and Secant to converge.

More information

Interest Rate Models:

Interest Rate Models: 1/17 Interest Rate Models: from Parametric Statistics to Infinite Dimensional Stochastic Analysis René Carmona Bendheim Center for Finance ORFE & PACM, Princeton University email: rcarmna@princeton.edu

More information

Boundary conditions. Diffusion 2: Boundary conditions, long time behavior

Boundary conditions. Diffusion 2: Boundary conditions, long time behavior Boundary conditions In a domain Ω one has to add boundary conditions to the heat (or diffusion) equation: 1. u(x, t) = φ for x Ω. Temperature given at the boundary. Also density given at the boundary.

More information

Problem set 7 Math 207A, Fall 2011 Solutions

Problem set 7 Math 207A, Fall 2011 Solutions Problem set 7 Math 207A, Fall 2011 s 1. Classify the equilibrium (x, y) = (0, 0) of the system x t = x, y t = y + x 2. Is the equilibrium hyperbolic? Find an equation for the trajectories in (x, y)- phase

More information

BENG 221 Mathematical Methods in Bioengineering. Fall 2017 Midterm

BENG 221 Mathematical Methods in Bioengineering. Fall 2017 Midterm BENG Mathematical Methods in Bioengineering Fall 07 Midterm NAME: Open book, open notes. 80 minutes limit (end of class). No communication other than with instructor and TAs. No computers or internet,

More information

Modelling Interactions Between Weather and Climate

Modelling Interactions Between Weather and Climate Modelling Interactions Between Weather and Climate p. 1/33 Modelling Interactions Between Weather and Climate Adam Monahan & Joel Culina monahana@uvic.ca & culinaj@uvic.ca School of Earth and Ocean Sciences,

More information

TMS165/MSA350 Stochastic Calculus, Lecture on Applications

TMS165/MSA350 Stochastic Calculus, Lecture on Applications TMS165/MSA35 Stochastic Calculus, Lecture on Applications In this lecture we demonstrate how statistical methods such as the maximum likelihood method likelihood ratio estimation can be applied to the

More information

Lecture 10: Singular Perturbations and Averaging 1

Lecture 10: Singular Perturbations and Averaging 1 Massachusetts Institute of Technology Department of Electrical Engineering and Computer Science 6.243j (Fall 2003): DYNAMICS OF NONLINEAR SYSTEMS by A. Megretski Lecture 10: Singular Perturbations and

More information

DUBLIN CITY UNIVERSITY

DUBLIN CITY UNIVERSITY DUBLIN CITY UNIVERSITY SAMPLE EXAMINATIONS 2017/2018 MODULE: QUALIFICATIONS: Simulation for Finance MS455 B.Sc. Actuarial Mathematics ACM B.Sc. Financial Mathematics FIM YEAR OF STUDY: 4 EXAMINERS: Mr

More information

MATH 131P: PRACTICE FINAL SOLUTIONS DECEMBER 12, 2012

MATH 131P: PRACTICE FINAL SOLUTIONS DECEMBER 12, 2012 MATH 3P: PRACTICE FINAL SOLUTIONS DECEMBER, This is a closed ook, closed notes, no calculators/computers exam. There are 6 prolems. Write your solutions to Prolems -3 in lue ook #, and your solutions to

More information

Stochastic differential equations in neuroscience

Stochastic differential equations in neuroscience Stochastic differential equations in neuroscience Nils Berglund MAPMO, Orléans (CNRS, UMR 6628) http://www.univ-orleans.fr/mapmo/membres/berglund/ Barbara Gentz, Universität Bielefeld Damien Landon, MAPMO-Orléans

More information

Computing on Virtual Slow Manifolds of Fast Stochastic Systems.

Computing on Virtual Slow Manifolds of Fast Stochastic Systems. European Society of Computational Methods in Sciences and Engineering (ESCMSE) Journal of Numerical Analysis, Industrial and Applied Mathematics (JNAIAM) vol. 1, no. 1, nnnn, pp. 1-3 ISSN 179 814 Computing

More information

Models and Simulation

Models and Simulation Models and Simulation Lecture notes, WISB34 Modellen & Simulatie January 2, 26 jason frank Mathematical Insitute, Utrecht University Contents Introduction to models and modelling 6. An iterated map..........................................

More information

Ordinary Differential Equation Theory

Ordinary Differential Equation Theory Part I Ordinary Differential Equation Theory 1 Introductory Theory An n th order ODE for y = y(t) has the form Usually it can be written F (t, y, y,.., y (n) ) = y (n) = f(t, y, y,.., y (n 1) ) (Implicit

More information

Ordinary Differential Equations: Initial Value problems (IVP)

Ordinary Differential Equations: Initial Value problems (IVP) Chapter Ordinary Differential Equations: Initial Value problems (IVP) Many engineering applications can be modeled as differential equations (DE) In this book, our emphasis is about how to use computer

More information

Lecture 4: Numerical Solution of SDEs, Itô Taylor Series, Gaussian Process Approximations

Lecture 4: Numerical Solution of SDEs, Itô Taylor Series, Gaussian Process Approximations Lecture 4: Numerical Solution of SDEs, Itô Taylor Series, Gaussian Process Approximations Simo Särkkä Aalto University Tampere University of Technology Lappeenranta University of Technology Finland November

More information

10.34: Numerical Methods Applied to Chemical Engineering. Lecture 19: Differential Algebraic Equations

10.34: Numerical Methods Applied to Chemical Engineering. Lecture 19: Differential Algebraic Equations 10.34: Numerical Methods Applied to Chemical Engineering Lecture 19: Differential Algebraic Equations 1 Recap Differential algebraic equations Semi-explicit Fully implicit Simulation via backward difference

More information

9 More on the 1D Heat Equation

9 More on the 1D Heat Equation 9 More on the D Heat Equation 9. Heat equation on the line with sources: Duhamel s principle Theorem: Consider the Cauchy problem = D 2 u + F (x, t), on x t x 2 u(x, ) = f(x) for x < () where f

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

DYNAMICAL SYSTEMS

DYNAMICAL SYSTEMS 0.42 DYNAMICAL SYSTEMS Week Lecture Notes. What is a dynamical system? Probably the best way to begin this discussion is with arguably a most general and yet least helpful statement: Definition. A dynamical

More information

Numerical methods in molecular dynamics and multiscale problems

Numerical methods in molecular dynamics and multiscale problems Numerical methods in molecular dynamics and multiscale problems Two examples T. Lelièvre CERMICS - Ecole des Ponts ParisTech & MicMac project-team - INRIA Horizon Maths December 2012 Introduction The aim

More information

Applied Mathematics Masters Examination Fall 2016, August 18, 1 4 pm.

Applied Mathematics Masters Examination Fall 2016, August 18, 1 4 pm. Applied Mathematics Masters Examination Fall 16, August 18, 1 4 pm. Each of the fifteen numbered questions is worth points. All questions will be graded, but your score for the examination will be the

More information

Practice Problems For Test 3

Practice Problems For Test 3 Practice Problems For Test 3 Power Series Preliminary Material. Find the interval of convergence of the following. Be sure to determine the convergence at the endpoints. (a) ( ) k (x ) k (x 3) k= k (b)

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

LECTURE 19: SEPARATION OF VARIABLES, HEAT CONDUCTION IN A ROD

LECTURE 19: SEPARATION OF VARIABLES, HEAT CONDUCTION IN A ROD ECTURE 19: SEPARATION OF VARIABES, HEAT CONDUCTION IN A ROD The idea of separation of variables is simple: in order to solve a partial differential equation in u(x, t), we ask, is it possible to find a

More information

Uncertainty quantification and systemic risk

Uncertainty quantification and systemic risk Uncertainty quantification and systemic risk Josselin Garnier (Université Paris Diderot) with George Papanicolaou and Tzu-Wei Yang (Stanford University) February 3, 2016 Modeling systemic risk We consider

More information

APPLICATIONS OF FD APPROXIMATIONS FOR SOLVING ORDINARY DIFFERENTIAL EQUATIONS

APPLICATIONS OF FD APPROXIMATIONS FOR SOLVING ORDINARY DIFFERENTIAL EQUATIONS LECTURE 10 APPLICATIONS OF FD APPROXIMATIONS FOR SOLVING ORDINARY DIFFERENTIAL EQUATIONS Ordinary Differential Equations Initial Value Problems For Initial Value problems (IVP s), conditions are specified

More information

Fast-slow systems with chaotic noise

Fast-slow systems with chaotic noise Fast-slow systems with chaotic noise David Kelly Ian Melbourne Courant Institute New York University New York NY www.dtbkelly.com May 12, 215 Averaging and homogenization workshop, Luminy. Fast-slow systems

More information

Stochastic Mode Reduction in Large Deterministic Systems

Stochastic Mode Reduction in Large Deterministic Systems Stochastic Mode Reduction in Large Deterministic Systems I. Timofeyev University of Houston With A. J. Majda and E. Vanden-Eijnden; NYU Related Publications: http://www.math.uh.edu/ ilya Plan Mode-Elimination

More information

A Lévy-Fokker-Planck equation: entropies and convergence to equilibrium

A Lévy-Fokker-Planck equation: entropies and convergence to equilibrium 1/ 22 A Lévy-Fokker-Planck equation: entropies and convergence to equilibrium I. Gentil CEREMADE, Université Paris-Dauphine International Conference on stochastic Analysis and Applications Hammamet, Tunisia,

More information

Lecture 19: Heat conduction with distributed sources/sinks

Lecture 19: Heat conduction with distributed sources/sinks Introductory lecture notes on Partial Differential Equations - c Anthony Peirce. Not to be copied, used, or revised without explicit written permission from the copyright owner. 1 ecture 19: Heat conduction

More information

5 Applying the Fokker-Planck equation

5 Applying the Fokker-Planck equation 5 Applying the Fokker-Planck equation We begin with one-dimensional examples, keeping g = constant. Recall: the FPE for the Langevin equation with η(t 1 )η(t ) = κδ(t 1 t ) is = f(x) + g(x)η(t) t = x [f(x)p

More information

Approximation of random dynamical systems with discrete time by stochastic differential equations: I. Theory

Approximation of random dynamical systems with discrete time by stochastic differential equations: I. Theory Random Operators / Stochastic Eqs. 15 7, 5 c de Gruyter 7 DOI 1.1515 / ROSE.7.13 Approximation of random dynamical systems with discrete time by stochastic differential equations: I. Theory Yuri A. Godin

More information

A brief introduction to ordinary differential equations

A brief introduction to ordinary differential equations Chapter 1 A brief introduction to ordinary differential equations 1.1 Introduction An ordinary differential equation (ode) is an equation that relates a function of one variable, y(t), with its derivative(s)

More information