Quasi-Monte Carlo Algorithms with Applications in Numerical Analysis and Finance

Size: px
Start display at page:

Download "Quasi-Monte Carlo Algorithms with Applications in Numerical Analysis and Finance"

Transcription

1 Quasi-Monte Carlo Algorithms with Applications in Numerical Analysis and Finance Reinhold F. Kainhofer Rigorosumsvortrag, Institut für Mathematik Graz, 16. Mai 2003

2 Inhalt 1. Quasi-Monte Carlo Methoden 2. Sublineare Dividendenschranken in der Risikotheorie 3. Runge-Kutte QMC Methoden für retardierte Differentialgleichungen (a) Lösungsskizze des Algorithmus (b) RKQMC Lösungsmethoden (Hermite Interpolation, QMC Methoden) (c) Konvergenzbeweis (d) Numerische Beispiele 4. QMC Methoden für singuläre gewichtete Integration (a) Konvergenztheorem und -beweis (b) Hlawka-Mück Konstruktion (c) Numerisches Beispiel (Bewertung von asiatischen Optionen)

3 Quasi-Monte Carlo methods Integrals approximated by a discrete sum over N (quasi-)random points: f(x)dx = 1 [0,1] s N N f(x i ) i=1

4 Quasi-Monte Carlo methods Integrals approximated by a discrete sum over N (quasi-)random points: MC methods: x i random points [0,1] s f(x)dx = 1 N N f(x i ) QMC methods: x i low-discrepancy sequences Low discrepancy sequences: deterministic point sequences {x i } 1 n N [0, 1) s, good uniform distribution i=1

5 Quasi-Monte Carlo methods Integrals approximated by a discrete sum over N (quasi-)random points: MC methods: x i random points [0,1] s f(x)dx = 1 N N f(x i ) QMC methods: x i low-discrepancy sequences Low discrepancy sequences: deterministic point sequences {x i } 1 n N [0, 1) s, good uniform distribution discrepancy of the point set S D N (S) = sup J [0,1] s i=1 A(J, S) N λ s (J )

6 Quasi-Monte Carlo methods Integrals approximated by a discrete sum over N (quasi-)random points: MC methods: x i random points [0,1] s f(x)dx = 1 N N f(x i ) QMC methods: x i low-discrepancy sequences Low discrepancy sequences: deterministic point sequences {x i } 1 n N [0, 1) s, good uniform distribution discrepancy of the point set S D N (S) = sup J [0,1] s i=1 A(J, S) N λ s (J ) Koksma-Hlawka inequality (f of bounded Variation): 1 N N f(x n ) f(u)du [0,1) V ([0, 1)s, f)dn (x 1,..., x N ). s n=1

7 Low-Discrepancy sequences ( (log N) DN s ) (S) O N

8 Low-Discrepancy sequences ( (log N) DN s ) (S) O Halton-sequence in bases (b 1,... b s ): inversion of digit expansion of n in base b i at the comma (t, s) nets in base b (Niederreiter, Sobol, Faure): net-like structure best possible uniform distribution on elementary intervals N

9 Low-Discrepancy sequences ( (log N) DN s ) (S) O Halton-sequence in bases (b 1,... b s ): inversion of digit expansion of n in base b i at the comma (t, s) nets in base b (Niederreiter, Sobol, Faure): net-like structure best possible uniform distribution on elementary intervals N 1 Monte Carlo, 3000 points 1 Halton sequence, 3000 points

10 Low-Discrepancy sequences ( (log N) DN s ) (S) O Halton-sequence in bases (b 1,... b s ): inversion of digit expansion of n in base b i at the comma (t, s) nets in base b (Niederreiter, Sobol, Faure): net-like structure best possible uniform distribution on elementary intervals N 1 Monte Carlo, 3000 points 1 Halton sequence, 3000 points Problem: correlations between elements

11 Risk Model with constant interest force and non-linear dividend barrier reserve R t dividends dividend barrier b claims ~ F(y) premiums t b x ruin time t φ(u, b)... probability of survival W (u, b)... expected value of discounted dividend payments

12 Integro-differential equation for W (u, b): (c+i u) W u + 1 α m b m 1 W b (i+λ) W + λ u 0 W (u z,b)df (z)=0 with boundary condition W u u=b = 1. Solution is fixed point of integral operator apply it iteratively or recursively Ag(u, b) = + t 0 ( (c λe (λ+i)t +u)e it c ( g (c + u)e it c z, b m + t ) ) 1/m df (z)dt 0 α ( (b m + α) t 1/m ( g b m + t ) 1/m ( z, b m + t ) ) 1/m df (z)dt 0 α α ( ) t + λe λt e is (c + i u)e is 1 t t mα ( b m + α s ) 1 1/m ds dt, λe (λ+i)t t = Solution is just a high-dimensional integration problem.

13 Numerical solution of delayed differential equations using QMC methods 1. Sketch of the numerical solution 2. The RKQMC solution methods (Hermite Interpolation, QMC methods) 3. Convergence proofs 4. Numerical examples

14 The problem Heavily varying delay differential equations (DDE) or DDE with heavily varying solutions. y (t) = f (t, y(t), y(t τ 1 (t)),..., y(t τ k (t))), for t t 0, k 1, y(t) = φ(t), for t t 0, with

15 The problem Heavily varying delay differential equations (DDE) or DDE with heavily varying solutions. y (t) = f (t, y(t), y(t τ 1 (t)),..., y(t τ k (t))), for t t 0, k 1, y(t) = φ(t), for t t 0, with f(t, y(t), y ret (t))...piecewise smooth in y and y ret, bounded and Borel measurable in t y(t)...solution, d-dimensional real-valued function τ 1 (t),..., τ k (t)...cont. delay functions, bounded from below by τ 0 > 0, satisfy t 1 τ j (t 1 ) t 2 τ j (t 2 ) for t 1 t [ 2 ] φ(t)...initial function, cont. on inf (t τ j(t)), t 0. t 0 t,1 j k

16 Sketch of the numerical solution For heavily oscillating DDE: conventional Runge-Kutta methods unstable. Hermite interpolation for retarded argument ODE

17 Sketch of the numerical solution For heavily oscillating DDE: conventional Runge-Kutta methods unstable. Hermite interpolation for retarded argument ODE use RKQMC methods for ODE: Large Runge-Kutta error for heavily oscillating DE Idea (Stengle, Lécot): integrate over whole step size

18 Sketch of the numerical solution For heavily oscillating DDE: conventional Runge-Kutta methods unstable. Hermite interpolation for retarded argument ODE use RKQMC methods for ODE: Large Runge-Kutta error for heavily oscillating DE Idea (Stengle, Lécot): integrate over whole step size Runge Kutta: Integration over y and t discretized RK(Q)MC: Integration over y discretized, numerical Integration in t (using MC or QMC integration to minimize the error)

19 Hermite interpolation Use hermite interpolation for the retarded arguments:

20 Hermite interpolation Use hermite interpolation for the retarded arguments: z j (t) := y(t τ j (t)) = { φ(t τ j (t)), if t τ j (t) t 0 P q (t τ j (t); (y i ); (y i )) otherwise

21 Hermite interpolation Use hermite interpolation for the retarded arguments: z j (t) := y(t τ j (t)) = DDE transforms to a ODE: { φ(t τ j (t)), if t τ j (t) t 0 P q (t τ j (t); (y i ); (y i )) otherwise y (t) = f(t, y(t), y(t τ 1 (t)),..., y(t τ k (t))) f(t, y(t), z 1 (t),..., z k (t)) =: g(t, y(t)).

22 Hermite interpolation Use hermite interpolation for the retarded arguments: z j (t) := y(t τ j (t)) = DDE transforms to a ODE: { φ(t τ j (t)), if t τ j (t) t 0 P q (t τ j (t); (y i ); (y i )) otherwise y (t) = f(t, y(t), y(t τ 1 (t)),..., y(t τ k (t))) f(t, y(t), z 1 (t),..., z k (t)) =: g(t, y(t)). Solution has to be piecewise r/2-times continuously differentiable in t.

23 Hermite interpolation Use hermite interpolation for the retarded arguments: z j (t) := y(t τ j (t)) = DDE transforms to a ODE: { φ(t τ j (t)), if t τ j (t) t 0 P q (t τ j (t); (y i ); (y i )) otherwise y (t) = f(t, y(t), y(t τ 1 (t)),..., y(t τ k (t))) f(t, y(t), z 1 (t),..., z k (t)) =: g(t, y(t)). Solution has to be piecewise r/2-times continuously differentiable in t. Resulting ODE has to fulfill requirements for RKQMC methods (Borelmeasurable in t, continously differentiable in y(t)).

24 Runge Kutta QMC methods for ODE G. Stengle, Ch. Lécot, I. Coulibaly, A. Koudiraty y (t) = f(t, y(t)), 0 < t < T, y(0) = y 0 f smooth in y, bounded and Borel measurable in t.

25 Runge Kutta QMC methods for ODE G. Stengle, Ch. Lécot, I. Coulibaly, A. Koudiraty y (t) = f(t, y(t)), 0 < t < T, y(0) = y 0 f smooth in y, bounded and Borel measurable in t. f is Taylor-expanded only in y integral equation in t.

26 Runge Kutta QMC methods for ODE G. Stengle, Ch. Lécot, I. Coulibaly, A. Koudiraty y (t) = f(t, y(t)), 0 < t < T, y(0) = y 0 f smooth in y, bounded and Borel measurable in t. f is Taylor-expanded only in y integral equation in t. y n+1 = y n + h n s!n 0 j<n G s ( t j,n ; y) G s ( t j,n ; y)... differential increment function of scheme

27 Runge Kutta QMC methods for ODE G. Stengle, Ch. Lécot, I. Coulibaly, A. Koudiraty y (t) = f(t, y(t)), 0 < t < T, y(0) = y 0 f smooth in y, bounded and Borel measurable in t. f is Taylor-expanded only in y integral equation in t. y n+1 = y n + h n s!n 0 j<n G s ( t j,n ; y) G s ( t j,n ; y)... differential increment function of scheme G 1 (u; y) = f (u, y) G 2 (ū; y) = f (ū 1, y) + 1 β f (ū 2, y)) + 1 α f (ū 2, y + αh n f (ū 1, y))) L 2 G 3 (ū; y) = a 1 f(ū 1, y) + a 2,l f ( ū 2, y + b 2,l h n f(ū 1, y) ) + l=1 l=1 L 3 ( + a 3,l ū 3, y + b (1) 3,l h nf (ū 1, y) + b (2) 3,l h nf ( ū 2, y n + c 3,l h n (ū 1, y n ) ))

28 RKQMC for Volterra functional equations y (t) = f(t, y(t), z(t)) t t 0 z(t) = (F y)(t) y(s) = φ(s) s t 0

29 RKQMC for Volterra functional equations y (t) = f(t, y(t), z(t)) t t 0 z(t) = (F y)(t) y(s) = φ(s) s t 0 (F y)(t) contains dependence on retarded values. F and f are Lipschitz continuous in all arguments except t.

30 RKQMC for Volterra functional equations y (t) = f(t, y(t), z(t)) t t 0 z(t) = (F y)(t) y(s) = φ(s) s t 0 (F y)(t) contains dependence on retarded values. F and f are Lipschitz continuous in all arguments except t. RKQMC method (n 0): y n+1 = y n + h n z(t) = ( F y j )(t) N i=1 G s (t n,i ; y n, z(t))

31 Convergence: RKQMC for DDE Theorem[K., 2002] If (i) RKQMC method converges for ordinary differential equations with order p (ii) the increment function G s of the method and F are Lipschitz (iii) the interpolation fulfills a Lipschitz condition (iv) Hermite interpolation is used with order r (v) the initial error e 0 vanishes then the method converges.

32 Convergence: RKQMC for DDE Theorem[K., 2002] If (i) RKQMC method converges for ordinary differential equations with order p (ii) the increment function G s of the method and F are Lipschitz (iii) the interpolation fulfills a Lipschitz condition (iv) Hermite interpolation is used with order r (v) the initial error e 0 vanishes then the method converges. If at least ii and iii hold, the error is bounded by e j+1 e 0 e Lt j + (et jl 1) L ( E ODE + L1 L 2 E interpol ). G r

33 Special case: one retarded argument Choose the RKQMC method: G s Lipschitz (L 2 ) in 2 nd and 3 rd argument, bounded variation (in the sense of Hardy and Krause). c 1, c 2, c 3 such that for a p > 0 loc. trunc. error ɛ n c 1 (h n )h p n RK error δ n c 2 (h n ) e n QMC error d n c 3 (h n )D N (S) interpolation order p, fulfils a certain Lipschitz condition

34 Special case: one retarded argument Choose the RKQMC method: G s Lipschitz (L 2 ) in 2 nd and 3 rd argument, bounded variation (in the sense of Hardy and Krause). c 1, c 2, c 3 such that for a p > 0 loc. trunc. error ɛ n c 1 (h n )h p n RK error δ n c 2 (h n ) e n QMC error d n c 3 (h n )D N (S) interpolation order p, fulfils a certain Lipschitz condition Then the error e n = y n y(t n ) of the method is bounded from above by: e n e 0 e t n(c 2 + L 2 s! ) e t n(c 2 + L2 s! ) 1 + c 2 + L 2 s! { c 3 DN(X) + L } 2 s! MHq + c 1 H p

35 Numerical examples y (t) = 3y(t 1) sin(λt) + 2y(t 1.5) cos(λt), t 0 y(t) = 1, t 0,

36 Numerical examples y (t) = 3y(t 1) sin(λt) + 2y(t 1.5) cos(λt), t 0 y(t) = 1, t 0, Log 2 S meth,λ Log 2 Λ Butcher Heun Runge RKQMC1, N 1000 RKQMC2, N 1000 RKQMC3, N 1000 RKQMC3, N 100 RKQMC3, N 10 Fig: Error of the RK and RKQMC methods, h n = for RK, h n = 0.01 for RKQMC

37 Numerical examples y (t) = 3y(t 1) sin(λt) + 2y(t 1.5) cos(λt), t 0 y(t) = 1, t 0, Log 2 S meth,λ Log 2 Λ Butcher Heun Runge RKQMC1, N 1000 RKQMC2, N 1000 RKQMC3, N 1000 RKQMC3, N 100 RKQMC3, N 10 Fig: Error of the RK and RKQMC methods, h n = for RK, h n = 0.01 for RKQMC slowly varying (small λ): conventional RK better rapidly varying (high λ): RKQMC outperform higher order RK

38 Advantage of RKQMC for unstable DDE y (t) = π λ 2 ( ( y t 2 3 ) ( y t 2 1 )), t 0 2λ 2λ y(t) = sin(λtπ), t < 0,

39 Advantage of RKQMC for unstable DDE y (t) = π λ 2 ( ( y t 2 3 ) ( y t 2 1 )), t 0 2λ 2λ y(t) = sin(λtπ), t < 0, Exact Solution: y(t) = sin(λtπ) No discontinuities in any derivative k-th derivative only bounded by λ k exploding error

40 Advantage of RKQMC for unstable DDE y (t) = π λ 2 ( ( y t 2 3 ) ( y t 2 1 )), t 0 2λ 2λ y(t) = sin(λtπ), t < 0, Exact Solution: y(t) = sin(λtπ) No discontinuities in any derivative k-th derivative only bounded by λ k exploding error Log 2 S Λ, meth Butcher Heun Runge RKQMC1, N 1000 RKQMC2, N 1000 RKQMC3, N Log 2 Λ RKQMC schemes can delay the instability of the solution for heavily oscillating delay differential equations.

41 Time-corrected error QMC integration is more expensive than 1 evaluation (Runge-Kutta)

42 Time-corrected error QMC integration is more expensive than 1 evaluation (Runge-Kutta) Compare a time-corrected error

43 Time-corrected error QMC integration is more expensive than 1 evaluation (Runge-Kutta) Compare a time-corrected error Log 2 S Λ, meth T Log 2 Λ Butcher Heun Runge RKQMC1, N 1000 RKQMC2, N 1000 RKQMC3, N 1000 Fig: Time-corrected error of the RK and RKQMC methods Result: RKQMC methods loose some advantage, but still better than Runge-Kutta for heavily oscillating DDE.

44 Non-uniform QMC integration of singular integrands 1. Convergence theorem 2. Sketch of proof 3. Hlawka-Mück construction for h-distributed low-discrepancy sequences 4. Numerical example (pricing of Asian options)

45 H-Diskrepancy H-discrepancy of a sequence ω = (y 1, y 2,... ): D N,H (ω) = sup 1 J L N A N(J, ω) H(J), with L... support [ of H, J... intervals a, ] b, A N... number of elements of ω lying in J.

46 H-Diskrepancy H-discrepancy of a sequence ω = (y 1, y 2,... ): D N,H (ω) = sup 1 J L N A N(J, ω) H(J), with L... support [ of H, J... intervals a, ] b, A N... number of elements of ω lying in J. Koksma-Hlawka inequality (arbitrary distribution) Let f a function of bounded variation (in the sense of Hardy and Krause) on L and ω = (y 1, y 2,... ) a sequence on L. Then f(x)dh(x) 1 N f(y n ) L N V (f)d N,H(ω). n=1

47 Convergence of the multidimensional QMC estimator

48 Convergence of the multidimensional QMC estimator Theorem[Hartinger, K., Tichy, 2003] Let f(x) be a function on L = [a, b] with singularities only at the left boundary of the definition interval (i.e. f ± only if x (j) a j for at least one j),

49 Convergence of the multidimensional QMC estimator Theorem[Hartinger, K., Tichy, 2003] Let f(x) be a function on L = [a, b] with singularities only at the left boundary of the definition interval (i.e. f ± only if x (j) a j for at least one j), and let furthermore c N,j = min 1 n N y(j) n a j < c j c N,j.

50 Convergence of the multidimensional QMC estimator Theorem[Hartinger, K., Tichy, 2003] Let f(x) be a function on L = [a, b] with singularities only at the left boundary of the definition interval (i.e. f ± only if x (j) a j for at least one j), and let furthermore c N,j = min 1 n N y(j) n a j < c j c N,j. If the improper integral exists, and if D N,H (ω) V [c,b] (f) = o(1), then the QMC estimator converges to the value of the improper integral: lim N 1 N N f(y n ) = n=1 [a,b] f(x) dh(x).

51 Hlawka-Mück Transformation (1 dimension) ỹ k = 1 N N 1 + x k H(x r ) = 1 N r=1 N χ [0,xk ](H(x r )) r=1

52 Hlawka-Mück Transformation (1 dimension) ỹ k = 1 N N 1 + x k H(x r ) = 1 N r=1 N χ [0,xk ](H(x r )) r=1 D N,H ( ω) (1 + 2sM)D N (ω)

53 0 might appear among the ỹ k adapt the construction as follows (needed for singular integrands): We define the sequence ω for i = 1,..., N as: { ỹ ȳ k = k wenn ỹ k 1, N 1 wenn ỹ N k = 0.

54 0 might appear among the ỹ k adapt the construction as follows (needed for singular integrands): We define the sequence ω for i = 1,..., N as: { ỹ ȳ k = k wenn ỹ k 1, N 1 wenn ỹ N k = 0. The discrepancy of this sequence can be bounded as D N,H ( ω) (1 + 4M) s D N (ω).

55 Sample problem: Valuing Asian options arithmetic mean until expiration time Pay-Off (discrete Asian option, call) ( 1 n P (S T ) = S ti K n i=1 (S t ) t 0... price process, K... strike price S t = e X t with Levy process (X t ) t 0 Increments h i = X i X i 1 with distribution H (e.g. NIG, Variance-Gamma, Hyperbolic,...) ) +

56 NIG distribution Use the NIG distribution for the increments h i H Q. Advantage: closed under convolution dimension reduction, sample only weekly instead of daily Valuation Using fundamental theorem (Schachermayer): [( ) + ] C t0 := e r(t n t 0 ) E Q 1 n S ti K n r... constant interest rate Q... equivalent martingale measure (Esscher measure) i=1

57 NIG distribution Use the NIG distribution for the increments h i H Q. Advantage: closed under convolution dimension reduction, sample only weekly instead of daily Valuation Using fundamental theorem (Schachermayer): [( ) + ] C t0 := e r(t n t 0 ) E Q 1 n S ti K n r... constant interest rate Q... equivalent martingale measure (Esscher measure) i=1 Straigforward simulation (crude Monte Carlo): sample N price pathes and take the mean

58 Quasi-Monte Carlo schemes Problem: QMC numbers i.i.d. NIG(α, β, δ, µ)

59 Quasi-Monte Carlo schemes Problem: QMC numbers i.i.d. NIG(α, β, δ, µ) 2 Solutions: 1. Hlawka-Mück method for direct creation of (x n ) 1 n N i.i.d. NIG direct QMC calculation of the expectation value

60 Quasi-Monte Carlo schemes Problem: QMC numbers i.i.d. NIG(α, β, δ, µ) 2 Solutions: 1. Hlawka-Mück method for direct creation of (x n ) 1 n N i.i.d. NIG direct QMC calculation of the expectation value 2. Transformation of the integral using a suitable density (Ratio of uniforms, Hat ) variance reduction (if done right) Transformation Using a distribution K( x) = u: P ( x)f H( x)d x Q = P (K 1 (u)) f Q H(K 1 (u)) R n [0,1] n k(k 1 (u)) du Problem: Usual transformation F (x) = u leads to unbounded variation

61 Discrepancy for Hlawka-Mück The discrepancy of (y k ) 1 k N can be bounded by D N ((y k ), ρ) (2 + 6sM(ρ))D N ((y k )) with M(ρ) = sup ρ.

62 Discrepancy for Hlawka-Mück The discrepancy of (y k ) 1 k N can be bounded by with M(ρ) = sup ρ. QMC estimator D N ((y k ), ρ) (2 + 6sM(ρ))D N ((y k )) 1. Creation of low-discrepancy points with density f Q H (K 1 (x)) k(k 1 (x)) (Transformation of the integral R n to [0, 1] n using double-exponential distribution K(x))

63 Discrepancy for Hlawka-Mück The discrepancy of (y k ) 1 k N can be bounded by with M(ρ) = sup ρ. QMC estimator D N ((y k ), ρ) (2 + 6sM(ρ))D N ((y k )) 1. Creation of low-discrepancy points with density f Q H (K 1 (x)) k(k 1 (x)) (Transformation of the integral R n to [0, 1] n using double-exponential distribution K(x)) 2. Transformation [0, 1] n to R n of the sequence using doubleexponential distribution K 1 (x). Estimator similar to crude Monte Carlo

64 Numerical results (4 dimensions) Log 2 err dimensions N MC Import. samp. Ratio of unif. Hlawka Mück HM IS double exp. ROU and Hlawka-Mück are considerably better than Monte Carlo and control variate

65 Dimension 12 Log 2 err 12 dimensions N MC Import. samp. Ratio of unif. Hlawka Mück HM IS double exp. ROU looses performance Hlawka-Mück gives best results

Simulation methods in ruin models with non-linear dividend barriers

Simulation methods in ruin models with non-linear dividend barriers Simulation methods in ruin models with non-linear dividend barriers Hansjörg Albrecher, Reinhold Kainhofer, Robert F. Tichy Department of Mathematics, Graz University of Technology, Steyrergasse 3, A-8

More information

Quasi- Monte Carlo Multiple Integration

Quasi- Monte Carlo Multiple Integration Chapter 6 Quasi- Monte Carlo Multiple Integration Introduction In some sense, this chapter fits within Chapter 4 on variance reduction; in some sense it is stratification run wild. Quasi-Monte Carlo methods

More information

Lecture 4: Numerical solution of ordinary differential equations

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

More information

QMC methods in quantitative finance. and perspectives

QMC methods in quantitative finance. and perspectives , tradition and perspectives Johannes Kepler University Linz (JKU) WU Research Seminar What is the content of the talk Valuation of financial derivatives in stochastic market models using (QMC-)simulation

More information

Numerical Methods in Economics MIT Press, Chapter 9 Notes Quasi-Monte Carlo Methods. Kenneth L. Judd Hoover Institution.

Numerical Methods in Economics MIT Press, Chapter 9 Notes Quasi-Monte Carlo Methods. Kenneth L. Judd Hoover Institution. 1 Numerical Methods in Economics MIT Press, 1998 Chapter 9 Notes Quasi-Monte Carlo Methods Kenneth L. Judd Hoover Institution October 26, 2002 2 Quasi-Monte Carlo Methods Observation: MC uses random sequences

More information

HALTON SEQUENCES AVOID THE ORIGIN

HALTON SEQUENCES AVOID THE ORIGIN HALTON SEQUENCES AVOID THE ORIGIN ART B. OWEN STANFORD UNIVERSITY Abstract. The n th point of the Halton sequence in [0, 1] d is shown to have components whose product is larger than Cn 1 where C > 0 depends

More information

c Springer Verlag. The copyright for this contribution is held by Springer Verlag. The original publication is available at

c Springer Verlag. The copyright for this contribution is held by Springer Verlag. The original publication is available at c Springer Verlag. The copyright for this contribution is held by Springer Verlag. The original publication is available at www.springerlink.com. A Pragmatic view on umerical Integration of Unbounded Functions

More information

Improved Discrepancy Bounds for Hybrid Sequences. Harald Niederreiter. RICAM Linz and University of Salzburg

Improved Discrepancy Bounds for Hybrid Sequences. Harald Niederreiter. RICAM Linz and University of Salzburg Improved Discrepancy Bounds for Hybrid Sequences Harald Niederreiter RICAM Linz and University of Salzburg MC vs. QMC methods Hybrid sequences The basic sequences Deterministic discrepancy bounds The proof

More information

FE610 Stochastic Calculus for Financial Engineers. Stevens Institute of Technology

FE610 Stochastic Calculus for Financial Engineers. Stevens Institute of Technology FE610 Stochastic Calculus for Financial Engineers Lecture 3. Calculaus in Deterministic and Stochastic Environments Steve Yang Stevens Institute of Technology 01/31/2012 Outline 1 Modeling Random Behavior

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

Variance Reduction s Greatest Hits

Variance Reduction s Greatest Hits 1 Variance Reduction s Greatest Hits Pierre L Ecuyer CIRRELT, GERAD, and Département d Informatique et de Recherche Opérationnelle Université de Montréal, Canada ESM 2007, Malta, October 22, 2007 Context

More information

Tutorial on quasi-monte Carlo methods

Tutorial on quasi-monte Carlo methods Tutorial on quasi-monte Carlo methods Josef Dick School of Mathematics and Statistics, UNSW, Sydney, Australia josef.dick@unsw.edu.au Comparison: MCMC, MC, QMC Roughly speaking: Markov chain Monte Carlo

More information

Fast integration using quasi-random numbers. J.Bossert, M.Feindt, U.Kerzel University of Karlsruhe ACAT 05

Fast integration using quasi-random numbers. J.Bossert, M.Feindt, U.Kerzel University of Karlsruhe ACAT 05 Fast integration using quasi-random numbers J.Bossert, M.Feindt, U.Kerzel University of Karlsruhe ACAT 05 Outline Numerical integration Discrepancy The Koksma-Hlawka inequality Pseudo- and quasi-random

More information

Fast evaluation of mixed derivatives and calculation of optimal weights for integration. Hernan Leovey

Fast evaluation of mixed derivatives and calculation of optimal weights for integration. Hernan Leovey Fast evaluation of mixed derivatives and calculation of optimal weights for integration Humboldt Universität zu Berlin 02.14.2012 MCQMC2012 Tenth International Conference on Monte Carlo and Quasi Monte

More information

Part III. Quasi Monte Carlo methods 146/349

Part III. Quasi Monte Carlo methods 146/349 Part III Quasi Monte Carlo methods 46/349 Outline Quasi Monte Carlo methods 47/349 Quasi Monte Carlo methods Let y = (y,...,y N ) be a vector of independent uniform random variables in Γ = [0,] N, u(y)

More information

Consistency and Convergence

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

More information

Ordinary Differential Equation Theory

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

More information

High Dimensional Integration: New Weapons Fighting the Curse of Dimensionality

High Dimensional Integration: New Weapons Fighting the Curse of Dimensionality High Dimensional Integration: ew Weapons Fighting the Curse of Dimensionality Peter Zinterhof Technical Report 26-4 October 26 Department of Computer Sciences Jakob-Haringer-Straße 2 52 Salzburg Austria

More information

Hochdimensionale Integration

Hochdimensionale Integration Oliver Ernst Institut für Numerische Mathematik und Optimierung Hochdimensionale Integration 14-tägige Vorlesung im Wintersemester 2010/11 im Rahmen des Moduls Ausgewählte Kapitel der Numerik Contents

More information

epub WU Institutional Repository

epub WU Institutional Repository epub WU Institutional Repository Wolfgang Hörmann and Josef Leydold Quasi Importance Sampling Working Paper Original Citation: Hörmann, Wolfgang and Leydold, Josef (2005) Quasi Importance Sampling. Preprint

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

Quasi-Monte Carlo Techniques and Rare Event Sampling

Quasi-Monte Carlo Techniques and Rare Event Sampling www.oeaw.ac.at Quasi-Monte Carlo Techniques and Rare Event Sampling J. Hartinger, D. Kortschak RICAM-Report 2005-26 www.ricam.oeaw.ac.at Quasi-Monte Carlo Techniques and Rare Event Sampling Jürgen Hartinger

More information

Randomized Quasi-Monte Carlo Simulation of Markov Chains with an Ordered State Space

Randomized Quasi-Monte Carlo Simulation of Markov Chains with an Ordered State Space Randomized Quasi-Monte Carlo Simulation of Markov Chains with an Ordered State Space Pierre L Ecuyer 1, Christian Lécot 2, and Bruno Tuffin 3 1 Département d informatique et de recherche opérationnelle,

More information

SMOOTHNESS PROPERTIES OF SOLUTIONS OF CAPUTO- TYPE FRACTIONAL DIFFERENTIAL EQUATIONS. Kai Diethelm. Abstract

SMOOTHNESS PROPERTIES OF SOLUTIONS OF CAPUTO- TYPE FRACTIONAL DIFFERENTIAL EQUATIONS. Kai Diethelm. Abstract SMOOTHNESS PROPERTIES OF SOLUTIONS OF CAPUTO- TYPE FRACTIONAL DIFFERENTIAL EQUATIONS Kai Diethelm Abstract Dedicated to Prof. Michele Caputo on the occasion of his 8th birthday We consider ordinary fractional

More information

Initial value problems for ordinary differential equations

Initial value problems for ordinary differential equations Initial value problems for ordinary differential equations Xiaojing Ye, Math & Stat, Georgia State University Spring 2019 Numerical Analysis II Xiaojing Ye, Math & Stat, Georgia State University 1 IVP

More information

Laplace s Equation. Chapter Mean Value Formulas

Laplace s Equation. Chapter Mean Value Formulas Chapter 1 Laplace s Equation Let be an open set in R n. A function u C 2 () is called harmonic in if it satisfies Laplace s equation n (1.1) u := D ii u = 0 in. i=1 A function u C 2 () is called subharmonic

More information

Explicit One-Step Methods

Explicit One-Step Methods Chapter 1 Explicit One-Step Methods Remark 11 Contents This class presents methods for the numerical solution of explicit systems of initial value problems for ordinary differential equations of first

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

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

Introduction to standard and non-standard Numerical Methods

Introduction to standard and non-standard Numerical Methods Introduction to standard and non-standard Numerical Methods Dr. Mountaga LAM AMS : African Mathematic School 2018 May 23, 2018 One-step methods Runge-Kutta Methods Nonstandard Finite Difference Scheme

More information

Solution: (a) Before opening the parachute, the differential equation is given by: dv dt. = v. v(0) = 0

Solution: (a) Before opening the parachute, the differential equation is given by: dv dt. = v. v(0) = 0 Math 2250 Lab 4 Name/Unid: 1. (25 points) A man bails out of an airplane at the altitute of 12,000 ft, falls freely for 20 s, then opens his parachute. Assuming linear air resistance ρv ft/s 2, taking

More information

Progress in high-dimensional numerical integration and its application to stochastic optimization

Progress in high-dimensional numerical integration and its application to stochastic optimization Progress in high-dimensional numerical integration and its application to stochastic optimization W. Römisch Humboldt-University Berlin Department of Mathematics www.math.hu-berlin.de/~romisch Short course,

More information

APPLIED MATHEMATICS REPORT AMR04/16 FINITE-ORDER WEIGHTS IMPLY TRACTABILITY OF MULTIVARIATE INTEGRATION. I.H. Sloan, X. Wang and H.

APPLIED MATHEMATICS REPORT AMR04/16 FINITE-ORDER WEIGHTS IMPLY TRACTABILITY OF MULTIVARIATE INTEGRATION. I.H. Sloan, X. Wang and H. APPLIED MATHEMATICS REPORT AMR04/16 FINITE-ORDER WEIGHTS IMPLY TRACTABILITY OF MULTIVARIATE INTEGRATION I.H. Sloan, X. Wang and H. Wozniakowski Published in Journal of Complexity, Volume 20, Number 1,

More information

Quasi-Monte Carlo Algorithms for unbounded, weighted integration problems

Quasi-Monte Carlo Algorithms for unbounded, weighted integration problems Quasi-Monte Carlo Algorithms for unbounded, weighted integration problems Jürgen Hartinger Reinhold F. Kainhofer Robert F. Tihy Department of Mathematis, Graz University of Tehnology, Steyrergasse 30,

More information

Nonlinear Systems and Control Lecture # 12 Converse Lyapunov Functions & Time Varying Systems. p. 1/1

Nonlinear Systems and Control Lecture # 12 Converse Lyapunov Functions & Time Varying Systems. p. 1/1 Nonlinear Systems and Control Lecture # 12 Converse Lyapunov Functions & Time Varying Systems p. 1/1 p. 2/1 Converse Lyapunov Theorem Exponential Stability Let x = 0 be an exponentially stable equilibrium

More information

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

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

More information

Monte Carlo Method for Numerical Integration based on Sobol s Sequences

Monte Carlo Method for Numerical Integration based on Sobol s Sequences Monte Carlo Method for Numerical Integration based on Sobol s Sequences Ivan Dimov and Rayna Georgieva Institute of Information and Communication Technologies, Bulgarian Academy of Sciences, 1113 Sofia,

More information

LMI Methods in Optimal and Robust Control

LMI Methods in Optimal and Robust Control LMI Methods in Optimal and Robust Control Matthew M. Peet Arizona State University Lecture 15: Nonlinear Systems and Lyapunov Functions Overview Our next goal is to extend LMI s and optimization to nonlinear

More information

Ordinary Differential Equations

Ordinary Differential Equations Ordinary Differential Equations Professor Dr. E F Toro Laboratory of Applied Mathematics University of Trento, Italy eleuterio.toro@unitn.it http://www.ing.unitn.it/toro September 19, 2014 1 / 55 Motivation

More information

Numerical solution of ODEs

Numerical solution of ODEs Numerical solution of ODEs Arne Morten Kvarving Department of Mathematical Sciences Norwegian University of Science and Technology November 5 2007 Problem and solution strategy We want to find an approximation

More information

ON THE CORNER AVOIDANCE PROPERTIES OF VARIOUS LOW-DISCREPANCY SEQUENCES. Jürgen Hartinger 1.

ON THE CORNER AVOIDANCE PROPERTIES OF VARIOUS LOW-DISCREPANCY SEQUENCES. Jürgen Hartinger 1. INTEGERS: ELECTRONIC JOURNAL OF COMBINATORIAL NUMBER THEORY 5(3 (2005, #A10 ON THE CORNER AVOIDANCE PROPERTIES OF VARIOUS LOW-DISCREPANCY SEQUENCES Jürgen Hartinger 1 Department of Mathematics, Graz University

More information

QUASI-RANDOM NUMBER GENERATION IN THE VIEW OF PARALLEL IMPLEMENTATION. 1. Introduction

QUASI-RANDOM NUMBER GENERATION IN THE VIEW OF PARALLEL IMPLEMENTATION. 1. Introduction Trends in Mathematics Information Center for Mathematical Sciences Volume 6, Number 2, December, 2003, Pages 155 162 QUASI-RANDOM NUMBER GENERATION IN THE VIEW OF PARALLEL IMPLEMENTATION CHI-OK HWANG Abstract.

More information

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

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

More information

4.6 Example of non-uniqueness.

4.6 Example of non-uniqueness. 66 CHAPTER 4. STOCHASTIC DIFFERENTIAL EQUATIONS. 4.6 Example of non-uniqueness. If we try to construct a solution to the martingale problem in dimension coresponding to a(x) = x α with

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

An idea how to solve some of the problems. diverges the same must hold for the original series. T 1 p T 1 p + 1 p 1 = 1. dt = lim

An idea how to solve some of the problems. diverges the same must hold for the original series. T 1 p T 1 p + 1 p 1 = 1. dt = lim An idea how to solve some of the problems 5.2-2. (a) Does not converge: By multiplying across we get Hence 2k 2k 2 /2 k 2k2 k 2 /2 k 2 /2 2k 2k 2 /2 k. As the series diverges the same must hold for the

More information

Theory of Ordinary Differential Equations

Theory of Ordinary Differential Equations Theory of Ordinary Differential Equations Existence, Uniqueness and Stability Jishan Hu and Wei-Ping Li Department of Mathematics The Hong Kong University of Science and Technology ii Copyright c 24 by

More information

Introduction to Rare Event Simulation

Introduction to Rare Event Simulation Introduction to Rare Event Simulation Brown University: Summer School on Rare Event Simulation Jose Blanchet Columbia University. Department of Statistics, Department of IEOR. Blanchet (Columbia) 1 / 31

More information

A brief introduction to ordinary differential equations

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

More information

Upper Bounds for the Ruin Probability in a Risk Model With Interest WhosePremiumsDependonthe Backward Recurrence Time Process

Upper Bounds for the Ruin Probability in a Risk Model With Interest WhosePremiumsDependonthe Backward Recurrence Time Process Λ4flΛ4» ν ff ff χ Vol.4, No.4 211 8fl ADVANCES IN MATHEMATICS Aug., 211 Upper Bounds for the Ruin Probability in a Risk Model With Interest WhosePremiumsDependonthe Backward Recurrence Time Process HE

More information

Scenario Generation and Sampling Methods

Scenario Generation and Sampling Methods Scenario Generation and Sampling Methods Tito Homem-de-Mello Güzin Bayraksan SVAN 2016 IMPA 9 13 May 2106 Let s Start with a Recap Sample Average Approximation We want to solve the true problem min {g(x)

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

Uniformly Uniformly-ergodic Markov chains and BSDEs

Uniformly Uniformly-ergodic Markov chains and BSDEs Uniformly Uniformly-ergodic Markov chains and BSDEs Samuel N. Cohen Mathematical Institute, University of Oxford (Based on joint work with Ying Hu, Robert Elliott, Lukas Szpruch) Centre Henri Lebesgue,

More information

Introduction to Discrepancy Theory

Introduction to Discrepancy Theory Introduction to Discrepancy Theory Aleksandar (Sasho) Nikolov University of Toronto Sasho Nikolov (U of T) Discrepancy 1 / 23 Outline 1 Monte Carlo 2 Discrepancy and Quasi MC 3 Combinatorial Discrepancy

More information

A Randomized Quasi-Monte Carlo Simulation Method for Markov Chains

A Randomized Quasi-Monte Carlo Simulation Method for Markov Chains A Randomized Quasi-Monte Carlo Simulation Method for Markov Chains Pierre L Ecuyer GERAD and Département d Informatique et de Recherche Opérationnelle Université de Montréal, C.P. 6128, Succ. Centre-Ville,

More information

Low Discrepancy Sequences in High Dimensions: How Well Are Their Projections Distributed?

Low Discrepancy Sequences in High Dimensions: How Well Are Their Projections Distributed? Low Discrepancy Sequences in High Dimensions: How Well Are Their Projections Distributed? Xiaoqun Wang 1,2 and Ian H. Sloan 2 1 Department of Mathematical Sciences, Tsinghua University, Beijing 100084,

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

A Randomized Quasi-Monte Carlo Simulation Method for Markov Chains

A Randomized Quasi-Monte Carlo Simulation Method for Markov Chains A Randomized Quasi-Monte Carlo Simulation Method for Markov Chains Pierre L Ecuyer GERAD and Département d Informatique et de Recherche Opérationnelle Université de Montréal, C.P. 6128, Succ. Centre-Ville,

More information

n E(X t T n = lim X s Tn = X s

n E(X t T n = lim X s Tn = X s Stochastic Calculus Example sheet - Lent 15 Michael Tehranchi Problem 1. Let X be a local martingale. Prove that X is a uniformly integrable martingale if and only X is of class D. Solution 1. If If direction:

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

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

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

More information

X n D X lim n F n (x) = F (x) for all x C F. lim n F n(u) = F (u) for all u C F. (2)

X n D X lim n F n (x) = F (x) for all x C F. lim n F n(u) = F (u) for all u C F. (2) 14:17 11/16/2 TOPIC. Convergence in distribution and related notions. This section studies the notion of the so-called convergence in distribution of real random variables. This is the kind of convergence

More information

Economics 204 Summer/Fall 2011 Lecture 5 Friday July 29, 2011

Economics 204 Summer/Fall 2011 Lecture 5 Friday July 29, 2011 Economics 204 Summer/Fall 2011 Lecture 5 Friday July 29, 2011 Section 2.6 (cont.) Properties of Real Functions Here we first study properties of functions from R to R, making use of the additional structure

More information

Importance Sampling to Accelerate the Convergence of Quasi-Monte Carlo

Importance Sampling to Accelerate the Convergence of Quasi-Monte Carlo Importance Sampling to Accelerate the Convergence of Quasi-Monte Carlo Wolfgang Hörmann, Josef Leydold Department of Statistics and Mathematics Wirtschaftsuniversität Wien Research Report Series Report

More information

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

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

More information

Introduction to numerical methods for Ordinary Differential Equations

Introduction to numerical methods for Ordinary Differential Equations Introduction to numerical methods for Ordinary Differential Equations Charles-Edouard Bréhier Abstract The aims of these lecture notes are the following. We introduce Euler numerical schemes, and prove

More information

Malliavin Calculus in Finance

Malliavin Calculus in Finance Malliavin Calculus in Finance Peter K. Friz 1 Greeks and the logarithmic derivative trick Model an underlying assent by a Markov process with values in R m with dynamics described by the SDE dx t = b(x

More information

Half of Final Exam Name: Practice Problems October 28, 2014

Half of Final Exam Name: Practice Problems October 28, 2014 Math 54. Treibergs Half of Final Exam Name: Practice Problems October 28, 24 Half of the final will be over material since the last midterm exam, such as the practice problems given here. The other half

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

Delay Differential Equations Part I: Constant Lags

Delay Differential Equations Part I: Constant Lags Delay Differential Equations Part I: Constant Lags L.F. Shampine Department of Mathematics Southern Methodist University Dallas, Texas 75275 shampine@smu.edu www.faculty.smu.edu/shampine Delay Differential

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

Reflected Brownian Motion

Reflected Brownian Motion Chapter 6 Reflected Brownian Motion Often we encounter Diffusions in regions with boundary. If the process can reach the boundary from the interior in finite time with positive probability we need to decide

More information

The first order quasi-linear PDEs

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

More information

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

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

More information

Numerical Methods - Initial Value Problems for ODEs

Numerical Methods - Initial Value Problems for ODEs Numerical Methods - Initial Value Problems for ODEs Y. K. Goh Universiti Tunku Abdul Rahman 2013 Y. K. Goh (UTAR) Numerical Methods - Initial Value Problems for ODEs 2013 1 / 43 Outline 1 Initial Value

More information

EXPONENTIAL INEQUALITIES IN NONPARAMETRIC ESTIMATION

EXPONENTIAL INEQUALITIES IN NONPARAMETRIC ESTIMATION EXPONENTIAL INEQUALITIES IN NONPARAMETRIC ESTIMATION Luc Devroye Division of Statistics University of California at Davis Davis, CA 95616 ABSTRACT We derive exponential inequalities for the oscillation

More information

1 Lyapunov theory of stability

1 Lyapunov theory of stability M.Kawski, APM 581 Diff Equns Intro to Lyapunov theory. November 15, 29 1 1 Lyapunov theory of stability Introduction. Lyapunov s second (or direct) method provides tools for studying (asymptotic) stability

More information

Quasi-Monte Carlo Algorithms for Diffusion Equations in High Dimensions

Quasi-Monte Carlo Algorithms for Diffusion Equations in High Dimensions Quasi-Monte Carlo Algorithms for Diffusion Equations in High Dimensions G. Venkiteswaran a,, M. Junk b a Graduiertenkolleg Mathematik und Praxis, Universität Kaiserslautern 67653 Kaiserslautern, Germany

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

Math 576: Quantitative Risk Management

Math 576: Quantitative Risk Management Math 576: Quantitative Risk Management Haijun Li lih@math.wsu.edu Department of Mathematics Washington State University Week 11 Haijun Li Math 576: Quantitative Risk Management Week 11 1 / 21 Outline 1

More information

30 not everywhere defined and capturing the domain of f was part of the problem. In this paper the objective

30 not everywhere defined and capturing the domain of f was part of the problem. In this paper the objective 1 2 3 4 5 6 7 8 9 10 11 12 13 14 15 16 17 18 A SMOOTHING DIRECT SEARCH METHOD FOR MONTE CARLO-BASED BOUND CONSTRAINED COMPOSITE NONSMOOTH OPTIMIZATION XIAOJUN CHEN, C. T. KELLEY, FENGMIN XU, AND ZAIKUN

More information

Ch 6.4: Differential Equations with Discontinuous Forcing Functions

Ch 6.4: Differential Equations with Discontinuous Forcing Functions Ch 6.4: Differential Equations with Discontinuous Forcing Functions! In this section focus on examples of nonhomogeneous initial value problems in which the forcing function is discontinuous. Example 1:

More information

Numerical Methods for Differential Equations

Numerical Methods for Differential Equations Numerical Methods for Differential Equations Chapter 2: Runge Kutta and Linear Multistep methods Gustaf Söderlind and Carmen Arévalo Numerical Analysis, Lund University Textbooks: A First Course in the

More information

Suboptimal feedback control of PDEs by solving Hamilton-Jacobi Bellman equations on sparse grids

Suboptimal feedback control of PDEs by solving Hamilton-Jacobi Bellman equations on sparse grids Suboptimal feedback control of PDEs by solving Hamilton-Jacobi Bellman equations on sparse grids Jochen Garcke joint work with Axel Kröner, INRIA Saclay and CMAP, Ecole Polytechnique Ilja Kalmykov, Universität

More information

Ordinary differential equation II

Ordinary differential equation II Ordinary Differential Equations ISC-5315 1 Ordinary differential equation II 1 Some Basic Methods 1.1 Backward Euler method (implicit method) The algorithm looks like this: y n = y n 1 + hf n (1) In contrast

More information

Scientific Computing: Monte Carlo

Scientific Computing: Monte Carlo Scientific Computing: Monte Carlo Aleksandar Donev Courant Institute, NYU 1 donev@courant.nyu.edu 1 Course MATH-GA.2043 or CSCI-GA.2112, Spring 2012 April 5th and 12th, 2012 A. Donev (Courant Institute)

More information

Extensible grids: uniform sampling on a space-filling curve

Extensible grids: uniform sampling on a space-filling curve Extensible grids: uniform sampling on a space-filling curve Zhijian He Tsinghua University Art B. Owen Stanford University June 2014 Abstract We study the properties of points in [0, 1] d generated by

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

Adapting quasi-monte Carlo methods to simulation problems in weighted Korobov spaces

Adapting quasi-monte Carlo methods to simulation problems in weighted Korobov spaces Adapting quasi-monte Carlo methods to simulation problems in weighted Korobov spaces Christian Irrgeher joint work with G. Leobacher RICAM Special Semester Workshop 1 Uniform distribution and quasi-monte

More information

Brownian Motion. 1 Definition Brownian Motion Wiener measure... 3

Brownian Motion. 1 Definition Brownian Motion Wiener measure... 3 Brownian Motion Contents 1 Definition 2 1.1 Brownian Motion................................. 2 1.2 Wiener measure.................................. 3 2 Construction 4 2.1 Gaussian process.................................

More information

STRONG TRACTABILITY OF MULTIVARIATE INTEGRATION USING QUASI MONTE CARLO ALGORITHMS

STRONG TRACTABILITY OF MULTIVARIATE INTEGRATION USING QUASI MONTE CARLO ALGORITHMS MATHEMATICS OF COMPUTATION Volume 72, Number 242, Pages 823 838 S 0025-5718(02)01440-0 Article electronically published on June 25, 2002 STRONG TRACTABILITY OF MULTIVARIATE INTEGRATION USING QUASI MONTE

More information

Optimal stopping of a risk process when claims are covered immediately

Optimal stopping of a risk process when claims are covered immediately Optimal stopping of a risk process when claims are covered immediately Bogdan Muciek Krzysztof Szajowski Abstract The optimal stopping problem for the risk process with interests rates and when claims

More information

Differential Equations

Differential Equations Pysics-based simulation xi Differential Equations xi+1 xi xi+1 xi + x x Pysics-based simulation xi Wat is a differential equation? Differential equations describe te relation between an unknown function

More information

The problems that follow illustrate the methods covered in class. They are typical of the types of problems that will be on the tests.

The problems that follow illustrate the methods covered in class. They are typical of the types of problems that will be on the tests. NUMERICAL ANALYSIS PRACTICE PROBLEMS JAMES KEESLING The problems that follow illustrate the methods covered in class. They are typical of the types of problems that will be on the tests.. Solving Equations

More information

Scenario estimation and generation

Scenario estimation and generation October 10, 2004 The one-period case Distances of Probability Measures Tensor products of trees Tree reduction A decision problem is subject to uncertainty Uncertainty is represented by probability To

More information

CS 257: Numerical Methods

CS 257: Numerical Methods CS 57: Numerical Methods Final Exam Study Guide Version 1.00 Created by Charles Feng http://www.fenguin.net CS 57: Numerical Methods Final Exam Study Guide 1 Contents 1 Introductory Matter 3 1.1 Calculus

More information

Additive functionals of infinite-variance moving averages. Wei Biao Wu The University of Chicago TECHNICAL REPORT NO. 535

Additive functionals of infinite-variance moving averages. Wei Biao Wu The University of Chicago TECHNICAL REPORT NO. 535 Additive functionals of infinite-variance moving averages Wei Biao Wu The University of Chicago TECHNICAL REPORT NO. 535 Departments of Statistics The University of Chicago Chicago, Illinois 60637 June

More information

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

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

More information

Real Analysis Problems

Real Analysis Problems Real Analysis Problems Cristian E. Gutiérrez September 14, 29 1 1 CONTINUITY 1 Continuity Problem 1.1 Let r n be the sequence of rational numbers and Prove that f(x) = 1. f is continuous on the irrationals.

More information

Low Discrepancy Toolbox Manual. Michael Baudin

Low Discrepancy Toolbox Manual. Michael Baudin Low Discrepancy Toolbox Manual Michael Baudin Version 0.1 May 2013 Abstract This document is an introduction to the Low Discrepancy module v0.5. Contents 1 Gallery 4 1.1 The Van Der Corput sequence.............................

More information