Simulation and Parametric Estimation of SDEs

Size: px
Start display at page:

Download "Simulation and Parametric Estimation of SDEs"

Transcription

1 Simulation and Parametric Estimation of SDEs Jhonny Gonzalez School of Mathematics The University of Manchester Magical books project August 23, 2012

2 Motivation The problem Simulation of SDEs SDEs driven by Wiener processes Processes with jumps Parametric estimation Continuous-time observations Discrete-time observations The Kalman Filter

3 Motivation The problem Simulation of SDEs SDEs driven by Wiener processes Processes with jumps Parametric estimation Continuous-time observations Discrete-time observations The Kalman Filter

4 Problem An observer has collected a set of data of their interest over a period of time and at a certain sampling rate (not necessarily fixed). Imagine data coming from investment finance, population dynamics, radio-astronomy, etc. She/he would like to find a mathematical model that could best describe the dynamics of the variables involved. Discrete or continuous? Deterministic or stochastic? Is there some noise or randomness that make her think about using SDEs?

5 Problem The observer thinks some particular model is suitable and proposes a set of equations, for instance, dx t = β(α X t )dt + dw t. an OU process with unknown level and speed of mean reversion θ =(α, β). Well, but what is θ for the corresponding dataset the observer has collected? What can we say about the parameters in θ?

6 Figure: COB market prices. Taken from Geman and Roncoroni (2006)

7 Parametric estimation Parametric estimation is the process of determining the parameters that best fit some given data in some sense. Since the process cannot be observed completely we actually want estimates of the parameters. Obviously, for different datasets we will have in general different values for the parameters. Use same SDEs in different markets but with different parameters. In what sense? At least we expect the more we observe the process the more accurate we can find the estimates.

8 In general Let {(Ω, F, {F t } t 0, P θ ); θ Θ} be a filtered space and {X t } t 0 a stochastic process satisfying the stochastic differential equation dx t = b(x t, θ)dt + σ(x t, θ)dw t X 0 = x, t 0, (1) where {W t } t 0 is a standard Wiener process adapted to the natural filtration {F W t } t 0. Here θ Θ R p is the multidimensional parameter to be estimated from the observations of {X t } t 0. The functions b : R Θ R and σ : R Θ R + are assumed to be known and satisfying conditions for the SDE to have a unique (strong) solution.

9 Consistency and asymptotic normal estimators Let θ 0 be the true value of the parameter θ. Our main goal is to determine estimates ˆθ of the true value θ 0 that are both consistent and asymptotically normal as defined below. 1. A sequence of estimators ˆθ T (X T ) of the unknown parameter θ is said to be consistent if ˆθ T θ 0 almost surely as T under P θ0. 2. A sequence of consistent estimators ˆθ T (X T ) of the unknown parameter θ is said to be asymptotically normal (Gaussian) if T ˆθ T θ 0 N (0, Σ) in distribution as T under P θ0.hereσ is the asymptotic variance matrix.

10 Sample schemes We could have different sampling rates. For example, Large sample scheme: the number of observations n increases but the time between consecutive observations is fixed. Hence, the total time of observation [0, n = T ] also increases as more observations are taken. High-frequency scheme: the total time of observation is fixed whilst n increases. Consequently, = n goes to zero with n. Rapidly increasing design: n goes to zero as n increases, but the total time of observation also increases, i.e., n n. Moreover, could shrink to zero at a specified rate n k n 0, k 2. In any case a continuous observation is quite unlikely and the large sample scheme is perhaps the most natural one.

11 Simulation of SDEs Simulation of SDEs is quite important in any field where SDEs are used to model systems. They are the link between our mental models and the real world. They tells us what to expect from our models and allow analysis, forecasts, etc. In particular, if we want to test whether any estimation method is good in some sense, we need to have at hand the right data to prove it. This data is obtained by simulating the SDE of interest.

12 Motivation The problem Simulation of SDEs SDEs driven by Wiener processes Processes with jumps Parametric estimation Continuous-time observations Discrete-time observations The Kalman Filter

13 Simulation of sample paths Clip for this slide Consider the solution {X t } to the SDE dx t = b(x t )dt + σ(x t )dw t, X 0 = x for 0 t T.Wewanttoapproximatetheprocess{X t } by a discrete process {Yt } which has the property that Y converges in a suitable sense to X as approaches zero, where we have a partition of the interval [0, T ] of the form t n = n, n = 1, 2,...,n T with = T n T for some integer n T.

14 Definition It is said that the discrete approximation Y converges strongly with order γ > 0attimet > 0, if there exists a positive constant C and 0 < δ 0 < t such that, for all (0, δ 0 ) where C does not depend on. E [ X t Y t ] C γ In average the discretisation is close to the initial process by a distance that depends on. If < 1, the greater the order γ the smaller the distance in average.

15 To derive discrete approximations of the process {X t } stochastic Ito-Taylor expansions that satisfy the strong convergence criterion are used. These approximations are called strong Taylor approximations (derived using Taylor series for SDEs).

16 There are mainly 3 schemes that can be used to simulate Ito processes Euler scheme, the simplest one Milstein scheme The 1.5 strong order Taylor scheme

17 Euler scheme The simplest strong Taylor approximation is the Euler scheme given by Y n+1 = Y n + b(y n ) + σ(y n ) W n, for n 0withY 0 = X 0 and W n = W tn+1 W tn. Use W n N(0, 1). γ = 1 /2 if strong solution of the SDE exists. Good numerical results for nearly constant drift and diffusion terms. However, the small order of convergence of this scheme makes desirable to use a higher order scheme.

18 Milstein scheme By adding a small term to the Euler scheme we get the Milstein scheme Y n+1 = Y n + b(y n ) + σ(y n ) W n σ(y n)σ (Y n ) ( W n ) 2, where σ ( ) denotes the derivative of σ( ). γ = 1

19 Comparison. Euler vs Milstein vs analytic Euler Milstein Analitic solution 120 X(t) t

20 Comparison. Euler vs Milstein vs analytic Euler Milstein Analitic solution X(t) t

21 Comparison. Euler vs Milstein vs analytic Euler Milstein Analitic solution 95 X(t) t

22 The order 1.5 strong Taylor scheme More information of the sample paths of the process is obtained with Y n+1 = Y n + b + σ W n σσ ( W n ) 2 +b σ Z n + 1 bb σ2 b 2 + bσ + 12 σ2 σ { W n Z n } σ σσ 1 3 ( W n) 2 W n, Here Z n is a standard Gaussian random variable with variance and E [ Z n W n ]=

23 The pair of random variables ( Z n, W n ) can be determined from two independent standard normal variables U 1,n and U 2,n such that W n = U 1,n Z n = /2 U 1,n U 2,n. γ = 3 /2.

24 For the geometric and arithmetic model without jumps, we have more than one Wiener process driving the SDEs. In this case, similar equations can be obtained to those presented above (see Kloeden and Platen, 1992). This the classical book for numerical analysis of SDEs!

25 Motivation The problem Simulation of SDEs SDEs driven by Wiener processes Processes with jumps Parametric estimation Continuous-time observations Discrete-time observations The Kalman Filter

26 Preliminaries Clip for this slide Compound Poisson process. Let {X i } i=1,2,... be a sequence of iid random variables. Define L(t) = N(t) X i, i=1 where N(t) is a Poisson process with intensity λ independent of X i.thenl(t) is said to be a CP process. It is a Lévy process where jumps occur at a intensity λ, and jump size is determined by X i. It gives us random jumps, and not only of jumps of size one as the Poisson process. The intensity of jumps may be time dependent. We want this for electricity markets!

27 For example, λ(t) = sin 2 π (t τ) k λ(t) Jan Apr Jul Oct Jan Apr Jul Oct Jan Apr Jul Oct Time τ is phase change. k controls the concentration of jumps occurring in multiple of k years.

28 Simulation of a (NC) Poisson process Simulation of a nonhomogeneous Compound Poisson process Algorithm. Thinning or random sampling approach. 1. t = 0, I = 0, L = Generate a random exponential number T e 3. t = t + T e.ift e > T, stop. 4. Generate a random uniform number U. 5. If U λ(t) /λ, set I = I + 1, S(I) =t. Generate random jump X. L = L + X. 6. Go to step 2.

29 Stationary distributions Stationary distribution of an OU-type process. We want to look at the random variable X = lim t X (t). Consider the solution of an OU process dx (t) = βx (t)dt + σdi(t), X (0) =x, with solution given by t X (t) =e βt x + σe βt e βu di(u). If I(u) =W (u), thenx (t) N(0, σ2 2β ). If I(t) = N(t) i=1 X i, N(t) with intensity λ and exponentially distributed jumps with mean µ J,thenX (t) Γ( λ /β, 1 /µ J ). 0

30 OU process driven by a Lévy process We know already how to simulate the classical OU process. Now we want to simulate, say, the process dy t = βy t dt + dl t where L is a Lévy process, β > 0. Then discretise the interval [0, T ] by homogeneous time intervals of length > 0. Then, using a integrator factor or the general Itô formula, we get the exact solution Y (s + ) =e β Y (s)+e β Z (s), where Z (s) =e βs s+ e s βu dl(u). By a change of variables (u =: u s), we find that Z (s) d = 0 e βu dl(u).

31 OU process driven by a Lévy process For a general Levy process, computation of this random variable is complicated and simulation algorithms are usually slow. Following Bandorff-Nielsen and Shephard (2001), suppose the stationary distribution of Y (t) is Γ(ν, 1 /µ J ).Thenthe background Lévy process L(t) is a compound Poisson process with exponentially distributed jumps with mean 1 /µ J.Further, if the speed of mean reversion β is known, the intensity of jumps in L(t) is λ = νβ. In this case it can be shown that if we let c 1 < c 2 <... be the arrival times of a Poisson process with intensity νβ and N(1) the number of jumps up to time 1, then Z (s) = d N(1) µ J ln(ci 1 )e β u i. i=1

32 The arithmetic spot model Consider the arithmetic model S(t) =Λ(t)+Y 1 (t)+y 2 (t) with Y 1 (0) =S(0) Λ(0), Y 2 (0) =0, and where 2πt Λ(t) =a + bt + c sin, 365 is the floor seasonal function to which the prices will revert back to. It consists of a linear trend describing inflation in price level and a seasonal term explaining variations over the year.

33 Also, dy 1 (t) = β 1 Y 1 (t)dt + η 1 di 1 (t), dy 2 (t) = β 2 Y 2 (t)dt + η 2 di 2 (t), with Y 1 (t) Γ(ν, 1 /µ J ) and I 2 a compound Poisson process with exponentially distributed jumps and time dependent intensity λ(t) given by λ(t) = sin 2 π (t τ) k Y 1 describes the normal prices. Low speed reversion. Y 2 captures the spikes in prices. High speed reversion. τ is phase change. k controls the concentration of jumps occurring in multiple of k years.

34 Figure: Simulation of the Arithmetic spot price model.

35 Motivation The problem Simulation of SDEs SDEs driven by Wiener processes Processes with jumps Parametric estimation Continuous-time observations Discrete-time observations The Kalman Filter

36 Clip for this slide Recall we want find consistent and asymptotically normal estimates of the parameters of a SDE, e.g., find estimates for β and α in dx t = β(α X t )dt + dw t.

37 There are several methods that can be used to perform parametric estimation, some easy, others difficult to implement. For example, Exact Maximum Likelihood. Pseudo-likelihood methods (discretise the SDE) Approximated likelihood methods (approximate the likelihood function, e.g., with Hermite polynomials). GMM. Generalised method of moments (match theoretical and sample moments). Martingale Estimating functions. (Adapted) Kalman Filter method. etc. Some useful references at the end!

38 Continuous time observations Consider the SDE Note that if θ =(θ b, θ σ ) 2 n lim n i=1 dx t = b(t, X t, θ)dt + σ(t, X t, θ)dw t t X i 2 n T X i 1 2 n T 2 = σ 2 (u, X u, θ σ )du 0 And thus, θ σ, the parameters that only appear in the diffusion term, can be calculated from the quadratic variation of the process. So we can focus only on the parameters appearing in the drift term.

39 Volatility of GBM For a GBM S t = S 0 e (σw t+(µ 1 2 σ2 )t) with unknown volatility σ we may use the quadratic variation of a BM to find that for small enough and a partition of the observation time [0, T ], {t i } i=1,...,n σ 2 1 T N 1 log S 2 i+1. i=0 S i where S i = S ti.

40 Maximum likelihood For a SDE of the form dx t = b(x t, θ)dt + σ(x t )dw t the continuous-time likelihood ratio is given by T L T (θ) =exp b(x s, θ) σ 2 (X s ) dx s 1 T b 2 (X s, θ) 2 σ 2 (X s ) ds. 0 0 The MLE of θ 0 is the value of θ that maximises this ratio. T (θ) =log L T (θ) could also be maximised. Under some regularity conditions, the estimates so obtained are consistent and asymptotically normal Rao (1999). If time between observations is not small enough estimators are neither consistent nor unbiased.

41 Discrete likelihood function Instead of using the likelihood ratio above we could use the likelihood function for discrete observations given by L n (θ) = n i=1 p θ (, X i X i 1 ) (2) where p θ (, X i X i 1 ) represents the transition probability density function of the process from X i 1 at time t i 1 to state X i at time t i. This implies that at least we know p θ. GBM, classic OU. But we do not know it in gral., we are dealing with a mixture of processes in energy markets. Trying to compute it numerically could lead to poor estimating algorithms.

42 Motivation The problem Simulation of SDEs SDEs driven by Wiener processes Processes with jumps Parametric estimation Continuous-time observations Discrete-time observations The Kalman Filter

43 Clip for this slide When observation of the process is discrete there are many available methods that we can use. We give the basic ideas behind two of these methods, namely, Martingale Estimating functions and the Kalman Filter method. Parametric estimation of SDEs depends upon many factors such as the number of observations n (the more the better), the timestep (the smaller the better). Number of simulations. Sometimes the estimates need to be calculated as the average of the estimates for several simulations of the same process (the larger the number of simulations the better). In any case, parametric estimation is not a magic tool!

44 Martingale Estimating functions An estimating function G n is a function of the parameter θ and the discretely-observed data of the process X i, i = 0, 1,...,n. An estimator θ is calculated from the equation G n (θ, (X i ) i=0,1,...,n )=0. If G n is also a martingale then it is called a MEF. Basic idea in Bibbi and Sørensen (1995) 1. Take the log- continuous-time likelihood function for an SDE. 2. Take derivative wrt to the parameter. 3. Discretise it to get an estimating function. Since this (estimating) function is biased, subtract its compensator to get a martingale with respect to P θ.

45 Martingale Estimating functions Under some conditions... the optimal MEF of Bibbi and Sørensen (1995) is given by G n (θ) = n Ḟ (X i 1 ; θ) T φ(x i 1 ; θ) 1 (X i F (X i 1 ; θ)), i=1 where the dot operator denotes differentiation with respect to the parameter θ, and φ(x i 1 ; θ) =E θ [X i F (X i 1 : θ) 2 X i 1 ] and F (X i 1 ; θ) =E θ [X i X i 1 ]. This method exchanges small for ergodicity in the process. If F and φ are complicated to find they can be approximated by their sample counterpart.

46 OU process For an OU process with zero mean reversion it is known that dx t = θx t dt + σdw t, F (x; θ) =xe θ, and φ(θ) = σ2 e 2θ 1. 2θ Using these last two equations in G n above and assuming σ is given, we get θ n = 1 log n i=1 X i 1 X i n i=1 Xi 1 2.

47 Motivation The problem Simulation of SDEs SDEs driven by Wiener processes Processes with jumps Parametric estimation Continuous-time observations Discrete-time observations The Kalman Filter

48 OU process and the AR(1) model Clip for this slide The AR(1) model is the discrete-time version of the OU process (Euler scheme). The AR(p) model can be written as X t = c + p i=1 ϕ i X t i + ε t, where c is a constant, ϕ i are parameters of the model and ε t is white noise. Using the Euler scheme with = 1fortheOUprocess we get dx t = β (µ X t ) dt + σdw t, X t = βµ +(1 β)x t 1 + ε t, with E [ε t ] = 0andE ε 2 t = σ 2.

49 An interpretation of SDEs In contrast with the financial markets, in most electricity markets we have only hourly data series. So we may interpret our SDEs as discrete time equations. As shorthand notations of discrete models. Prices in i < t < (i + 1) are not observable.

50 KF in discrete time The state equation (real price process) is given by and the observation equation is x t = F t x t 1 + v t 1, z t = H t x t + A t z t 1 + w t. Here v t, w t are two noise sources with normal distributions N(0, Q) and N(0, R), respectively.thematricesf t, H t, A t, Q and R contains the parameters of the equations. 1. What is the best estimate of x t above based on the observations z s, s t? 2. The filtering problem. We want to filter the noise away from the observations in an optimal way. Extract the state process from noisy measurements.

51 Running the KF recursive method The variables for the KF can be classified as Apriorivariables. x t t 1, P t t 1 are the estimates for the mean and variance of x t given the observations z 1,...,z t 1. A posteriori variables. x t, P t are the estimates for the mean and variance given z 1,...,z t 1, z t.

52 1. Project the a posteriori values for t 1 one time step ahead x t t 1 = F t x t 1, 2. Compute the Kalman gain K t 3. Estimate z t given z 1,...,z t 1 4. The residuals are P t t 1 = F t P t 1 F T t + Q. G t = H t P t t 1 H T t + R, K t = P t t 1 H T t G 1 t. z t = H t x t t 1 + Az t 1. r t = z t z t = z t H t x t t 1 Az t Produce a posteriori estimates x t, P t x t = x t t 1 + K t r t, P t = (I K t H t ) P t t 1.

53 Figure: Basic concept of the Kalman Filter

54 The residual r t has a normal distribution N(0, G t ).WhenG t is 1-dimensional, the pdf of r t is f t (r t )=(2πG t ) 1/2 exp ( r 2 t/2g t ). The sample log-likelihood is therefore L = N log f t (r t )= 1 t=1 2 log(2π) 1 N 2 log(g t )+ r 2 t. t=1 G t

55 Parametric estimation Parameters are estimated as follows (Barlow, Gusev, Lai, 2004): 1. Start with some initial guesses of the parameters. They can be optimally chosen to provide the fastest convergence of the KF filter. 2. Run the KF to estimate what the system equation would be if these parameters were correct. 3. Calculate the log-likelihood function L. 4. Repeat 1-3 to find the parameter values that maximise L. An optimisation routine is used here.

56 Simplex algorithm The Log-likelihood function may be maximised (or minimised its negative) with the Simplex optimisation method. It is the fminsearch function in MATLAB. Allows multidimensional optimisation of a function without using its derivatives. Robust, converges quickly, works well for irregular functions. No rigorous proof of convergence in 2004! Gives only a local minimum, but this happens with all other methods. But have been used in the last 30 years and it is known to give false minimum points for few rare functions.

57 Barlow, M., Gusev, Y. and Lai, M. (2004) Calibration of multifactor models in Electricity Markets. International Journal of Theoretical and Applied Finance, v. 7, No. 2. Benth, F. E., Benth, J. Š. and Koekebakker S.. Stochastic modelling of electricity and related markets. World Scientific, London Bibby, B., Sørensen, M. (1995). Martingale estimating functions for discretely observed diffusion processes, Bernoulli, 1, Iacus, S., (2008). Simulation and Inference for Stochastic Differential Equations With R Examples. Springer-Verlag, New York.

58 Prakasa Rao, B.L.S. (1999) Statistical Inference for Diffusion Type Processes. Oxford University Press, New York. Pedersen, A. R. (1995). A new approach to Maximum Likelihood Estimation for stochastic differential equations based on discrete observations. Scandinavian Journal of Statistics, 22, pp

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 4: Introduction to stochastic processes and stochastic calculus

Lecture 4: Introduction to stochastic processes and stochastic calculus Lecture 4: Introduction to stochastic processes and stochastic calculus Cédric Archambeau Centre for Computational Statistics and Machine Learning Department of Computer Science University College London

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

Tools of stochastic calculus

Tools of stochastic calculus slides for the course Interest rate theory, University of Ljubljana, 212-13/I, part III József Gáll University of Debrecen Nov. 212 Jan. 213, Ljubljana Itô integral, summary of main facts Notations, basic

More information

I forgot to mention last time: in the Ito formula for two standard processes, putting

I forgot to mention last time: in the Ito formula for two standard processes, putting I forgot to mention last time: in the Ito formula for two standard processes, putting dx t = a t dt + b t db t dy t = α t dt + β t db t, and taking f(x, y = xy, one has f x = y, f y = x, and f xx = f yy

More information

Asymptotical distribution free test for parameter change in a diffusion model (joint work with Y. Nishiyama) Ilia Negri

Asymptotical distribution free test for parameter change in a diffusion model (joint work with Y. Nishiyama) Ilia Negri Asymptotical distribution free test for parameter change in a diffusion model (joint work with Y. Nishiyama) Ilia Negri University of Bergamo (Italy) ilia.negri@unibg.it SAPS VIII, Le Mans 21-24 March,

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

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

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

Jump-type Levy Processes

Jump-type Levy Processes Jump-type Levy Processes Ernst Eberlein Handbook of Financial Time Series Outline Table of contents Probabilistic Structure of Levy Processes Levy process Levy-Ito decomposition Jump part Probabilistic

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

Poisson random measure: motivation

Poisson random measure: motivation : motivation The Lévy measure provides the expected number of jumps by time unit, i.e. in a time interval of the form: [t, t + 1], and of a certain size Example: ν([1, )) is the expected number of jumps

More information

Stochastic Integration and Stochastic Differential Equations: a gentle introduction

Stochastic Integration and Stochastic Differential Equations: a gentle introduction Stochastic Integration and Stochastic Differential Equations: a gentle introduction Oleg Makhnin New Mexico Tech Dept. of Mathematics October 26, 27 Intro: why Stochastic? Brownian Motion/ Wiener process

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

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

Functional Limit theorems for the quadratic variation of a continuous time random walk and for certain stochastic integrals

Functional Limit theorems for the quadratic variation of a continuous time random walk and for certain stochastic integrals Functional Limit theorems for the quadratic variation of a continuous time random walk and for certain stochastic integrals Noèlia Viles Cuadros BCAM- Basque Center of Applied Mathematics with Prof. Enrico

More information

LAN property for sde s with additive fractional noise and continuous time observation

LAN property for sde s with additive fractional noise and continuous time observation LAN property for sde s with additive fractional noise and continuous time observation Eulalia Nualart (Universitat Pompeu Fabra, Barcelona) joint work with Samy Tindel (Purdue University) Vlad s 6th birthday,

More information

Brownian Motion. An Undergraduate Introduction to Financial Mathematics. J. Robert Buchanan. J. Robert Buchanan Brownian Motion

Brownian Motion. An Undergraduate Introduction to Financial Mathematics. J. Robert Buchanan. J. Robert Buchanan Brownian Motion Brownian Motion An Undergraduate Introduction to Financial Mathematics J. Robert Buchanan 2010 Background We have already seen that the limiting behavior of a discrete random walk yields a derivation of

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

Stochastic Volatility and Correction to the Heat Equation

Stochastic Volatility and Correction to the Heat Equation Stochastic Volatility and Correction to the Heat Equation Jean-Pierre Fouque, George Papanicolaou and Ronnie Sircar Abstract. From a probabilist s point of view the Twentieth Century has been a century

More information

Numerical methods for solving stochastic differential equations

Numerical methods for solving stochastic differential equations Mathematical Communications 4(1999), 251-256 251 Numerical methods for solving stochastic differential equations Rózsa Horváth Bokor Abstract. This paper provides an introduction to stochastic calculus

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

Tyler Hofmeister. University of Calgary Mathematical and Computational Finance Laboratory

Tyler Hofmeister. University of Calgary Mathematical and Computational Finance Laboratory JUMP PROCESSES GENERALIZING STOCHASTIC INTEGRALS WITH JUMPS Tyler Hofmeister University of Calgary Mathematical and Computational Finance Laboratory Overview 1. General Method 2. Poisson Processes 3. Diffusion

More information

Stochastic Modelling in Climate Science

Stochastic Modelling in Climate Science Stochastic Modelling in Climate Science David Kelly Mathematics Department UNC Chapel Hill dtbkelly@gmail.com November 16, 2013 David Kelly (UNC) Stochastic Climate November 16, 2013 1 / 36 Why use stochastic

More information

Geometric projection of stochastic differential equations

Geometric projection of stochastic differential equations Geometric projection of stochastic differential equations John Armstrong (King s College London) Damiano Brigo (Imperial) August 9, 2018 Idea: Projection Idea: Projection Projection gives a method of systematically

More information

A numerical method for solving uncertain differential equations

A numerical method for solving uncertain differential equations Journal of Intelligent & Fuzzy Systems 25 (213 825 832 DOI:1.3233/IFS-12688 IOS Press 825 A numerical method for solving uncertain differential equations Kai Yao a and Xiaowei Chen b, a Department of Mathematical

More information

Econ 623 Econometrics II Topic 2: Stationary Time Series

Econ 623 Econometrics II Topic 2: Stationary Time Series 1 Introduction Econ 623 Econometrics II Topic 2: Stationary Time Series In the regression model we can model the error term as an autoregression AR(1) process. That is, we can use the past value of the

More information

Lecture on Parameter Estimation for Stochastic Differential Equations. Erik Lindström

Lecture on Parameter Estimation for Stochastic Differential Equations. Erik Lindström Lecture on Parameter Estimation for Stochastic Differential Equations Erik Lindström Recap We are interested in the parameters θ in the Stochastic Integral Equations X(t) = X(0) + t 0 µ θ (s, X(s))ds +

More information

1 Brownian Local Time

1 Brownian Local Time 1 Brownian Local Time We first begin by defining the space and variables for Brownian local time. Let W t be a standard 1-D Wiener process. We know that for the set, {t : W t = } P (µ{t : W t = } = ) =

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

1. Stochastic Process

1. Stochastic Process HETERGENEITY IN QUANTITATIVE MACROECONOMICS @ TSE OCTOBER 17, 216 STOCHASTIC CALCULUS BASICS SANG YOON (TIM) LEE Very simple notes (need to add references). It is NOT meant to be a substitute for a real

More information

On the Strong Approximation of Jump-Diffusion Processes

On the Strong Approximation of Jump-Diffusion Processes QUANTITATIV FINANC RSARCH CNTR QUANTITATIV FINANC RSARCH CNTR Research Paper 157 April 25 On the Strong Approximation of Jump-Diffusion Processes Nicola Bruti-Liberati and ckhard Platen ISSN 1441-81 www.qfrc.uts.edu.au

More information

Nested Uncertain Differential Equations and Its Application to Multi-factor Term Structure Model

Nested Uncertain Differential Equations and Its Application to Multi-factor Term Structure Model Nested Uncertain Differential Equations and Its Application to Multi-factor Term Structure Model Xiaowei Chen International Business School, Nankai University, Tianjin 371, China School of Finance, Nankai

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

Affine Processes. Econometric specifications. Eduardo Rossi. University of Pavia. March 17, 2009

Affine Processes. Econometric specifications. Eduardo Rossi. University of Pavia. March 17, 2009 Affine Processes Econometric specifications Eduardo Rossi University of Pavia March 17, 2009 Eduardo Rossi (University of Pavia) Affine Processes March 17, 2009 1 / 40 Outline 1 Affine Processes 2 Affine

More information

Statistical methods for financial models driven by Lévy processes

Statistical methods for financial models driven by Lévy processes Statistical methods for financial models driven by Lévy processes Part IV: Some Non-parametric Methods for Lévy Models José Enrique Figueroa-López 1 1 Department of Statistics Purdue University PASI CIMAT,

More information

Numerical Methods with Lévy Processes

Numerical Methods with Lévy Processes Numerical Methods with Lévy Processes 1 Objective: i) Find models of asset returns, etc ii) Get numbers out of them. Why? VaR and risk management Valuing and hedging derivatives Why not? Usual assumption:

More information

Stochastic Calculus. Kevin Sinclair. August 2, 2016

Stochastic Calculus. Kevin Sinclair. August 2, 2016 Stochastic Calculus Kevin Sinclair August, 16 1 Background Suppose we have a Brownian motion W. This is a process, and the value of W at a particular time T (which we write W T ) is a normally distributed

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

Filtrations, Markov Processes and Martingales. Lectures on Lévy Processes and Stochastic Calculus, Braunschweig, Lecture 3: The Lévy-Itô Decomposition

Filtrations, Markov Processes and Martingales. Lectures on Lévy Processes and Stochastic Calculus, Braunschweig, Lecture 3: The Lévy-Itô Decomposition Filtrations, Markov Processes and Martingales Lectures on Lévy Processes and Stochastic Calculus, Braunschweig, Lecture 3: The Lévy-Itô Decomposition David pplebaum Probability and Statistics Department,

More information

Let (Ω, F) be a measureable space. A filtration in discrete time is a sequence of. F s F t

Let (Ω, F) be a measureable space. A filtration in discrete time is a sequence of. F s F t 2.2 Filtrations Let (Ω, F) be a measureable space. A filtration in discrete time is a sequence of σ algebras {F t } such that F t F and F t F t+1 for all t = 0, 1,.... In continuous time, the second condition

More information

Brownian motion. Samy Tindel. Purdue University. Probability Theory 2 - MA 539

Brownian motion. Samy Tindel. Purdue University. Probability Theory 2 - MA 539 Brownian motion Samy Tindel Purdue University Probability Theory 2 - MA 539 Mostly taken from Brownian Motion and Stochastic Calculus by I. Karatzas and S. Shreve Samy T. Brownian motion Probability Theory

More information

Brief Review on Estimation Theory

Brief Review on Estimation Theory Brief Review on Estimation Theory K. Abed-Meraim ENST PARIS, Signal and Image Processing Dept. abed@tsi.enst.fr This presentation is essentially based on the course BASTA by E. Moulines Brief review on

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

Pathwise volatility in a long-memory pricing model: estimation and asymptotic behavior

Pathwise volatility in a long-memory pricing model: estimation and asymptotic behavior Pathwise volatility in a long-memory pricing model: estimation and asymptotic behavior Ehsan Azmoodeh University of Vaasa Finland 7th General AMaMeF and Swissquote Conference September 7 1, 215 Outline

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

Multivariate Generalized Ornstein-Uhlenbeck Processes

Multivariate Generalized Ornstein-Uhlenbeck Processes Multivariate Generalized Ornstein-Uhlenbeck Processes Anita Behme TU München Alexander Lindner TU Braunschweig 7th International Conference on Lévy Processes: Theory and Applications Wroclaw, July 15 19,

More information

ELEG 3143 Probability & Stochastic Process Ch. 6 Stochastic Process

ELEG 3143 Probability & Stochastic Process Ch. 6 Stochastic Process Department of Electrical Engineering University of Arkansas ELEG 3143 Probability & Stochastic Process Ch. 6 Stochastic Process Dr. Jingxian Wu wuj@uark.edu OUTLINE 2 Definition of stochastic process (random

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

Introduction to Diffusion Processes.

Introduction to Diffusion Processes. Introduction to Diffusion Processes. Arka P. Ghosh Department of Statistics Iowa State University Ames, IA 511-121 apghosh@iastate.edu (515) 294-7851. February 1, 21 Abstract In this section we describe

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

Time Series 4. Robert Almgren. Oct. 5, 2009

Time Series 4. Robert Almgren. Oct. 5, 2009 Time Series 4 Robert Almgren Oct. 5, 2009 1 Nonstationarity How should you model a process that has drift? ARMA models are intrinsically stationary, that is, they are mean-reverting: when the value of

More information

A MODEL FOR THE LONG-TERM OPTIMAL CAPACITY LEVEL OF AN INVESTMENT PROJECT

A MODEL FOR THE LONG-TERM OPTIMAL CAPACITY LEVEL OF AN INVESTMENT PROJECT A MODEL FOR HE LONG-ERM OPIMAL CAPACIY LEVEL OF AN INVESMEN PROJEC ARNE LØKKA AND MIHAIL ZERVOS Abstract. We consider an investment project that produces a single commodity. he project s operation yields

More information

WEAK VERSIONS OF STOCHASTIC ADAMS-BASHFORTH AND SEMI-IMPLICIT LEAPFROG SCHEMES FOR SDES. 1. Introduction

WEAK VERSIONS OF STOCHASTIC ADAMS-BASHFORTH AND SEMI-IMPLICIT LEAPFROG SCHEMES FOR SDES. 1. Introduction WEAK VERSIONS OF STOCHASTIC ADAMS-BASHFORTH AND SEMI-IMPLICIT LEAPFROG SCHEMES FOR SDES BRIAN D. EWALD 1 Abstract. We consider the weak analogues of certain strong stochastic numerical schemes considered

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

Stochastic contraction BACS Workshop Chamonix, January 14, 2008

Stochastic contraction BACS Workshop Chamonix, January 14, 2008 Stochastic contraction BACS Workshop Chamonix, January 14, 2008 Q.-C. Pham N. Tabareau J.-J. Slotine Q.-C. Pham, N. Tabareau, J.-J. Slotine () Stochastic contraction 1 / 19 Why stochastic contraction?

More information

An introduction to Lévy processes

An introduction to Lévy processes with financial modelling in mind Department of Statistics, University of Oxford 27 May 2008 1 Motivation 2 3 General modelling with Lévy processes Modelling financial price processes Quadratic variation

More information

Asymptotics for posterior hazards

Asymptotics for posterior hazards Asymptotics for posterior hazards Pierpaolo De Blasi University of Turin 10th August 2007, BNR Workshop, Isaac Newton Intitute, Cambridge, UK Joint work with Giovanni Peccati (Université Paris VI) and

More information

Nonlinear GMM. Eric Zivot. Winter, 2013

Nonlinear GMM. Eric Zivot. Winter, 2013 Nonlinear GMM Eric Zivot Winter, 2013 Nonlinear GMM estimation occurs when the GMM moment conditions g(w θ) arenonlinearfunctionsofthe model parameters θ The moment conditions g(w θ) may be nonlinear functions

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

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

Understanding Regressions with Observations Collected at High Frequency over Long Span

Understanding Regressions with Observations Collected at High Frequency over Long Span Understanding Regressions with Observations Collected at High Frequency over Long Span Yoosoon Chang Department of Economics, Indiana University Joon Y. Park Department of Economics, Indiana University

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

A variational radial basis function approximation for diffusion processes

A variational radial basis function approximation for diffusion processes A variational radial basis function approximation for diffusion processes Michail D. Vrettas, Dan Cornford and Yuan Shen Aston University - Neural Computing Research Group Aston Triangle, Birmingham B4

More information

On pathwise stochastic integration

On pathwise stochastic integration On pathwise stochastic integration Rafa l Marcin Lochowski Afican Institute for Mathematical Sciences, Warsaw School of Economics UWC seminar Rafa l Marcin Lochowski (AIMS, WSE) On pathwise stochastic

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

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

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

Moment Properties of Distributions Used in Stochastic Financial Models

Moment Properties of Distributions Used in Stochastic Financial Models Moment Properties of Distributions Used in Stochastic Financial Models Jordan Stoyanov Newcastle University (UK) & University of Ljubljana (Slovenia) e-mail: stoyanovj@gmail.com ETH Zürich, Department

More information

Linear Filtering of general Gaussian processes

Linear Filtering of general Gaussian processes Linear Filtering of general Gaussian processes Vít Kubelka Advisor: prof. RNDr. Bohdan Maslowski, DrSc. Robust 2018 Department of Probability and Statistics Faculty of Mathematics and Physics Charles University

More information

Parameter estimation of diffusion models

Parameter estimation of diffusion models 129 Parameter estimation of diffusion models Miljenko Huzak Abstract. Parameter estimation problems of diffusion models are discussed. The problems of maximum likelihood estimation and model selections

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

Bayesian inference for stochastic differential mixed effects models - initial steps

Bayesian inference for stochastic differential mixed effects models - initial steps Bayesian inference for stochastic differential ixed effects odels - initial steps Gavin Whitaker 2nd May 2012 Supervisors: RJB and AG Outline Mixed Effects Stochastic Differential Equations (SDEs) Bayesian

More information

Introduction Optimality and Asset Pricing

Introduction Optimality and Asset Pricing Introduction Optimality and Asset Pricing Andrea Buraschi Imperial College Business School October 2010 The Euler Equation Take an economy where price is given with respect to the numéraire, which is our

More information

Estimation Theory. as Θ = (Θ 1,Θ 2,...,Θ m ) T. An estimator

Estimation Theory. as Θ = (Θ 1,Θ 2,...,Θ m ) T. An estimator Estimation Theory Estimation theory deals with finding numerical values of interesting parameters from given set of data. We start with formulating a family of models that could describe how the data were

More information

Prof. Dr. Roland Füss Lecture Series in Applied Econometrics Summer Term Introduction to Time Series Analysis

Prof. Dr. Roland Füss Lecture Series in Applied Econometrics Summer Term Introduction to Time Series Analysis Introduction to Time Series Analysis 1 Contents: I. Basics of Time Series Analysis... 4 I.1 Stationarity... 5 I.2 Autocorrelation Function... 9 I.3 Partial Autocorrelation Function (PACF)... 14 I.4 Transformation

More information

The multidimensional Ito Integral and the multidimensional Ito Formula. Eric Mu ller June 1, 2015 Seminar on Stochastic Geometry and its applications

The multidimensional Ito Integral and the multidimensional Ito Formula. Eric Mu ller June 1, 2015 Seminar on Stochastic Geometry and its applications The multidimensional Ito Integral and the multidimensional Ito Formula Eric Mu ller June 1, 215 Seminar on Stochastic Geometry and its applications page 2 Seminar on Stochastic Geometry and its applications

More information

Estimates for the density of functionals of SDE s with irregular drift

Estimates for the density of functionals of SDE s with irregular drift Estimates for the density of functionals of SDE s with irregular drift Arturo KOHATSU-HIGA a, Azmi MAKHLOUF a, a Ritsumeikan University and Japan Science and Technology Agency, Japan Abstract We obtain

More information

Estimating AR/MA models

Estimating AR/MA models September 17, 2009 Goals The likelihood estimation of AR/MA models AR(1) MA(1) Inference Model specification for a given dataset Why MLE? Traditional linear statistics is one methodology of estimating

More information

Inference for Lévy-Driven Continuous-Time ARMA Processes

Inference for Lévy-Driven Continuous-Time ARMA Processes Inference for Lévy-Driven Continuous-Time ARMA Processes Peter J. Brockwell Richard A. Davis Yu Yang Colorado State University May 23, 2007 Outline Background Lévy-driven CARMA processes Second order properties

More information

ELEMENTS OF PROBABILITY THEORY

ELEMENTS OF PROBABILITY THEORY ELEMENTS OF PROBABILITY THEORY Elements of Probability Theory A collection of subsets of a set Ω is called a σ algebra if it contains Ω and is closed under the operations of taking complements and countable

More information

Stochastic Processes and Advanced Mathematical Finance

Stochastic Processes and Advanced Mathematical Finance Steven R. Dunbar Department of Mathematics 23 Avery Hall University of Nebraska-Lincoln Lincoln, NE 68588-13 http://www.math.unl.edu Voice: 42-472-3731 Fax: 42-472-8466 Stochastic Processes and Advanced

More information

Simulation Method for Solving Stochastic Differential Equations with Constant Diffusion Coefficients

Simulation Method for Solving Stochastic Differential Equations with Constant Diffusion Coefficients Journal of mathematics and computer Science 8 (2014) 28-32 Simulation Method for Solving Stochastic Differential Equations with Constant Diffusion Coefficients Behrouz Fathi Vajargah Department of statistics,

More information

Regular Variation and Extreme Events for Stochastic Processes

Regular Variation and Extreme Events for Stochastic Processes 1 Regular Variation and Extreme Events for Stochastic Processes FILIP LINDSKOG Royal Institute of Technology, Stockholm 2005 based on joint work with Henrik Hult www.math.kth.se/ lindskog 2 Extremes for

More information

Information and Credit Risk

Information and Credit Risk Information and Credit Risk M. L. Bedini Université de Bretagne Occidentale, Brest - Friedrich Schiller Universität, Jena Jena, March 2011 M. L. Bedini (Université de Bretagne Occidentale, Brest Information

More information

State-Space Methods for Inferring Spike Trains from Calcium Imaging

State-Space Methods for Inferring Spike Trains from Calcium Imaging State-Space Methods for Inferring Spike Trains from Calcium Imaging Joshua Vogelstein Johns Hopkins April 23, 2009 Joshua Vogelstein (Johns Hopkins) State-Space Calcium Imaging April 23, 2009 1 / 78 Outline

More information

Man Kyu Im*, Un Cig Ji **, and Jae Hee Kim ***

Man Kyu Im*, Un Cig Ji **, and Jae Hee Kim *** JOURNAL OF THE CHUNGCHEONG MATHEMATICAL SOCIETY Volume 19, No. 4, December 26 GIRSANOV THEOREM FOR GAUSSIAN PROCESS WITH INDEPENDENT INCREMENTS Man Kyu Im*, Un Cig Ji **, and Jae Hee Kim *** Abstract.

More information

Stochastic Processes

Stochastic Processes Stochastic Processes A very simple introduction Péter Medvegyev 2009, January Medvegyev (CEU) Stochastic Processes 2009, January 1 / 54 Summary from measure theory De nition (X, A) is a measurable space

More information

Multi-Factor Lévy Models I: Symmetric alpha-stable (SαS) Lévy Processes

Multi-Factor Lévy Models I: Symmetric alpha-stable (SαS) Lévy Processes Multi-Factor Lévy Models I: Symmetric alpha-stable (SαS) Lévy Processes Anatoliy Swishchuk Department of Mathematics and Statistics University of Calgary Calgary, Alberta, Canada Lunch at the Lab Talk

More information

Some Tools From Stochastic Analysis

Some Tools From Stochastic Analysis W H I T E Some Tools From Stochastic Analysis J. Potthoff Lehrstuhl für Mathematik V Universität Mannheim email: potthoff@math.uni-mannheim.de url: http://ls5.math.uni-mannheim.de To close the file, click

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

Estimation for the standard and geometric telegraph process. Stefano M. Iacus. (SAPS VI, Le Mans 21-March-2007)

Estimation for the standard and geometric telegraph process. Stefano M. Iacus. (SAPS VI, Le Mans 21-March-2007) Estimation for the standard and geometric telegraph process Stefano M. Iacus University of Milan(Italy) (SAPS VI, Le Mans 21-March-2007) 1 1. Telegraph process Consider a particle moving on the real line

More information

Towards inference for skewed alpha stable Levy processes

Towards inference for skewed alpha stable Levy processes Towards inference for skewed alpha stable Levy processes Simon Godsill and Tatjana Lemke Signal Processing and Communications Lab. University of Cambridge www-sigproc.eng.cam.ac.uk/~sjg Overview Motivation

More information

Estimating Functions for Discretely Sampled Diffusion-Type Models

Estimating Functions for Discretely Sampled Diffusion-Type Models Estimating Functions for Discretely Sampled Diffusion-Type Models Bo Martin Bibby Institute of Mathematics and Physics The Royal Veterinary and Agricultural University Thorvaldsensvej 40 DK-1871 Frederiksberg

More information

Ernesto Mordecki 1. Lecture III. PASI - Guanajuato - June 2010

Ernesto Mordecki 1. Lecture III. PASI - Guanajuato - June 2010 Optimal stopping for Hunt and Lévy processes Ernesto Mordecki 1 Lecture III. PASI - Guanajuato - June 2010 1Joint work with Paavo Salminen (Åbo, Finland) 1 Plan of the talk 1. Motivation: from Finance

More information

A Short Introduction to Diffusion Processes and Ito Calculus

A Short Introduction to Diffusion Processes and Ito Calculus A Short Introduction to Diffusion Processes and Ito Calculus Cédric Archambeau University College, London Center for Computational Statistics and Machine Learning c.archambeau@cs.ucl.ac.uk January 24,

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

A nonparametric method of multi-step ahead forecasting in diffusion processes

A nonparametric method of multi-step ahead forecasting in diffusion processes A nonparametric method of multi-step ahead forecasting in diffusion processes Mariko Yamamura a, Isao Shoji b a School of Pharmacy, Kitasato University, Minato-ku, Tokyo, 108-8641, Japan. b Graduate School

More information

Some functional (Hölderian) limit theorems and their applications (II)

Some functional (Hölderian) limit theorems and their applications (II) Some functional (Hölderian) limit theorems and their applications (II) Alfredas Račkauskas Vilnius University Outils Statistiques et Probabilistes pour la Finance Université de Rouen June 1 5, Rouen (Rouen

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