Multilevel Monte Carlo for Stochastic McKean-Vlasov Equations

Size: px
Start display at page:

Download "Multilevel Monte Carlo for Stochastic McKean-Vlasov Equations"

Transcription

1 Multilevel Monte Carlo for Stochastic McKean-Vlasov Equations Lukasz Szpruch School of Mathemtics University of Edinburgh joint work with Shuren Tan and Alvin Tse (Edinburgh) Lukasz Szpruch (University of Edinburgh) MLMC for MV-SDEs March / 23

2 MKV-SDEs Mckean-Vlasov SDEs on [0, T ], of the form { dx t = R d b(x t, y)µ t (dy)dt + R d σ(x t, y)µ t (dy)dw t, µ t = Law(X t), X 0 R d b C 2,1 b (R d R d, R d ) and σ C 2,1 b (R d R d, R d r ) = For all x 1, x 2, y 1, y 2 R d, there exists a constant L such that b(x 1, y 1 ) b(x 2, y 2 ) + σ(x 1, y 1 ) σ(x 2, y 2 ) L( x 1 x 2 + y 1 y 2 ), = (can be relaxed) b(x 1, y 1) + σ(x 1, y 1) L(1 + x 1 + y 1 ) sup b(x 1, y 1) + sup σ(x 2, y 2) K < (x 1,y 1 ) R d R d (x 2,y 2 ) R d R d The initial law µ 0 satisfies: µ 0 is a Dirac measure at X 0, or p 2, R d x p µ 0 (dx) < Lukasz Szpruch (University of Edinburgh) MLMC for MV-SDEs March / 23

3 Motivation MKV-SDEs gives probabilistic interpretation of nonlinear McKean-Vlasov PDEs which weak formulation with f ( ) CK (R d ) is given { t t, f = µ t, 1 d 2 i,j=1 a ij(x, µ t ) 2 f x i x j (x) + d i=1 b i(x, µ t ) f x i (x), µ 0 = P X 1 0 = Law(X 0 ), where a(x, µ t ) = σ(x t, µ t ) T σ(x t, µ t ) and b(x, µ t ) := R d b(x, y)µ t (dy) Example: dy t = R d b(y t, y)µ t (dy)dt + dw t Applications: Lagrangian models (Bossy,Jabir,Talay, 2011) Navier-Stokes equation for the vorticity of a two-dimensional incompressible fluid flow and many more (Bossy,Jourdain,Meleard,Reygner,Talay) Mean-Field Games (Lasry, Lions, 2007, Chassagneux, Crisan, Delarue, 2015) Stochastic Local Volatility Models (Gyongy, 1996; Guyon, Henry-Labordere 2011; Guyon 2014,2015; Jourdain,Zhou 2016) Lukasz Szpruch (University of Edinburgh) MLMC for MV-SDEs March / 23

4 Propagation of chaos Stochastic interacting particles (X i,n t ) are solutions to (R d ) N dimensional SDEs { dx i,n t = b(x i,n t µ N t := 1 N N i=1 δ X i,n t, µ N t )dt + σ(x i,n t, t 0,, µ N t )dw i t, i = 1,, N, where {X i,n 0 } i=1,,n are iid samples with the law µ 0 and {W i t } i=1,,n are independent Brownian motions X i,n t X i t when N Lukasz Szpruch (University of Edinburgh) MLMC for MV-SDEs March / 23

5 Time discretization - Euler Scheme Consider MV-SDEs dx t = b(x t, y)µ t(dy)dt + σ(x t, y)µ t(dy)dw t, R d R d Euler scheme with time-step h = T /M, i=1,,n, Y i,n k+1 = Y i,n k + 1 N N j=1 b(y i,n k, Y j,n k )h + 1 N N j=1 σ(y i,n k, Y j,n k ) Wk+1 i Due to the particle interactions, its implementation requires N 2 arithmetic operations at each step Euler scheme converges with weak rate of order (( N) 1 + h) Bossy, Talay (1997) Antonelli, Kohatsu-Higa (2002), Bossy, Jourdain (2002) Notice that the same sample is used to approximate MV-SDEs and to evaluate the E[G(X T )] Lukasz Szpruch (University of Edinburgh) MLMC for MV-SDEs March / 23

6 Computational cost of the propagation of chaos Consider mean-square-error [( E E[f (X T )] 1 N bias and statistical error are in a nonlinear relationship Consider iid samples Lukasz Szpruch (University of Edinburgh) MLMC for MV-SDEs March / 23 n i=1 f (Y i,n T ) ) 2 ] X k+1 = X k + b( X k, P kh )h + σ( X k, P kh ) W k+1, P kh = P ( X k ) 1 Error decomposition E[f (X T )] 1 N N i=1 f (Y i,n T ) = ( E[f (X T )] E[f ( X T )] ) + ( E[f ( X T )] 1 N + 1 N N i=1 N f (( X T i ) ) i=1 ( f (( X i T ) f (Y i,n T ))

7 Cost Typical mean-square error ( E E[f (X T )] 1 N ) 2 N f (Y i,n T ) C(h N + 1 N ), i=1 Cost C γ = N γ h 1, γ = 1 no-interacting Kernel, γ = 2 interacting Kernel For the root-mean-square-error ϵ the cost is C 1 = O(ϵ 3 ) or C 2 = O(ϵ 5 ) Example of the non-interacting kernel particle system: Y i,n k+1 = Y i,n k + b(y i,n k, 1 N N j=1 f (Y j,n k ))h + σ Wk+1 i Lukasz Szpruch (University of Edinburgh) MLMC for MV-SDEs March / 23

8 MLMC for standard SDEs Idea of Giles (2006), Heinrich (2001) was to explore the identity E[P L ] = E[P 0 ] + L E[P l P l 1 ], where P l := P(Y M l ) with P : C([0, T ], R d ) R and {Y M l }, l = 0 L, being discrete time approximation of process X with M l number of time steps l=1 This identity leads to an unbiased estimator of E[P(Y M L )], { N 0 N 1 L P (i,0) 1 l 0 + N 0 i=1 l=1 N l Lukasz Szpruch (University of Edinburgh) MLMC for MV-SDEs March / 23 i=1 (P (i,l) l } P (i,l) l 1 ), where P (i,l) l = P((Y M l ) (i) ) are independent samples at level l But for MLMC variance for particle systems, typically decays as O(N 1 + h) In the case of particle systems, one need to be careful to ensure telescopic sum is preserved

9 Sznitman s iteration proof { Xt = X 0 + W t + t b(x 0 C s, y)µ t (dy)ds, µ t = Law(X t ) 0 t T Step 1: Pick a measure µ P(C[0, T ], R d ) Step 2: Define an operator Φ : P(C[0, T ], R d ) P(C[0, T ], R d ); Φ(µ) = Law(X µ ) t X µ t = X 0 + W t + b(x s µ, y)µ t(dy)ds, 0 t T Iterate Theorem (Sznitman) Let T > 0, and µ P 2 (C[0, T ], R d )) There exists C > 0 st [ W 2 (µ, ν) = inf γ C C 0 C W 2(Φ k+1 (µ), Φ k (µ)) C T k W2(Φ(µ), µ) k! ] u v 2 γ(du, dv); γ( C) = µ, γ(c ) = ν Lukasz Szpruch (University of Edinburgh) MLMC for MV-SDEs March / 23

10 Picard s Particle system Consider a sequence of SDEs linear (in a sense of McKean) defined as dxt m = b(xt m, y)µ m 1 t (dy)dt + σ(xt m, y)µ m 1 t (dy)dwt m, Law(X0 m ) = Law(X 0 ), C C where µ m 1 t = Law(Xt m 1 ) Let (Y 0,n,N 0 t ) 1 n N0 be an iid sample with law µ 0 For m 1, we define Key idea: dy m,n,n m t = 1 N m 1 N m 1 j=1 + 1 N m 1 N m 1 j=1 b(y m,n,n m t σ(y m,n,nm t, Y m 1,j,N m 1 t ) dt Use 1 : m 1 steps to approximate R d b(x µ s, y)µ t(dy), Y m 1,j,N m 1 t ) dw m,n t Use the final m Picard step to approximate the quantity of interest Iterated Particle system is less efficient then original Particle system! Lukasz Szpruch (University of Edinburgh) MLMC for MV-SDEs March / 23

11 Iterative Particle System Consider a sequence of SDEs linear (in a sense of McKean) defined as dxt m =, y)µ m 1 t (dy)dt + b(xt m R d σ(xt m R d where µ t m 1 = Law(Xt m 1 ) and W m and X0 m are independent Iterative particle system Y i,m,l k+1 = Y i,m,l k + [M t l k ( µ m 1 Y No-interacting Kernels are much easier to analyse, y)µ m 1 t (dy)dwt m, Law(X0 m ) = Law(X 0), )](b(y i,m,l, ))h l + [M t l( µ m 1 k Y )](σ(y i,m,l, )) W i,m,l k+1 Lukasz Szpruch (University of Edinburgh) MLMC for MV-SDEs March / 23

12 Iterative Particle System For any borel function G = (G (1),, G (d) ), where G (i) : R d R d R, we define [M t(µ)](g(x, )) := L l=0 where µ l t (G(x, )) = R d G(x, y)µ l t (dy) [ µ l t := ( ) µ l t µ t l 1 (G(x, )), µ P 2, [ t η l (t) h l ]µ l η l (t)+h l + 1 t η l (t) h l ]µ l η l (t), t / Π l, 1 Nl,m N l,m i=1 δ Yt i,m,l, t Π l Lukasz Szpruch (University of Edinburgh) MLMC for MV-SDEs March / 23

13 Further assumptions Define B(t, x) = E[b(x, X t )] and Σ(t, x) = E[σ(x, X t )] ( B(, ) C 1,2 and Σ(, ) C 1,2 ) Consider stochastic flow ( X s,x t, t [s, T ] ) We consider X s,x t = x + t s B ( θ, X s,x θ ) dθ + t s Σ ( θ, X s,x ) θ dwθ, t [s, T ] v y (s, x) := E[G(y, X s,x t )], y R d and (s, x) [0, t] R d, and associated (family of) PDEs reads d v y s (s, x) i,j=1 v y (t, x) = G(y, x), A ij (s, x) 2 v y x i x j (s, x) + where A = Σ(s, x)σ(s, x) T We have d j=1 B j (s, x) vy x j (s, x) = 0, (s, x) [0, t] R d sup v y y R d x (t, x ) L v and sup 2 v y y R d x (t, x ) 2 L v (t, x ) [0, T ] R d Lukasz Szpruch (University of Edinburgh) MLMC for MV-SDEs March / 23

14 Main Result Theorem Assume regularity of the coefficients and the initial law Then ] [([M ηl(t)(µ MY )](G(x, )) E[G(x, X ηl(t))]) 2 sup x R d sup E 0 t T c { h 2 L + M m=1 c M m (M m)! L l=0 } h l + cm, N m,l M! We can reduce computational cost of approximating expectation by the order of magnitude Lukasz Szpruch (University of Edinburgh) MLMC for MV-SDEs March / 23

15 Glimpse into the analysis SDEs with random coefficients du t = B(U t, V ηl (t))dt + Σ(U t, V ηl (t))dw t, Law(U 0) = Law(X 0), where V ηl (t) P(R d ) is random measure Euler scheme is given dzt l = B(Z η(t), l V η(t) )dt + Σ(Z η(t), l V η(t) )dw t, Law(Z0 l ) = Law(X 0 ), (Conditional) Independence: The random measure V is independent of W and Z 0 Integrability: Let G be Lipschitz continuous, then sup sup E[ G(x, y)) p V s(dy)] c p 1 0 s T R d x R d Regularity: Let G be Lipschitz continuous, then sup sup E[ G(x, y)(v t V s )(dy) 2 ] c(t s) x R d 0 s t T R d Lukasz Szpruch (University of Edinburgh) MLMC for MV-SDEs March / 23

16 Glimpse into the analysis Theorem Assume regularity of the coefficients and the initial law There exists a constant c such that Theorem sup sup E V Z l η L (t)(g(x, )) V Z l 1 η L (t) (G(x, )) 2 ch l x R d 0 t T Assume regularity of the coefficients and the initial law Then there exists a constant c such that t [0, T ], sup x R d sup E[G(x, Zs L )] E[G(x, X s )] 0 s t ( t c h L + 0 sup E B(x, V ηl (s)) E[b(x, X ηl (s))] ds x R d + t 0 sup E Σ(x, V ηl (s)) E[σ(x, X ηl (s))] ds x R d ) Lukasz Szpruch (University of Edinburgh) MLMC for MV-SDEs March / 23

17 New idea The idea is to use previous Iteration as Control Variates ie E[G(x, X M )] = E[G(x, X 0 )] + M m=1 E[G(x, X m ) G(x, X m 1 )] Coupling is obtained by simulating both iterations with the same BM Inner expected value can be further expanded into a telescopic sum First numerical examples are very promising Lukasz Szpruch (University of Edinburgh) MLMC for MV-SDEs March / 23

18 Numerical Experiment: Non-interacting kernel The target stochastic differential equation is dx t = sin(x t E[X t ])dt + σdw t, X 0 = 0 The testing payoff function is P(x) = max(x K, 0), where strike K is set to 01 Lukasz Szpruch (University of Edinburgh) MLMC for MV-SDEs March / 23

19 Non-interacting kernel Epsilon level (ǫ) Computation cost particle system revised MC+picard MC+picard Lukasz Szpruch (University of Edinburgh) MLMC for MV-SDEs March / 23

20 Non-interacting case MLMC with ǫ 1 >ǫ 2 >+ picard MLMC + picard particle systems 25 2 Computational cost Epsilon level (ǫ) Lukasz Szpruch (University of Edinburgh) MLMC for MV-SDEs March / 23

21 Interacting kernel The target stochastic differential equation is dx t = E[sin(x X t)] x=xt dt + σdw t, X 0 = 0, where Y t is an independent copy of X t The payoff P(x) = 1 + x 2 Lukasz Szpruch (University of Edinburgh) MLMC for MV-SDEs March / 23

22 Interacting kernel particle system revised MC+picard MC+picard MLMC+picard 2 Computational cost Epsilon level (ǫ) Lukasz Szpruch (University of Edinburgh) MLMC for MV-SDEs March / 23

23 Interacting kernel MLMC with ǫ 1 >ǫ 2 >+ picard MLMC + picard particle systems 4 35 Computational cost Epsilon level (ǫ) Lukasz Szpruch (University of Edinburgh) MLMC for MV-SDEs March / 23

Weak solutions of mean-field stochastic differential equations

Weak solutions of mean-field stochastic differential equations Weak solutions of mean-field stochastic differential equations Juan Li School of Mathematics and Statistics, Shandong University (Weihai), Weihai 26429, China. Email: juanli@sdu.edu.cn Based on joint works

More information

On a class of stochastic differential equations in a financial network model

On a class of stochastic differential equations in a financial network model 1 On a class of stochastic differential equations in a financial network model Tomoyuki Ichiba Department of Statistics & Applied Probability, Center for Financial Mathematics and Actuarial Research, University

More information

Multilevel Monte Carlo for Lévy Driven SDEs

Multilevel Monte Carlo for Lévy Driven SDEs Multilevel Monte Carlo for Lévy Driven SDEs Felix Heidenreich TU Kaiserslautern AG Computational Stochastics August 2011 joint work with Steffen Dereich Philipps-Universität Marburg supported within DFG-SPP

More information

Nonlinear representation, backward SDEs, and application to the Principal-Agent problem

Nonlinear representation, backward SDEs, and application to the Principal-Agent problem Nonlinear representation, backward SDEs, and application to the Principal-Agent problem Ecole Polytechnique, France April 4, 218 Outline The Principal-Agent problem Formulation 1 The Principal-Agent problem

More information

On continuous time contract theory

On continuous time contract theory Ecole Polytechnique, France Journée de rentrée du CMAP, 3 octobre, 218 Outline 1 2 Semimartingale measures on the canonical space Random horizon 2nd order backward SDEs (Static) Principal-Agent Problem

More information

Mean-Field optimization problems and non-anticipative optimal transport. Beatrice Acciaio

Mean-Field optimization problems and non-anticipative optimal transport. Beatrice Acciaio Mean-Field optimization problems and non-anticipative optimal transport Beatrice Acciaio London School of Economics based on ongoing projects with J. Backhoff, R. Carmona and P. Wang Robust Methods in

More information

A stochastic particle system for the Burgers equation.

A stochastic particle system for the Burgers equation. A stochastic particle system for the Burgers equation. Alexei Novikov Department of Mathematics Penn State University with Gautam Iyer (Carnegie Mellon) supported by NSF Burgers equation t u t + u x u

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

Stochastic Differential Equations.

Stochastic Differential Equations. Chapter 3 Stochastic Differential Equations. 3.1 Existence and Uniqueness. One of the ways of constructing a Diffusion process is to solve the stochastic differential equation dx(t) = σ(t, x(t)) dβ(t)

More information

Introduction to numerical simulations for Stochastic ODEs

Introduction to numerical simulations for Stochastic ODEs Introduction to numerical simulations for Stochastic ODEs Xingye Kan Illinois Institute of Technology Department of Applied Mathematics Chicago, IL 60616 August 9, 2010 Outline 1 Preliminaries 2 Numerical

More information

The concentration of a drug in blood. Exponential decay. Different realizations. Exponential decay with noise. dc(t) dt.

The concentration of a drug in blood. Exponential decay. Different realizations. Exponential decay with noise. dc(t) dt. The concentration of a drug in blood Exponential decay C12 concentration 2 4 6 8 1 C12 concentration 2 4 6 8 1 dc(t) dt = µc(t) C(t) = C()e µt 2 4 6 8 1 12 time in minutes 2 4 6 8 1 12 time in minutes

More information

Lecture 12: Diffusion Processes and Stochastic Differential Equations

Lecture 12: Diffusion Processes and Stochastic Differential Equations Lecture 12: Diffusion Processes and Stochastic Differential Equations 1. Diffusion Processes 1.1 Definition of a diffusion process 1.2 Examples 2. Stochastic Differential Equations SDE) 2.1 Stochastic

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

Large Deviations Principles for McKean-Vlasov SDEs, Skeletons, Supports and the law of iterated logarithm

Large Deviations Principles for McKean-Vlasov SDEs, Skeletons, Supports and the law of iterated logarithm Large Deviations Principles for McKean-Vlasov SDEs, Skeletons, Supports and the law of iterated logarithm Gonçalo dos Reis University of Edinburgh (UK) & CMA/FCT/UNL (PT) jointly with: W. Salkeld, U. of

More information

Homogenization with stochastic differential equations

Homogenization with stochastic differential equations Homogenization with stochastic differential equations Scott Hottovy shottovy@math.arizona.edu University of Arizona Program in Applied Mathematics October 12, 2011 Modeling with SDE Use SDE to model system

More information

Bridging the Gap between Center and Tail for Multiscale Processes

Bridging the Gap between Center and Tail for Multiscale Processes Bridging the Gap between Center and Tail for Multiscale Processes Matthew R. Morse Department of Mathematics and Statistics Boston University BU-Keio 2016, August 16 Matthew R. Morse (BU) Moderate Deviations

More information

Approximation of BSDEs using least-squares regression and Malliavin weights

Approximation of BSDEs using least-squares regression and Malliavin weights Approximation of BSDEs using least-squares regression and Malliavin weights Plamen Turkedjiev (turkedji@math.hu-berlin.de) 3rd July, 2012 Joint work with Prof. Emmanuel Gobet (E cole Polytechnique) Plamen

More information

Introduction to the Numerical Simulation of Stochastic Differential Equations with Examples

Introduction to the Numerical Simulation of Stochastic Differential Equations with Examples Introduction to the Numerical Simulation of with Examples Prof. Michael Mascagni Department of Computer Science Department of Mathematics Department of Scientific Computing Florida State University, Tallahassee,

More information

Regularization by noise in infinite dimensions

Regularization by noise in infinite dimensions Regularization by noise in infinite dimensions Franco Flandoli, University of Pisa King s College 2017 Franco Flandoli, University of Pisa () Regularization by noise King s College 2017 1 / 33 Plan of

More information

Robust Markowitz portfolio selection. ambiguous covariance matrix

Robust Markowitz portfolio selection. ambiguous covariance matrix under ambiguous covariance matrix University Paris Diderot, LPMA Sorbonne Paris Cité Based on joint work with A. Ismail, Natixis MFO March 2, 2017 Outline Introduction 1 Introduction 2 3 and Sharpe ratio

More information

SDE Coefficients. March 4, 2008

SDE Coefficients. March 4, 2008 SDE Coefficients March 4, 2008 The following is a summary of GARD sections 3.3 and 6., mainly as an overview of the two main approaches to creating a SDE model. Stochastic Differential Equations (SDE)

More information

Systemic Risk and Stochastic Games with Delay

Systemic Risk and Stochastic Games with Delay Systemic Risk and Stochastic Games with Delay Jean-Pierre Fouque Collaborators: R. Carmona, M. Mousavi, L.-H. Sun, N. Ning and Z. Zhang Mean Field Games 2017 IPAM at UCLA JP Fouque (UC Santa Barbara) Stochastic

More information

Production and Relative Consumption

Production and Relative Consumption Mean Field Growth Modeling with Cobb-Douglas Production and Relative Consumption School of Mathematics and Statistics Carleton University Ottawa, Canada Mean Field Games and Related Topics III Henri Poincaré

More information

Weak convergence and large deviation theory

Weak convergence and large deviation theory First Prev Next Go To Go Back Full Screen Close Quit 1 Weak convergence and large deviation theory Large deviation principle Convergence in distribution The Bryc-Varadhan theorem Tightness and Prohorov

More information

HJB equations. Seminar in Stochastic Modelling in Economics and Finance January 10, 2011

HJB equations. Seminar in Stochastic Modelling in Economics and Finance January 10, 2011 Department of Probability and Mathematical Statistics Faculty of Mathematics and Physics, Charles University in Prague petrasek@karlin.mff.cuni.cz Seminar in Stochastic Modelling in Economics and Finance

More information

Weakly interacting particle systems on graphs: from dense to sparse

Weakly interacting particle systems on graphs: from dense to sparse Weakly interacting particle systems on graphs: from dense to sparse Ruoyu Wu University of Michigan (Based on joint works with Daniel Lacker and Kavita Ramanan) USC Math Finance Colloquium October 29,

More information

Mean field simulation for Monte Carlo integration. Part I : Intro. nonlinear Markov models (+links integro-diff eq.) P. Del Moral

Mean field simulation for Monte Carlo integration. Part I : Intro. nonlinear Markov models (+links integro-diff eq.) P. Del Moral Mean field simulation for Monte Carlo integration Part I : Intro. nonlinear Markov models (+links integro-diff eq.) P. Del Moral INRIA Bordeaux & Inst. Maths. Bordeaux & CMAP Polytechnique Lectures, INLN

More information

Exact Simulation of Multivariate Itô Diffusions

Exact Simulation of Multivariate Itô Diffusions Exact Simulation of Multivariate Itô Diffusions Jose Blanchet Joint work with Fan Zhang Columbia and Stanford July 7, 2017 Jose Blanchet (Columbia/Stanford) Exact Simulation of Diffusions July 7, 2017

More information

Some Properties of NSFDEs

Some Properties of NSFDEs Chenggui Yuan (Swansea University) Some Properties of NSFDEs 1 / 41 Some Properties of NSFDEs Chenggui Yuan Swansea University Chenggui Yuan (Swansea University) Some Properties of NSFDEs 2 / 41 Outline

More information

LECTURES ON MEAN FIELD GAMES: II. CALCULUS OVER WASSERSTEIN SPACE, CONTROL OF MCKEAN-VLASOV DYNAMICS, AND THE MASTER EQUATION

LECTURES ON MEAN FIELD GAMES: II. CALCULUS OVER WASSERSTEIN SPACE, CONTROL OF MCKEAN-VLASOV DYNAMICS, AND THE MASTER EQUATION LECTURES ON MEAN FIELD GAMES: II. CALCULUS OVER WASSERSTEIN SPACE, CONTROL OF MCKEAN-VLASOV DYNAMICS, AND THE MASTER EQUATION René Carmona Department of Operations Research & Financial Engineering PACM

More information

Stochastic Differential Equations

Stochastic Differential Equations Chapter 5 Stochastic Differential Equations We would like to introduce stochastic ODE s without going first through the machinery of stochastic integrals. 5.1 Itô Integrals and Itô Differential Equations

More information

Mean-Field optimization problems and non-anticipative optimal transport. Beatrice Acciaio

Mean-Field optimization problems and non-anticipative optimal transport. Beatrice Acciaio Mean-Field optimization problems and non-anticipative optimal transport Beatrice Acciaio London School of Economics based on ongoing projects with J. Backhoff, R. Carmona and P. Wang Thera Stochastics

More information

The Chaotic Character of the Stochastic Heat Equation

The Chaotic Character of the Stochastic Heat Equation The Chaotic Character of the Stochastic Heat Equation March 11, 2011 Intermittency The Stochastic Heat Equation Blowup of the solution Intermittency-Example ξ j, j = 1, 2,, 10 i.i.d. random variables Taking

More information

Convergence of Particle Filtering Method for Nonlinear Estimation of Vortex Dynamics

Convergence of Particle Filtering Method for Nonlinear Estimation of Vortex Dynamics Convergence of Particle Filtering Method for Nonlinear Estimation of Vortex Dynamics Meng Xu Department of Mathematics University of Wyoming February 20, 2010 Outline 1 Nonlinear Filtering Stochastic Vortex

More information

A new approach for investment performance measurement. 3rd WCMF, Santa Barbara November 2009

A new approach for investment performance measurement. 3rd WCMF, Santa Barbara November 2009 A new approach for investment performance measurement 3rd WCMF, Santa Barbara November 2009 Thaleia Zariphopoulou University of Oxford, Oxford-Man Institute and The University of Texas at Austin 1 Performance

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: Ito s Stochastic Calculus and SDE. Seung Yeal Ha Dept of Mathematical Sciences Seoul National University

Lecture 4: Ito s Stochastic Calculus and SDE. Seung Yeal Ha Dept of Mathematical Sciences Seoul National University Lecture 4: Ito s Stochastic Calculus and SDE Seung Yeal Ha Dept of Mathematical Sciences Seoul National University 1 Preliminaries What is Calculus? Integral, Differentiation. Differentiation 2 Integral

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

Short-time expansions for close-to-the-money options under a Lévy jump model with stochastic volatility

Short-time expansions for close-to-the-money options under a Lévy jump model with stochastic volatility Short-time expansions for close-to-the-money options under a Lévy jump model with stochastic volatility José Enrique Figueroa-López 1 1 Department of Statistics Purdue University Statistics, Jump Processes,

More information

Stochastic optimal control with rough paths

Stochastic optimal control with rough paths Stochastic optimal control with rough paths Paul Gassiat TU Berlin Stochastic processes and their statistics in Finance, Okinawa, October 28, 2013 Joint work with Joscha Diehl and Peter Friz Introduction

More information

A STOCHASTIC LAGRANGIAN REPRESENTATION OF THE 3-DIMENSIONAL INCOMPRESSIBLE NAVIER-STOKES EQUATIONS

A STOCHASTIC LAGRANGIAN REPRESENTATION OF THE 3-DIMENSIONAL INCOMPRESSIBLE NAVIER-STOKES EQUATIONS A STOCHASTIC LAGRANGIAN REPRESENTATION OF THE 3-DIMENSIONAL INCOMPRESSIBLE NAVIER-STOKES EQUATIONS PETER CONSTANTIN AND GAUTAM IYER Abstract. In this paper we derive a probabilistic representation of the

More information

Densities for the Navier Stokes equations with noise

Densities for the Navier Stokes equations with noise Densities for the Navier Stokes equations with noise Marco Romito Università di Pisa Universitat de Barcelona March 25, 2015 Summary 1 Introduction & motivations 2 Malliavin calculus 3 Besov bounds 4 Other

More information

Strong Solutions and a Bismut-Elworthy-Li Formula for Mean-F. Formula for Mean-Field SDE s with Irregular Drift

Strong Solutions and a Bismut-Elworthy-Li Formula for Mean-F. Formula for Mean-Field SDE s with Irregular Drift Strong Solutions and a Bismut-Elworthy-Li Formula for Mean-Field SDE s with Irregular Drift Thilo Meyer-Brandis University of Munich joint with M. Bauer, University of Munich Conference for the 1th Anniversary

More information

Discretization of SDEs: Euler Methods and Beyond

Discretization of SDEs: Euler Methods and Beyond Discretization of SDEs: Euler Methods and Beyond 09-26-2006 / PRisMa 2006 Workshop Outline Introduction 1 Introduction Motivation Stochastic Differential Equations 2 The Time Discretization of SDEs Monte-Carlo

More information

Least Squares Estimators for Stochastic Differential Equations Driven by Small Lévy Noises

Least Squares Estimators for Stochastic Differential Equations Driven by Small Lévy Noises Least Squares Estimators for Stochastic Differential Equations Driven by Small Lévy Noises Hongwei Long* Department of Mathematical Sciences, Florida Atlantic University, Boca Raton Florida 33431-991,

More information

Lecture 15 Random variables

Lecture 15 Random variables Lecture 15 Random variables Weinan E 1,2 and Tiejun Li 2 1 Department of Mathematics, Princeton University, weinan@princeton.edu 2 School of Mathematical Sciences, Peking University, tieli@pku.edu.cn No.1

More information

Mean Field Game Theory for Systems with Major and Minor Agents: Nonlinear Theory and Mean Field Estimation

Mean Field Game Theory for Systems with Major and Minor Agents: Nonlinear Theory and Mean Field Estimation Mean Field Game Theory for Systems with Major and Minor Agents: Nonlinear Theory and Mean Field Estimation Peter E. Caines McGill University, Montreal, Canada 2 nd Workshop on Mean-Field Games and Related

More information

Unbiased simulation of stochastic differential equations using parametrix expansions

Unbiased simulation of stochastic differential equations using parametrix expansions Submitted to Bernoulli Unbiased simulation of stochastic differential equations using parametrix expansions PATRIK ANDERSSON and ARTURO KOHATSU-HIGA Department of Statistics, Uppsala University, Box 53,

More information

Concentration inequalities for Feynman-Kac particle models. P. Del Moral. INRIA Bordeaux & IMB & CMAP X. Journées MAS 2012, SMAI Clermond-Ferrand

Concentration inequalities for Feynman-Kac particle models. P. Del Moral. INRIA Bordeaux & IMB & CMAP X. Journées MAS 2012, SMAI Clermond-Ferrand Concentration inequalities for Feynman-Kac particle models P. Del Moral INRIA Bordeaux & IMB & CMAP X Journées MAS 2012, SMAI Clermond-Ferrand Some hyper-refs Feynman-Kac formulae, Genealogical & Interacting

More information

arxiv: v2 [math.na] 16 Jan 2017

arxiv: v2 [math.na] 16 Jan 2017 arxiv:171.551v2 [math.na] 16 Jan 217 The weak rate of convergence for the Euler-Maruyama approximation of one-dimensional stochastic differential equations involving the local times of the unknown process

More information

Non-nested Adaptive Timesteps in Multilevel Monte Carlo Computations

Non-nested Adaptive Timesteps in Multilevel Monte Carlo Computations Non-nested Adaptive Timesteps in Multilevel Monte Carlo Computations M.B. Giles, C. Lester, and J. Whittle Abstract This paper shows that it is relatively easy to incorporate adaptive timesteps into multilevel

More information

Kolmogorov Equations and Markov Processes

Kolmogorov Equations and Markov Processes Kolmogorov Equations and Markov Processes May 3, 013 1 Transition measures and functions Consider a stochastic process {X(t)} t 0 whose state space is a product of intervals contained in R n. We define

More information

Variance Reduction Techniques for Monte Carlo Simulations with Stochastic Volatility Models

Variance Reduction Techniques for Monte Carlo Simulations with Stochastic Volatility Models Variance Reduction Techniques for Monte Carlo Simulations with Stochastic Volatility Models Jean-Pierre Fouque North Carolina State University SAMSI November 3, 5 1 References: Variance Reduction for Monte

More information

Control of McKean-Vlasov Dynamics versus Mean Field Games

Control of McKean-Vlasov Dynamics versus Mean Field Games Control of McKean-Vlasov Dynamics versus Mean Field Games René Carmona (a),, François Delarue (b), and Aimé Lachapelle (a), (a) ORFE, Bendheim Center for Finance, Princeton University, Princeton, NJ 8544,

More information

Sequential Monte Carlo Methods for Bayesian Computation

Sequential Monte Carlo Methods for Bayesian Computation Sequential Monte Carlo Methods for Bayesian Computation A. Doucet Kyoto Sept. 2012 A. Doucet (MLSS Sept. 2012) Sept. 2012 1 / 136 Motivating Example 1: Generic Bayesian Model Let X be a vector parameter

More information

An adaptive numerical scheme for fractional differential equations with explosions

An adaptive numerical scheme for fractional differential equations with explosions An adaptive numerical scheme for fractional differential equations with explosions Johanna Garzón Departamento de Matemáticas, Universidad Nacional de Colombia Seminario de procesos estocásticos Jointly

More information

Long time behavior of Mean Field Games

Long time behavior of Mean Field Games Long time behavior of Mean Field Games P. Cardaliaguet (Paris-Dauphine) Joint work with A. Porretta (Roma Tor Vergata) PDE and Probability Methods for Interactions Sophia Antipolis (France) - March 30-31,

More information

Exercises. T 2T. e ita φ(t)dt.

Exercises. T 2T. e ita φ(t)dt. Exercises. Set #. Construct an example of a sequence of probability measures P n on R which converge weakly to a probability measure P but so that the first moments m,n = xdp n do not converge to m = xdp.

More information

Walsh Diffusions. Andrey Sarantsev. March 27, University of California, Santa Barbara. Andrey Sarantsev University of Washington, Seattle 1 / 1

Walsh Diffusions. Andrey Sarantsev. March 27, University of California, Santa Barbara. Andrey Sarantsev University of Washington, Seattle 1 / 1 Walsh Diffusions Andrey Sarantsev University of California, Santa Barbara March 27, 2017 Andrey Sarantsev University of Washington, Seattle 1 / 1 Walsh Brownian Motion on R d Spinning measure µ: probability

More information

Mean-square Stability Analysis of an Extended Euler-Maruyama Method for a System of Stochastic Differential Equations

Mean-square Stability Analysis of an Extended Euler-Maruyama Method for a System of Stochastic Differential Equations Mean-square Stability Analysis of an Extended Euler-Maruyama Method for a System of Stochastic Differential Equations Ram Sharan Adhikari Assistant Professor Of Mathematics Rogers State University Mathematical

More information

Random and Deterministic perturbations of dynamical systems. Leonid Koralov

Random and Deterministic perturbations of dynamical systems. Leonid Koralov Random and Deterministic perturbations of dynamical systems Leonid Koralov - M. Freidlin, L. Koralov Metastability for Nonlinear Random Perturbations of Dynamical Systems, Stochastic Processes and Applications

More information

Mean-Field Games with non-convex Hamiltonian

Mean-Field Games with non-convex Hamiltonian Mean-Field Games with non-convex Hamiltonian Martino Bardi Dipartimento di Matematica "Tullio Levi-Civita" Università di Padova Workshop "Optimal Control and MFGs" Pavia, September 19 21, 2018 Martino

More information

An Introduction to Malliavin calculus and its applications

An Introduction to Malliavin calculus and its applications An Introduction to Malliavin calculus and its applications Lecture 3: Clark-Ocone formula David Nualart Department of Mathematics Kansas University University of Wyoming Summer School 214 David Nualart

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 October 22nd, 2014 E. Tanré (INRIA - Team Tosca) Mathematical

More information

Two new developments in Multilevel Monte Carlo methods

Two new developments in Multilevel Monte Carlo methods Two new developments in Multilevel Monte Carlo methods Mike Giles Abdul-Lateef Haji-Ali Oliver Sheridan-Methven Mathematical Institute, University of Oxford Rob Scheichl s Farewell Conference University

More information

Introduction to the Numerical Solution of SDEs Selected topics

Introduction to the Numerical Solution of SDEs Selected topics 0 / 23 Introduction to the Numerical Solution of SDEs Selected topics Andreas Rößler Summer School on Numerical Methods for Stochastic Differential Equations at Vienna University of Technology, Austria

More information

Introduction to Mean Field Game Theory Part I

Introduction to Mean Field Game Theory Part I School of Mathematics and Statistics Carleton University Ottawa, Canada Workshop on Game Theory, Institute for Math. Sciences National University of Singapore, June 2018 Outline of talk Background 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

Stochastic Differential Equations

Stochastic Differential Equations CHAPTER 1 Stochastic Differential Equations Consider a stochastic process X t satisfying dx t = bt, X t,w t dt + σt, X t,w t dw t. 1.1 Question. 1 Can we obtain the existence and uniqueness theorem for

More information

Lipschitz continuity for solutions of Hamilton-Jacobi equation with Ornstein-Uhlenbeck operator

Lipschitz continuity for solutions of Hamilton-Jacobi equation with Ornstein-Uhlenbeck operator Lipschitz continuity for solutions of Hamilton-Jacobi equation with Ornstein-Uhlenbeck operator Thi Tuyen Nguyen Ph.D student of University of Rennes 1 Joint work with: Prof. E. Chasseigne(University of

More information

Mean-field SDE driven by a fractional BM. A related stochastic control problem

Mean-field SDE driven by a fractional BM. A related stochastic control problem Mean-field SDE driven by a fractional BM. A related stochastic control problem Rainer Buckdahn, Université de Bretagne Occidentale, Brest Durham Symposium on Stochastic Analysis, July 1th to July 2th,

More information

Model Specification Testing in Nonparametric and Semiparametric Time Series Econometrics. Jiti Gao

Model Specification Testing in Nonparametric and Semiparametric Time Series Econometrics. Jiti Gao Model Specification Testing in Nonparametric and Semiparametric Time Series Econometrics Jiti Gao Department of Statistics School of Mathematics and Statistics The University of Western Australia Crawley

More information

Large deviation properties of weakly interacting processes via weak convergence methods

Large deviation properties of weakly interacting processes via weak convergence methods Large deviation properties of wealy interacting processes via wea convergence methods A. Budhiraja, P. Dupuis, and M. Fischer December 11, 29 Abstract We study large deviation properties of systems of

More information

Higher order weak approximations of stochastic differential equations with and without jumps

Higher order weak approximations of stochastic differential equations with and without jumps Higher order weak approximations of stochastic differential equations with and without jumps Hideyuki TANAKA Graduate School of Science and Engineering, Ritsumeikan University Rough Path Analysis and Related

More information

Derivation of Itô SDE and Relationship to ODE and CTMC Models

Derivation of Itô SDE and Relationship to ODE and CTMC Models Derivation of Itô SDE and Relationship to ODE and CTMC Models Biomathematics II April 23, 2015 Linda J. S. Allen Texas Tech University TTU 1 Euler-Maruyama Method for Numerical Solution of an Itô SDE dx(t)

More information

Systemic Risk and Stochastic Games with Delay

Systemic Risk and Stochastic Games with Delay Systemic Risk and Stochastic Games with Delay Jean-Pierre Fouque (with René Carmona, Mostafa Mousavi and Li-Hsien Sun) PDE and Probability Methods for Interactions Sophia Antipolis (France) - March 30-31,

More information

Improved diffusion Monte Carlo

Improved diffusion Monte Carlo Improved diffusion Monte Carlo Jonathan Weare University of Chicago with Martin Hairer (U of Warwick) October 4, 2012 Diffusion Monte Carlo The original motivation for DMC was to compute averages with

More information

Exact and high order discretization schemes. Wishart processes and their affine extensions

Exact and high order discretization schemes. Wishart processes and their affine extensions for Wishart processes and their affine extensions CERMICS, Ecole des Ponts Paris Tech - PRES Université Paris Est Modeling and Managing Financial Risks -2011 Plan 1 Motivation and notations 2 Splitting

More information

Some Terminology and Concepts that We will Use, But Not Emphasize (Section 6.2)

Some Terminology and Concepts that We will Use, But Not Emphasize (Section 6.2) Some Terminology and Concepts that We will Use, But Not Emphasize (Section 6.2) Statistical analysis is based on probability theory. The fundamental object in probability theory is a probability space,

More information

The Wiener Itô Chaos Expansion

The Wiener Itô Chaos Expansion 1 The Wiener Itô Chaos Expansion The celebrated Wiener Itô chaos expansion is fundamental in stochastic analysis. In particular, it plays a crucial role in the Malliavin calculus as it is presented in

More information

Mean Field Games on networks

Mean Field Games on networks Mean Field Games on networks Claudio Marchi Università di Padova joint works with: S. Cacace (Rome) and F. Camilli (Rome) C. Marchi (Univ. of Padova) Mean Field Games on networks Roma, June 14 th, 2017

More information

On the connection between symmetric N-player games and mean field games

On the connection between symmetric N-player games and mean field games On the connection between symmetric -player games and mean field games Markus Fischer May 14, 214; revised September 7, 215; modified April 15, 216 Abstract Mean field games are limit models for symmetric

More information

Introduction. Stochastic Processes. Will Penny. Stochastic Differential Equations. Stochastic Chain Rule. Expectations.

Introduction. Stochastic Processes. Will Penny. Stochastic Differential Equations. Stochastic Chain Rule. Expectations. 19th May 2011 Chain Introduction We will Show the relation between stochastic differential equations, Gaussian processes and methods This gives us a formal way of deriving equations for the activity of

More information

Math 21B - Homework Set 8

Math 21B - Homework Set 8 Math B - Homework Set 8 Section 8.:. t cos t dt Let u t, du t dt and v sin t, dv cos t dt Let u t, du dt and v cos t, dv sin t dt t cos t dt u v v du t sin t t sin t dt [ t sin t u v ] v du [ ] t sin t

More information

Chapter 4: Monte-Carlo Methods

Chapter 4: Monte-Carlo Methods Chapter 4: Monte-Carlo Methods A Monte-Carlo method is a technique for the numerical realization of a stochastic process by means of normally distributed random variables. In financial mathematics, it

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

A STOCHASTIC LAGRANGIAN REPRESENTATION OF THE 3-DIMENSIONAL INCOMPRESSIBLE NAVIER-STOKES EQUATIONS

A STOCHASTIC LAGRANGIAN REPRESENTATION OF THE 3-DIMENSIONAL INCOMPRESSIBLE NAVIER-STOKES EQUATIONS A STOCHASTIC LAGRANGIAN REPRESENTATION OF THE 3-DIMENSIONAL INCOMPRESSIBLE NAVIER-STOKES EQUATIONS PETER CONSTANTIN AND GAUTAM IYER Abstract. In this paper we derive a representation of the deterministic

More information

Mean field simulation for Monte Carlo integration. Part II : Feynman-Kac models. P. Del Moral

Mean field simulation for Monte Carlo integration. Part II : Feynman-Kac models. P. Del Moral Mean field simulation for Monte Carlo integration Part II : Feynman-Kac models P. Del Moral INRIA Bordeaux & Inst. Maths. Bordeaux & CMAP Polytechnique Lectures, INLN CNRS & Nice Sophia Antipolis Univ.

More information

FE 5204 Stochastic Differential Equations

FE 5204 Stochastic Differential Equations Instructor: Jim Zhu e-mail:zhu@wmich.edu http://homepages.wmich.edu/ zhu/ January 20, 2009 Preliminaries for dealing with continuous random processes. Brownian motions. Our main reference for this lecture

More information

Conditional Distributions

Conditional Distributions Conditional Distributions The goal is to provide a general definition of the conditional distribution of Y given X, when (X, Y ) are jointly distributed. Let F be a distribution function on R. Let G(,

More information

1. Stochastic Processes and filtrations

1. Stochastic Processes and filtrations 1. Stochastic Processes and 1. Stoch. pr., A stochastic process (X t ) t T is a collection of random variables on (Ω, F) with values in a measurable space (S, S), i.e., for all t, In our case X t : Ω S

More information

Some Semi-Markov Processes

Some Semi-Markov Processes Some Semi-Markov Processes and the Navier-Stokes equations NW Probability Seminar, October 22, 2006 Mina Ossiander Department of Mathematics Oregon State University 1 Abstract Semi-Markov processes were

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

ECE 636: Systems identification

ECE 636: Systems identification ECE 636: Systems identification Lectures 3 4 Random variables/signals (continued) Random/stochastic vectors Random signals and linear systems Random signals in the frequency domain υ ε x S z + y Experimental

More information

Stability of Stochastic Differential Equations

Stability of Stochastic Differential Equations Lyapunov stability theory for ODEs s Stability of Stochastic Differential Equations Part 1: Introduction Department of Mathematics and Statistics University of Strathclyde Glasgow, G1 1XH December 2010

More information

Week 6 Notes, Math 865, Tanveer

Week 6 Notes, Math 865, Tanveer Week 6 Notes, Math 865, Tanveer. Energy Methods for Euler and Navier-Stokes Equation We will consider this week basic energy estimates. These are estimates on the L 2 spatial norms of the solution u(x,

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

EULER MARUYAMA APPROXIMATION FOR SDES WITH JUMPS AND NON-LIPSCHITZ COEFFICIENTS

EULER MARUYAMA APPROXIMATION FOR SDES WITH JUMPS AND NON-LIPSCHITZ COEFFICIENTS Qiao, H. Osaka J. Math. 51 (14), 47 66 EULER MARUYAMA APPROXIMATION FOR SDES WITH JUMPS AND NON-LIPSCHITZ COEFFICIENTS HUIJIE QIAO (Received May 6, 11, revised May 1, 1) Abstract In this paper we show

More information

MA8109 Stochastic Processes in Systems Theory Autumn 2013

MA8109 Stochastic Processes in Systems Theory Autumn 2013 Norwegian University of Science and Technology Department of Mathematical Sciences MA819 Stochastic Processes in Systems Theory Autumn 213 1 MA819 Exam 23, problem 3b This is a linear equation of the form

More information

Exact Simulation of Diffusions and Jump Diffusions

Exact Simulation of Diffusions and Jump Diffusions Exact Simulation of Diffusions and Jump Diffusions A work by: Prof. Gareth O. Roberts Dr. Alexandros Beskos Dr. Omiros Papaspiliopoulos Dr. Bruno Casella 28 th May, 2008 Content 1 Exact Algorithm Construction

More information