Solving the Stochastic Steady-State Diffusion Problem Using Multigrid

Size: px
Start display at page:

Download "Solving the Stochastic Steady-State Diffusion Problem Using Multigrid"

Transcription

1 Solving the Stochastic Steady-State Diffusion Problem Using Multigrid Tengfei Su Applied Mathematics and Scientific Computing Program Advisor: Howard Elman Department of Computer Science May 5, 2016 Tengfei Su Solving the Stochastic Steady-State Diffusion Problem Using Multigrid 1 / 31

2 Outline 1 Project Review 2 Multigrid Two-Grid Method Algorithm Validation 3 Low-Rank Approximation Motivation Algorithm Numerical Results 4 Conclusions Tengfei Su Solving the Stochastic Steady-State Diffusion Problem Using Multigrid 2 / 31

3 Project Goal The stochastic steady-state diffusion equation { (c(x, ω) u(x, ω)) = f (x) in D Ω u(x, ω) = 0 with stochastic coefficient c(x, ω) : D Ω R. Approaches Monte Carlo method (MCM) Stochastic finite element method (SFEM) [Ghanem & Spanos, 2003] Solver: Multigrid [Elman & Furnival, 2007] on D Ω Tengfei Su Solving the Stochastic Steady-State Diffusion Problem Using Multigrid 3 / 31

4 Stochastic FEM Karhunen-Loève expansion [Loève, 1960] m c(x, ω) c 0 (x) + λi c i (x)ξ i (ω). i=1 Weak form Γ ρ(ξ) D c(x, ξ) u(x, ξ) v(x, ξ)dxdξ = ρ(ξ) f (x)v(x, ξ)dxdξ, Γ D for v(x, ω) V = H 1 0 (D) L2 (Γ). Here ρ(ξ) is the joint density function, and Γ is the joint image of {ξ i } m i=1. Tengfei Su Solving the Stochastic Steady-State Diffusion Problem Using Multigrid 4 / 31

5 Stochastic FEM Finite-dimensional subspace V hp = S T = span{φ(x)ψ(ξ), φ S, ψ T } with basis functions φ(x): piecewise linear/bilinear basis functions ψ(ξ): m-dimensional orthonormal polynomials, total order not exceeding p [Xiu & Karniadakis, 2003]. SFEM solution Γ ψ r (ξ)ψ s (ξ)ρ(ξ)dξ = δ rs, M = u hp (x, ξ) = N j=1 s=1 M u js φ j (x)ψ s (ξ) (m + p)! m!p! Tengfei Su Solving the Stochastic Steady-State Diffusion Problem Using Multigrid 5 / 31

6 Galerkin System Find u R MN, such that [Powell & Elman, 2009] Au = f, where u = [u 11, u 21,..., u N1,..., u 1M, u 2M,..., u NM ] T, m A = G 0 K 0 + G i K i, f = g 0 f 0. i=1 Block structure of A (m = 4, p = 1, 2, 3) Tengfei Su Solving the Stochastic Steady-State Diffusion Problem Using Multigrid 6 / 31

7 Outline 1 Project Review 2 Multigrid Two-Grid Method Algorithm Validation 3 Low-Rank Approximation Motivation Algorithm Numerical Results 4 Conclusions Tengfei Su Solving the Stochastic Steady-State Diffusion Problem Using Multigrid 7 / 31

8 Two-Grid Method Two-gird correction scheme [Elman & Furnival, 2007] Choose initial guess u (0) for i = 0 until convergence for k steps u (i) u (i) + Q 1 (f Au (i) ) end r = R(f Au (i) ) solve Āē = r u (i+1) = u (i) + Pē for k steps u (i+1) u (i+1) + Q 1 (f Au (i+1) ) end end Multigrid: Apply the two-grid method recursively Tengfei Su Solving the Stochastic Steady-State Diffusion Problem Using Multigrid 8 / 31

9 Two-Grid Method Two grid spaces V hp = T p S h, V 2h,p = T p S 2h Prolongation and restriction operators Construction of Ā P = I P, R = I P T Ā = G 0 K 2h 0 + Damped Jacobi smoother m i=1 G i K 2h i Q = 1 ω D, D = diag(a) = I diag(k 0) Tengfei Su Solving the Stochastic Steady-State Diffusion Problem Using Multigrid 9 / 31

10 Algorithm Algorithm 1: Multigrid for stochastic Galerkin systems initialization: i = 0, r (0) = f, r 0 = f while r > tol r 0 & i maxit do /* solve residual equation */ e (i) = MgIter(A, 0, r (i), level) u (i+1) = u (i) + e (i) r (i+1) = f Au (i+1) r = r (i+1), i = i + 1 function u (1) = MgIter(A, u (0), f, level) if level == 2 then /* coarsest grid level */ u (1) = A\f else /* apply one MG iteration */ for k steps do u (0) u (0) + Q 1 (f Au (0) ) r = R(f Au (0) ) ē = MgIter(Ā, 0, r, level 1) u (1) = u (0) + Pē for k steps do u (1) u (1) + Q 1 (f Au (1) ) Tengfei Su Solving the Stochastic Steady-State Diffusion Problem Using Multigrid 10 / 31

11 Model Problem D = ( 1, 1) 2, f = 1. Covariance function KL expansion r(x, y) = σ 2 exp( 1 b x 1 y 1 1 b x 2 y 2 ) c(x, ω) = c 0 (x) + 3 m λi c i (x)ξ i (ω) i=1 Uniform distribution (assuming independence) ξ i U( 1, 1), ρ(ξ) = 1 2 m Take c 0 (x) = 1, σ = 0.3, b = 2, multigrid tol = 10 6 Tengfei Su Solving the Stochastic Steady-State Diffusion Problem Using Multigrid 11 / 31

12 Validation: Convergence Performance Independent of h m = 5, p = 3 m = 3, p = 5 h n h n Independent of m, p (h = 2 3 ) (m = 3) p n (p = 3) m n Tengfei Su Solving the Stochastic Steady-State Diffusion Problem Using Multigrid 12 / 31

13 Validation: Monte Carlo Monte Carlo method ξ i U( 1, 1), (K 0 + Compute mean and variance E[u MC ] = 1 q q r=1 Var[u MC ] = 1 q 1 u r MC m ξ i K i )u = f 0 i=1 q (umc r E[u MC ]) 2 r=1 Monte Carlo: h = 2 4, m = 3, q = 1, 000, 000 Multigrid: h = 2 4, m = 3, p = 9, tol = Tengfei Su Solving the Stochastic Steady-State Diffusion Problem Using Multigrid 13 / 31

14 Validation: Monte Carlo E[u FE ] E[u MC ] 2 E[u MC ] 2 = , Var[u FE ] Var[u MC ] 2 Var[u MC ] 2 = Tengfei Su Solving the Stochastic Steady-State Diffusion Problem Using Multigrid 14 / 31

15 Outline 1 Project Review 2 Multigrid Two-Grid Method Algorithm Validation 3 Low-Rank Approximation Motivation Algorithm Numerical Results 4 Conclusions Tengfei Su Solving the Stochastic Steady-State Diffusion Problem Using Multigrid 15 / 31

16 Motivation Galerkin system SFEM solution Au = (G 0 K 0 + m G i K i )u = f. i=1 u = [u 11,..., u N1,..., u 1M,..., u NM ] T Write into matrix form u 11 u 12 u 1M u 21 u 22 u 2M U = mat(u) = u N1 u N2 u NM A(U) = K 0 UG T 0 + m i=1 K i UG T i = F. Tengfei Su Solving the Stochastic Steady-State Diffusion Problem Using Multigrid 16 / 31

17 Motivation Decay of singular values for the solution matrix U (h = 2 6, m = 5, p = 3) U can be well approximated by a low-rank matrix! Tengfei Su Solving the Stochastic Steady-State Diffusion Problem Using Multigrid 17 / 31

18 Motivation Low-rank approximation U U k = V k Wk T, V k R N k, W k R M k, k N, M m (K 0 V k )(G 0 W k ) T + (K i V k )(G i W k ) T = F l Fr T. i=1 Memory and computational cost NM v.s. k(n + M) Low-rank matrix iterates are convenient to implement m A(VW T ) = (K 0 V )(G 0 W ) T + (K i V )(G i W ) T i=1 = [K 0 V, K 1 V,..., K m V ][G 0 W, G 1 W,..., G m W ] T Matrix rank grows rapidly: k (m + 1)k. The iterates should be truncated in every iteration. Tengfei Su Solving the Stochastic Steady-State Diffusion Problem Using Multigrid 18 / 31

19 Algorithm Algorithm 2: Multigrid with low-rank truncations initialization: i = 0, R (0) = F in low-rank format, r 0 = F while r > tol r 0 & i maxit do /* solve residual equation */ E (i) = MgIter(A, 0, R (i), level) U (i+1) = U (i) + E (i), U (i+1) = T abs (U (i+1) ) R (i+1) = F A(U (i+1) ), R (i+1) = T abs (R (i+1) ) r = R (i+1), i = i + 1 function U (1) = MgIter(A, U (0), F, level) if level == 2 then /* coarsest grid level */ solve A(U (1) ) = F directly else /* apply one MG iteration */ for k steps do U (0) U (0) + S (F A(U (0) )), U (0) = T rel (U (0) ) R = F A(U (0) ), R = Trel ( R) R = R R, Ē = MgIter(Ā, 0, R, level 1) U (1) = U (0) + PĒ for k steps do U (1) U (1) + S (F A(U (1) )), U (1) = T rel (U (1) ) Tengfei Su Solving the Stochastic Steady-State Diffusion Problem Using Multigrid 19 / 31

20 Low-rank truncation The truncation operator Ũ = T (U) [Kressner & Tobler, 2011] U = VW T, V R N k, W R M k Ũ = Ṽ W T, Ṽ R N k, W R M k Computation QR factorization: V = Q V R V, W = Q W R W where R V, R W R k k SVD: R V R T W = ˆV diag(σ 1,..., σ k )Ŵ T Truncation σ 2 k σk 2 ɛ rel σ σ2 k k = max{k σ k ɛ abs } Ṽ = Q V ˆV (:, 1 : k), W = Q W ˆV (:, 1 : k)diag(σ 1,..., σ k ) Cost: O((M + N + k)k 2 ) Tengfei Su Solving the Stochastic Steady-State Diffusion Problem Using Multigrid 20 / 31

21 Model Problem D = ( 1, 1) 2, f = 1. Covariance function KL expansion r(x, y) = σ 2 exp( 1 b x 1 y 1 1 b x 2 y 2 ) c(x, ω) = c 0 (x) + 3 m λi c k (x)ξ i (ω) i=1 Uniform distribution (assuming independence) ξ i U( 1, 1), ρ(ξ) = 1 2 m Take c 0 (x) = 1. m and b are chosen such that m λ i / λ i 95% i=1 i=1 Tengfei Su Solving the Stochastic Steady-State Diffusion Problem Using Multigrid 21 / 31

22 Implementation IFISS (Incompressible Flow and Iterative Solver Software, Silvester, et al) and SIFISS: Generate the Galerkin systems MATLAB R2015a 1.6 GHz Intel Core i5, 4 GB memory Tengfei Su Solving the Stochastic Steady-State Diffusion Problem Using Multigrid 22 / 31

23 Numerical Results Case 1: Standard deviation σ Decay of singular values of solution matrix U Relative residuals for low-rank approximations Tengfei Su Solving the Stochastic Steady-State Diffusion Problem Using Multigrid 23 / 31

24 Numerical Results Case 1: Standard deviation σ (N = 16129, M = 56) Truncation No truncation Rank 6 2 σ = Iterations Elapsed time Rel residual 3.0e-6 6.2e-4 1.2e-6 2.2e-4 Rank 13 6 σ = 0.01 Iterations Elapsed time Rel residual 1.1e-5 6.0e-4 1.6e-5 2.2e-4 Rank σ = 0.1 Iterations Elapsed time Rel residual 1.7e-5 1.1e-3 1.9e-5 2.4e-4 Rank σ = 0.3 Iterations Elapsed time Rel residual 1.8e-5 1.7e-3 1.4e-5 1.7e-3 Tengfei Su Solving the Stochastic Steady-State Diffusion Problem Using Multigrid 24 / 31

25 Numerical Results Case 2: Spatial dimension N (σ = 0.01, M = 56) Truncation No truncation Rank 13 6 nc = 7 Iterations N = Elapsed time Rel residual 1.1e-5 6.0e-4 1.6e-5 2.2e-4 Rank 16 6 nc = 8 Iterations N = Elapsed time Rel residual 1.3e-5 5.8e-4 1.8e-5 2.3e-4 Rank 11 5 nc = 9 Iterations N = Elapsed time Rel residual 4.6e-5 1.7e-3 1.9e-5 3.3e-3 Rank 11 2 nc = 10 Iterations N = Elapsed time Rel residual 4.5e-5 6.7e-3 1.9e-5 3.3e-3 Tengfei Su Solving the Stochastic Steady-State Diffusion Problem Using Multigrid 25 / 31

26 Numerical Results Case 3: Stochastic dimension M (σ = 0.01, N = 16129, p = 3) Truncation No truncation Rank 13 6 m = 5 Iterations M = 56 Elapsed time Rel residual 1.1e-5 6.0e-4 1.6e-5 2.2e-4 Rank 24 8 m = 7 Iterations M = 84 Elapsed time Rel residual 5.5e-6 4.6e-4 1.2e-6 2.2e-4 Rank m = 9 Iterations M = 220 Elapsed time Rel residual 4.0e-6 1.7e-4 1.2e-6 2.2e-4 Rank m = 11 Iterations M = 364 Elapsed time Rel residual 2.4e-6 7.5e-5 1.2e-6 1.6e-5 Tengfei Su Solving the Stochastic Steady-State Diffusion Problem Using Multigrid 26 / 31

27 Outline 1 Project Review 2 Multigrid Two-Grid Method Algorithm Validation 3 Low-Rank Approximation Motivation Algorithm Numerical Results 4 Conclusions Tengfei Su Solving the Stochastic Steady-State Diffusion Problem Using Multigrid 27 / 31

28 Conclusions Summary The multigrid solver works well for the stochastic Galerkin systems and can be more efficient than the Monte Carlo mehtod. The solution matrix can be better approximated by a low-rank matrix when the standard deviation in the random coefficient is small. Low-rank truncations reduce computing time for multigrid, especially when the spatial degree of freedom is large. Tengfei Su Solving the Stochastic Steady-State Diffusion Problem Using Multigrid 28 / 31

29 Future Work Low-rank truncation based on singular values Cost: O((N + M + k)k 2 ) QR factorization can be expensive (nc = 7, m = 5, p = 3) σ QR 51.2% 67.7% 73.2% SVD 3.4% 2.2% 2.2% Better truncation strategy: take advantage of grid hierarchy? Tengfei Su Solving the Stochastic Steady-State Diffusion Problem Using Multigrid 29 / 31

30 References 1 Ghanem, R. G. & Spanos, P. D. (2003). Stochastic Finite Elements: A Spectral Approach. New York: Dover Publications. 2 Elman, H. & Furnival D. (2007). Solving the stochastic steady-state diffusion problem using multigrid. IMA Journal of Numerical Analysis 27, Loève, M. (1960). Probability Theory. New York: Van Nostrand. 4 Xiu, D. & Karniadakis G. M. (2003). Modeling uncertainty in flow simulations via generalized polynomial chaos. Journal of Computational Physics, 187, Powell, C. & Elman H. (2009). Block-diagonal preconditioning for spectral stochastic finite-element systems. IMA Journal of Numerical Analysis 29, Kressner D. & Tobler C. (2011). Low-rank tensor Krylov subspace methods for parametrized linear systems. SIAM Journal of Matrix Analysis and Applications 32.4, Silvester, D., Elman, H. & Ramage, A. Incompressible Flow and Iterative Solver Software, Tengfei Su Solving the Stochastic Steady-State Diffusion Problem Using Multigrid 30 / 31

31 The End Thank you! Questions? Tengfei Su Solving the Stochastic Steady-State Diffusion Problem Using Multigrid 31 / 31

PDE Project Course 1. Adaptive finite element methods

PDE Project Course 1. Adaptive finite element methods PDE Project Course 1. Adaptive finite element methods Anders Logg logg@math.chalmers.se Department of Computational Mathematics PDE Project Course 03/04 p. 1 Lecture plan Introduction to FEM FEM for Poisson

More information

Monte Carlo Methods for Uncertainty Quantification

Monte Carlo Methods for Uncertainty Quantification Monte Carlo Methods for Uncertainty Quantification Abdul-Lateef Haji-Ali Based on slides by: Mike Giles Mathematical Institute, University of Oxford Contemporary Numerical Techniques Haji-Ali (Oxford)

More information

EC316a: Advanced Scientific Computation, Fall Discrete time, continuous state dynamic models: solution methods

EC316a: Advanced Scientific Computation, Fall Discrete time, continuous state dynamic models: solution methods EC316a: Advanced Scientific Computation, Fall 2003 Notes Section 4 Discrete time, continuous state dynamic models: solution methods We consider now solution methods for discrete time models in which decisions

More information

Fast Convergence of Regress-later Series Estimators

Fast Convergence of Regress-later Series Estimators Fast Convergence of Regress-later Series Estimators New Thinking in Finance, London Eric Beutner, Antoon Pelsser, Janina Schweizer Maastricht University & Kleynen Consultants 12 February 2014 Beutner Pelsser

More information

Monte-Carlo Methods in Financial Engineering

Monte-Carlo Methods in Financial Engineering Monte-Carlo Methods in Financial Engineering Universität zu Köln May 12, 2017 Outline Table of Contents 1 Introduction 2 Repetition Definitions Least-Squares Method 3 Derivation Mathematical Derivation

More information

Financial Mathematics and Supercomputing

Financial Mathematics and Supercomputing GPU acceleration in early-exercise option valuation Álvaro Leitao and Cornelis W. Oosterlee Financial Mathematics and Supercomputing A Coruña - September 26, 2018 Á. Leitao & Kees Oosterlee SGBM on GPU

More information

PORTFOLIO OPTIMIZATION AND EXPECTED SHORTFALL MINIMIZATION FROM HISTORICAL DATA

PORTFOLIO OPTIMIZATION AND EXPECTED SHORTFALL MINIMIZATION FROM HISTORICAL DATA PORTFOLIO OPTIMIZATION AND EXPECTED SHORTFALL MINIMIZATION FROM HISTORICAL DATA We begin by describing the problem at hand which motivates our results. Suppose that we have n financial instruments at hand,

More information

Idiosyncratic risk, insurance, and aggregate consumption dynamics: a likelihood perspective

Idiosyncratic risk, insurance, and aggregate consumption dynamics: a likelihood perspective Idiosyncratic risk, insurance, and aggregate consumption dynamics: a likelihood perspective Alisdair McKay Boston University June 2013 Microeconomic evidence on insurance - Consumption responds to idiosyncratic

More information

Stochastic Grid Bundling Method

Stochastic Grid Bundling Method Stochastic Grid Bundling Method GPU Acceleration Delft University of Technology - Centrum Wiskunde & Informatica Álvaro Leitao Rodríguez and Cornelis W. Oosterlee London - December 17, 2015 A. Leitao &

More information

A model reduction approach to numerical inversion for parabolic partial differential equations

A model reduction approach to numerical inversion for parabolic partial differential equations A model reduction approach to numerical inversion for parabolic partial differential equations Liliana Borcea Alexander V. Mamonov 2, Vladimir Druskin 3, Mikhail Zaslavsky 3 University of Michigan, Ann

More information

Solving Asset-Pricing Models with Recursive Preferences

Solving Asset-Pricing Models with Recursive Preferences Solving Asset-Pricing Models with Recursive Preferences Walter Pohl University of Zurich Karl Schmedders University of Zurich and Swiss Finance Institute Ole Wilms University of Zurich July 5, Abstract

More information

Reduced models for sparse grid discretizations of the multi-asset Black-Scholes equation

Reduced models for sparse grid discretizations of the multi-asset Black-Scholes equation Reduced models for sparse grid discretizations of the multi-asset Black-Scholes equation The MIT Faculty has made this article openly available. Please share how this access benefits you. Your story matters.

More information

The data-driven COS method

The data-driven COS method The data-driven COS method Á. Leitao, C. W. Oosterlee, L. Ortiz-Gracia and S. M. Bohte Delft University of Technology - Centrum Wiskunde & Informatica Reading group, March 13, 2017 Reading group, March

More information

Regression estimation in continuous time with a view towards pricing Bermudan options

Regression estimation in continuous time with a view towards pricing Bermudan options with a view towards pricing Bermudan options Tagung des SFB 649 Ökonomisches Risiko in Motzen 04.-06.06.2009 Financial engineering in times of financial crisis Derivate... süßes Gift für die Spekulanten

More information

Sparse Wavelet Methods for Option Pricing under Lévy Stochastic Volatility models

Sparse Wavelet Methods for Option Pricing under Lévy Stochastic Volatility models Sparse Wavelet Methods for Option Pricing under Lévy Stochastic Volatility models Norbert Hilber Seminar of Applied Mathematics ETH Zürich Workshop on Financial Modeling with Jump Processes p. 1/18 Outline

More information

Math 416/516: Stochastic Simulation

Math 416/516: Stochastic Simulation Math 416/516: Stochastic Simulation Haijun Li lih@math.wsu.edu Department of Mathematics Washington State University Week 13 Haijun Li Math 416/516: Stochastic Simulation Week 13 1 / 28 Outline 1 Simulation

More information

A model reduction approach to numerical inversion for parabolic partial differential equations

A model reduction approach to numerical inversion for parabolic partial differential equations A model reduction approach to numerical inversion for parabolic partial differential equations Liliana Borcea Alexander V. Mamonov 2, Vladimir Druskin 2, Mikhail Zaslavsky 2 University of Michigan, Ann

More information

"Pricing Exotic Options using Strong Convergence Properties

Pricing Exotic Options using Strong Convergence Properties Fourth Oxford / Princeton Workshop on Financial Mathematics "Pricing Exotic Options using Strong Convergence Properties Klaus E. Schmitz Abe schmitz@maths.ox.ac.uk www.maths.ox.ac.uk/~schmitz Prof. Mike

More information

Monte Carlo Methods for Uncertainty Quantification

Monte Carlo Methods for Uncertainty Quantification Monte Carlo Methods for Uncertainty Quantification Abdul-Lateef Haji-Ali Based on slides by: Mike Giles Mathematical Institute, University of Oxford Contemporary Numerical Techniques Haji-Ali (Oxford)

More information

Discussion Paper No. DP 07/05

Discussion Paper No. DP 07/05 SCHOOL OF ACCOUNTING, FINANCE AND MANAGEMENT Essex Finance Centre A Stochastic Variance Factor Model for Large Datasets and an Application to S&P data A. Cipollini University of Essex G. Kapetanios Queen

More information

The data-driven COS method

The data-driven COS method The data-driven COS method Á. Leitao, C. W. Oosterlee, L. Ortiz-Gracia and S. M. Bohte Delft University of Technology - Centrum Wiskunde & Informatica CMMSE 2017, July 6, 2017 Álvaro Leitao (CWI & TUDelft)

More information

Approximation of probability density functions for SPDEs using truncated series expansions 0

Approximation of probability density functions for SPDEs using truncated series expansions 0 Approximation of probability density functions for SPDEs using truncated series expansions 0 Giacomo Capodaglio Max Gunzburger Henry P. Wynn Abstract The probability density function (PDF) of a random

More information

On the Solution of Complementarity Problems Arising in American Options Pricing

On the Solution of Complementarity Problems Arising in American Options Pricing On the Solution of Complementarity Problems Arising in American Options Pricing Liming Feng Vadim Linetsky José Luis Morales Jorge Nocedal August 3, 2010 Abstract In the Black-Scholes-Merton model, as

More information

Overnight Index Rate: Model, calibration and simulation

Overnight Index Rate: Model, calibration and simulation Research Article Overnight Index Rate: Model, calibration and simulation Olga Yashkir and Yuri Yashkir Cogent Economics & Finance (2014), 2: 936955 Page 1 of 11 Research Article Overnight Index Rate: Model,

More information

4 Reinforcement Learning Basic Algorithms

4 Reinforcement Learning Basic Algorithms Learning in Complex Systems Spring 2011 Lecture Notes Nahum Shimkin 4 Reinforcement Learning Basic Algorithms 4.1 Introduction RL methods essentially deal with the solution of (optimal) control problems

More information

Extend the ideas of Kan and Zhou paper on Optimal Portfolio Construction under parameter uncertainty

Extend the ideas of Kan and Zhou paper on Optimal Portfolio Construction under parameter uncertainty Extend the ideas of Kan and Zhou paper on Optimal Portfolio Construction under parameter uncertainty George Photiou Lincoln College University of Oxford A dissertation submitted in partial fulfilment for

More information

Path-dependent options and randomization techniques

Path-dependent options and randomization techniques Path-dependent options and randomization techniques Daniele Marazzina Joint work with G. Fusai and M. Marena Dipartimento di Matematica F. Brioschi Politecnico di Milano daniele.marazzina@polimi.it April

More information

Lecture outline. Monte Carlo Methods for Uncertainty Quantification. Importance Sampling. Importance Sampling

Lecture outline. Monte Carlo Methods for Uncertainty Quantification. Importance Sampling. Importance Sampling Lecture outline Monte Carlo Methods for Uncertainty Quantification Mike Giles Mathematical Institute, University of Oxford KU Leuven Summer School on Uncertainty Quantification Lecture 2: Variance reduction

More information

Using radial basis functions for option pricing

Using radial basis functions for option pricing Using radial basis functions for option pricing Elisabeth Larsson Division of Scientific Computing Department of Information Technology Uppsala University Actuarial Mathematics Workshop, March 19, 2013,

More information

A No-Arbitrage Theorem for Uncertain Stock Model

A No-Arbitrage Theorem for Uncertain Stock Model Fuzzy Optim Decis Making manuscript No (will be inserted by the editor) A No-Arbitrage Theorem for Uncertain Stock Model Kai Yao Received: date / Accepted: date Abstract Stock model is used to describe

More information

Exact shape-reconstruction by one-step linearization in EIT

Exact shape-reconstruction by one-step linearization in EIT Exact shape-reconstruction by one-step linearization in EIT Bastian von Harrach harrach@ma.tum.de Department of Mathematics - M1, Technische Universität München, Germany Joint work with Jin Keun Seo, Yonsei

More information

AN OPERATOR SPLITTING METHOD FOR PRICING THE ELS OPTION

AN OPERATOR SPLITTING METHOD FOR PRICING THE ELS OPTION J. KSIAM Vol.14, No.3, 175 187, 21 AN OPERATOR SPLITTING METHOD FOR PRICING THE ELS OPTION DARAE JEONG, IN-SUK WEE, AND JUNSEOK KIM DEPARTMENT OF MATHEMATICS, KOREA UNIVERSITY, SEOUL 136-71, KOREA E-mail

More information

A Hybrid Commodity and Interest Rate Market Model

A Hybrid Commodity and Interest Rate Market Model A Hybrid Commodity and Interest Rate Market Model University of Technology, Sydney June 1 Literature A Hybrid Market Model Recall: The basic LIBOR Market Model The cross currency LIBOR Market Model LIBOR

More information

2D penalized spline (continuous-by-continuous interaction)

2D penalized spline (continuous-by-continuous interaction) 2D penalized spline (continuous-by-continuous interaction) Two examples (RWC, Section 13.1): Number of scallops caught off Long Island Counts are made at specific coordinates. Incidence of AIDS in Italian

More information

Portfolio Management and Optimal Execution via Convex Optimization

Portfolio Management and Optimal Execution via Convex Optimization Portfolio Management and Optimal Execution via Convex Optimization Enzo Busseti Stanford University April 9th, 2018 Problems portfolio management choose trades with optimization minimize risk, maximize

More information

Risk Measurement in Credit Portfolio Models

Risk Measurement in Credit Portfolio Models 9 th DGVFM Scientific Day 30 April 2010 1 Risk Measurement in Credit Portfolio Models 9 th DGVFM Scientific Day 30 April 2010 9 th DGVFM Scientific Day 30 April 2010 2 Quantitative Risk Management Profit

More information

Pricing American Options Using a Space-time Adaptive Finite Difference Method

Pricing American Options Using a Space-time Adaptive Finite Difference Method Pricing American Options Using a Space-time Adaptive Finite Difference Method Jonas Persson Abstract American options are priced numerically using a space- and timeadaptive finite difference method. The

More information

Forward Monte-Carlo Scheme for PDEs: Multi-Type Marked Branching Diffusions

Forward Monte-Carlo Scheme for PDEs: Multi-Type Marked Branching Diffusions Forward Monte-Carlo Scheme for PDEs: Multi-Type Marked Branching Diffusions Pierre Henry-Labordère 1 1 Global markets Quantitative Research, SOCIÉTÉ GÉNÉRALE Outline 1 Introduction 2 Semi-linear PDEs 3

More information

Write legibly. Unreadable answers are worthless.

Write legibly. Unreadable answers are worthless. MMF 2021 Final Exam 1 December 2016. This is a closed-book exam: no books, no notes, no calculators, no phones, no tablets, no computers (of any kind) allowed. Do NOT turn this page over until you are

More information

A New Multivariate Kurtosis and Its Asymptotic Distribution

A New Multivariate Kurtosis and Its Asymptotic Distribution A ew Multivariate Kurtosis and Its Asymptotic Distribution Chiaki Miyagawa 1 and Takashi Seo 1 Department of Mathematical Information Science, Graduate School of Science, Tokyo University of Science, Tokyo,

More information

The Numerical Valuation of Options with Underlying Jumps

The Numerical Valuation of Options with Underlying Jumps The Numerical Valuation of Options with Underlying Jumps Gunter H. Meyer School of Mathematics Georgia Institute of Technology Atlanta, GA, 30332-060, U.S.A. Abstract A Black-Scholes type model for American

More information

Application of MCMC Algorithm in Interest Rate Modeling

Application of MCMC Algorithm in Interest Rate Modeling Application of MCMC Algorithm in Interest Rate Modeling Xiaoxia Feng and Dejun Xie Abstract Interest rate modeling is a challenging but important problem in financial econometrics. This work is concerned

More information

Economics 2010c: Lecture 4 Precautionary Savings and Liquidity Constraints

Economics 2010c: Lecture 4 Precautionary Savings and Liquidity Constraints Economics 2010c: Lecture 4 Precautionary Savings and Liquidity Constraints David Laibson 9/11/2014 Outline: 1. Precautionary savings motives 2. Liquidity constraints 3. Application: Numerical solution

More information

Evaluating the Longstaff-Schwartz method for pricing of American options

Evaluating the Longstaff-Schwartz method for pricing of American options U.U.D.M. Project Report 2015:13 Evaluating the Longstaff-Schwartz method for pricing of American options William Gustafsson Examensarbete i matematik, 15 hp Handledare: Josef Höök, Institutionen för informationsteknologi

More information

Chapter 5 Univariate time-series analysis. () Chapter 5 Univariate time-series analysis 1 / 59

Chapter 5 Univariate time-series analysis. () Chapter 5 Univariate time-series analysis 1 / 59 Chapter 5 Univariate time-series analysis () Chapter 5 Univariate time-series analysis 1 / 59 Time-Series Time-series is a sequence fx 1, x 2,..., x T g or fx t g, t = 1,..., T, where t is an index denoting

More information

Energy Systems under Uncertainty: Modeling and Computations

Energy Systems under Uncertainty: Modeling and Computations Energy Systems under Uncertainty: Modeling and Computations W. Römisch Humboldt-University Berlin Department of Mathematics www.math.hu-berlin.de/~romisch Systems Analysis 2015, November 11 13, IIASA (Laxenburg,

More information

Space time adaptive finite difference method for European multi-asset options

Space time adaptive finite difference method for European multi-asset options Computers and Mathematics with Applications 53 (2007) 1159 1180 www.elsevier.com/locate/camwa Space time adaptive finite difference method for European multi-asset options Per Lötstedt a,, Jonas Persson

More information

A SURVEY OF NUMERICAL METHODS FOR LÉVY MARKETS

A SURVEY OF NUMERICAL METHODS FOR LÉVY MARKETS A SURVEY OF NUMERICAL METHODS FOR LÉVY MARKETS MICHAEL CHIU AUGUST 7, 2014 Abstract. The modeling of financial markets by Lévy process has become an active area of research during recent years. This has

More information

A distributed Laplace transform algorithm for European options

A distributed Laplace transform algorithm for European options A distributed Laplace transform algorithm for European options 1 1 A. J. Davies, M. E. Honnor, C.-H. Lai, A. K. Parrott & S. Rout 1 Department of Physics, Astronomy and Mathematics, University of Hertfordshire,

More information

Lecture Note 9 of Bus 41914, Spring Multivariate Volatility Models ChicagoBooth

Lecture Note 9 of Bus 41914, Spring Multivariate Volatility Models ChicagoBooth Lecture Note 9 of Bus 41914, Spring 2017. Multivariate Volatility Models ChicagoBooth Reference: Chapter 7 of the textbook Estimation: use the MTS package with commands: EWMAvol, marchtest, BEKK11, dccpre,

More information

On Complexity of Multistage Stochastic Programs

On Complexity of Multistage Stochastic Programs On Complexity of Multistage Stochastic Programs Alexander Shapiro School of Industrial and Systems Engineering, Georgia Institute of Technology, Atlanta, Georgia 30332-0205, USA e-mail: ashapiro@isye.gatech.edu

More information

Common Drifting Volatility in Large Bayesian VARs

Common Drifting Volatility in Large Bayesian VARs Common Drifting Volatility in Large Bayesian VARs Andrea Carriero 1 Todd Clark 2 Massimiliano Marcellino 3 1 Queen Mary, University of London 2 Federal Reserve Bank of Cleveland 3 European University Institute,

More information

Pakes (1986): Patents as Options: Some Estimates of the Value of Holding European Patent Stocks

Pakes (1986): Patents as Options: Some Estimates of the Value of Holding European Patent Stocks Pakes (1986): Patents as Options: Some Estimates of the Value of Holding European Patent Stocks Spring 2009 Main question: How much are patents worth? Answering this question is important, because it helps

More information

Interest Rate Curves Calibration with Monte-Carlo Simulatio

Interest Rate Curves Calibration with Monte-Carlo Simulatio Interest Rate Curves Calibration with Monte-Carlo Simulation 24 june 2008 Participants A. Baena (UCM) Y. Borhani (Univ. of Oxford) E. Leoncini (Univ. of Florence) R. Minguez (UCM) J.M. Nkhaso (UCM) A.

More information

BOUNDS FOR THE LEAST SQUARES RESIDUAL USING SCALED TOTAL LEAST SQUARES

BOUNDS FOR THE LEAST SQUARES RESIDUAL USING SCALED TOTAL LEAST SQUARES BOUNDS FOR THE LEAST SQUARES RESIDUAL USING SCALED TOTAL LEAST SQUARES Christopher C. Paige School of Computer Science, McGill University Montreal, Quebec, Canada, H3A 2A7 paige@cs.mcgill.ca Zdeněk Strakoš

More information

Multi-period Portfolio Choice and Bayesian Dynamic Models

Multi-period Portfolio Choice and Bayesian Dynamic Models Multi-period Portfolio Choice and Bayesian Dynamic Models Petter Kolm and Gordon Ritter Courant Institute, NYU Paper appeared in Risk Magazine, Feb. 25 (2015) issue Working paper version: papers.ssrn.com/sol3/papers.cfm?abstract_id=2472768

More information

King s College London

King s College London King s College London University Of London This paper is part of an examination of the College counting towards the award of a degree. Examinations are governed by the College Regulations under the authority

More information

Math489/889 Stochastic Processes and Advanced Mathematical Finance Homework 5

Math489/889 Stochastic Processes and Advanced Mathematical Finance Homework 5 Math489/889 Stochastic Processes and Advanced Mathematical Finance Homework 5 Steve Dunbar Due Fri, October 9, 7. Calculate the m.g.f. of the random variable with uniform distribution on [, ] and then

More information

Probabilistic Meshless Methods for Bayesian Inverse Problems. Jon Cockayne July 8, 2016

Probabilistic Meshless Methods for Bayesian Inverse Problems. Jon Cockayne July 8, 2016 Probabilistic Meshless Methods for Bayesian Inverse Problems Jon Cockayne July 8, 2016 1 Co-Authors Chris Oates Tim Sullivan Mark Girolami 2 What is PN? Many problems in mathematics have no analytical

More information

King s College London

King s College London King s College London University Of London This paper is part of an examination of the College counting towards the award of a degree. Examinations are governed by the College Regulations under the authority

More information

Econ 582 Nonlinear Regression

Econ 582 Nonlinear Regression Econ 582 Nonlinear Regression Eric Zivot June 3, 2013 Nonlinear Regression In linear regression models = x 0 β (1 )( 1) + [ x ]=0 [ x = x] =x 0 β = [ x = x] [ x = x] x = β it is assumed that the regression

More information

Infinite Reload Options: Pricing and Analysis

Infinite Reload Options: Pricing and Analysis Infinite Reload Options: Pricing and Analysis A. C. Bélanger P. A. Forsyth April 27, 2006 Abstract Infinite reload options allow the user to exercise his reload right as often as he chooses during the

More information

Exact Sampling of Jump-Diffusion Processes

Exact Sampling of Jump-Diffusion Processes 1 Exact Sampling of Jump-Diffusion Processes and Dmitry Smelov Management Science & Engineering Stanford University Exact Sampling of Jump-Diffusion Processes 2 Jump-Diffusion Processes Ubiquitous in finance

More information

PROJECT REPORT. Dimension Reduction for the Black-Scholes Equation. Alleviating the Curse of Dimensionality

PROJECT REPORT. Dimension Reduction for the Black-Scholes Equation. Alleviating the Curse of Dimensionality Dimension Reduction for the Black-Scholes Equation Alleviating the Curse of Dimensionality Erik Ekedahl, Eric Hansander and Erik Lehto Report in Scientic Computing, Advanced Course June 2007 PROJECT REPORT

More information

Partitioned Analysis of Coupled Systems

Partitioned Analysis of Coupled Systems Partitioned Analysis of Coupled Systems Hermann G. Matthies, Rainer Niekamp, Jan Steindorf Technische Universität Braunschweig Brunswick, Germany wire@tu-bs.de http://www.wire.tu-bs.de Coupled Problems

More information

Short-time-to-expiry expansion for a digital European put option under the CEV model. November 1, 2017

Short-time-to-expiry expansion for a digital European put option under the CEV model. November 1, 2017 Short-time-to-expiry expansion for a digital European put option under the CEV model November 1, 2017 Abstract In this paper I present a short-time-to-expiry asymptotic series expansion for a digital European

More information

Monte Carlo Pricing of Bermudan Options:

Monte Carlo Pricing of Bermudan Options: Monte Carlo Pricing of Bermudan Options: Correction of super-optimal and sub-optimal exercise Christian Fries 12.07.2006 (Version 1.2) www.christian-fries.de/finmath/talks/2006foresightbias 1 Agenda Monte-Carlo

More information

Numerical Simulation of Stochastic Differential Equations: Lecture 2, Part 2

Numerical Simulation of Stochastic Differential Equations: Lecture 2, Part 2 Numerical Simulation of Stochastic Differential Equations: Lecture 2, Part 2 Des Higham Department of Mathematics University of Strathclyde Montreal, Feb. 2006 p.1/17 Lecture 2, Part 2: Mean Exit Times

More information

Monte Carlo Methods for Uncertainty Quantification

Monte Carlo Methods for Uncertainty Quantification Monte Carlo Methods for Uncertainty Quantification Mike Giles Mathematical Institute, University of Oxford KU Leuven Summer School on Uncertainty Quantification May 30 31, 2013 Mike Giles (Oxford) Monte

More information

Parallel Multilevel Monte Carlo Simulation

Parallel Multilevel Monte Carlo Simulation Parallel Simulation Mathematisches Institut Goethe-Universität Frankfurt am Main Advances in Financial Mathematics Paris January 7-10, 2014 Simulation Outline 1 Monte Carlo 2 3 4 Algorithm Numerical Results

More information

Monte Carlo Methods in Finance

Monte Carlo Methods in Finance Monte Carlo Methods in Finance Peter Jackel JOHN WILEY & SONS, LTD Preface Acknowledgements Mathematical Notation xi xiii xv 1 Introduction 1 2 The Mathematics Behind Monte Carlo Methods 5 2.1 A Few Basic

More information

Market Risk Analysis Volume I

Market Risk Analysis Volume I Market Risk Analysis Volume I Quantitative Methods in Finance Carol Alexander John Wiley & Sons, Ltd List of Figures List of Tables List of Examples Foreword Preface to Volume I xiii xvi xvii xix xxiii

More information

SAQ KONTROLL AB Box 49306, STOCKHOLM, Sweden Tel: ; Fax:

SAQ KONTROLL AB Box 49306, STOCKHOLM, Sweden Tel: ; Fax: ProSINTAP - A Probabilistic Program for Safety Evaluation Peter Dillström SAQ / SINTAP / 09 SAQ KONTROLL AB Box 49306, 100 29 STOCKHOLM, Sweden Tel: +46 8 617 40 00; Fax: +46 8 651 70 43 June 1999 Page

More information

Chapter 5 Univariate time-series analysis. () Chapter 5 Univariate time-series analysis 1 / 29

Chapter 5 Univariate time-series analysis. () Chapter 5 Univariate time-series analysis 1 / 29 Chapter 5 Univariate time-series analysis () Chapter 5 Univariate time-series analysis 1 / 29 Time-Series Time-series is a sequence fx 1, x 2,..., x T g or fx t g, t = 1,..., T, where t is an index denoting

More information

EFFICIENT MONTE CARLO ALGORITHM FOR PRICING BARRIER OPTIONS

EFFICIENT MONTE CARLO ALGORITHM FOR PRICING BARRIER OPTIONS Commun. Korean Math. Soc. 23 (2008), No. 2, pp. 285 294 EFFICIENT MONTE CARLO ALGORITHM FOR PRICING BARRIER OPTIONS Kyoung-Sook Moon Reprinted from the Communications of the Korean Mathematical Society

More information

Numerical methods for solving stochastic partial differential equations in the Tensor Train format

Numerical methods for solving stochastic partial differential equations in the Tensor Train format Numerical methods for solving stochastic partial differential equations in the Tensor Train format tifica Alexander Litvinenko 1 (joint work with Sergey Dolgov 2,3, Boris Khoromskij 3 and Hermann G. Matthies

More information

Multi-Period Trading via Convex Optimization

Multi-Period Trading via Convex Optimization Multi-Period Trading via Convex Optimization Stephen Boyd Enzo Busseti Steven Diamond Ronald Kahn Kwangmoo Koh Peter Nystrup Jan Speth Stanford University & Blackrock City University of Hong Kong September

More information

Introduction to Sequential Monte Carlo Methods

Introduction to Sequential Monte Carlo Methods Introduction to Sequential Monte Carlo Methods Arnaud Doucet NCSU, October 2008 Arnaud Doucet () Introduction to SMC NCSU, October 2008 1 / 36 Preliminary Remarks Sequential Monte Carlo (SMC) are a set

More information

Monte Carlo Simulations

Monte Carlo Simulations Monte Carlo Simulations Lecture 1 December 7, 2014 Outline Monte Carlo Methods Monte Carlo methods simulate the random behavior underlying the financial models Remember: When pricing you must simulate

More information

Estimating Value-at-Risk using Multilevel Monte Carlo Maximum Entropy method

Estimating Value-at-Risk using Multilevel Monte Carlo Maximum Entropy method Estimating Value-at-Risk using Multilevel Monte Carlo Maximum Entropy method Wenhui Gou University of Oxford A thesis submitted for the degree of MSc Mathematical and Computational Finance June 24, 2016

More information

The Forward Kolmogorov Equation for Two Dimensional Options

The Forward Kolmogorov Equation for Two Dimensional Options The Forward Kolmogorov Equation for Two Dimensional Options Antoine Conze (Nexgenfs bank), Nicolas Lantos (Nexgenfs bank and UPMC), Olivier Pironneau (LJLL, University of Paris VI) March, 04 Abstract Pricing

More information

Exact shape-reconstruction by one-step linearization in EIT

Exact shape-reconstruction by one-step linearization in EIT Exact shape-reconstruction by one-step linearization in EIT Bastian von Harrach harrach@math.uni-mainz.de Zentrum Mathematik, M1, Technische Universität München, Germany Joint work with Jin Keun Seo, Yonsei

More information

ELEMENTS OF MONTE CARLO SIMULATION

ELEMENTS OF MONTE CARLO SIMULATION APPENDIX B ELEMENTS OF MONTE CARLO SIMULATION B. GENERAL CONCEPT The basic idea of Monte Carlo simulation is to create a series of experimental samples using a random number sequence. According to the

More information

Efficient Deterministic Numerical Simulation of Stochastic Asset-Liability Management Models in Life Insurance

Efficient Deterministic Numerical Simulation of Stochastic Asset-Liability Management Models in Life Insurance Efficient Deterministic Numerical Simulation of Stochastic Asset-Liability Management Models in Life Insurance Thomas Gerstner, Michael Griebel, Markus Holtz Institute for Numerical Simulation, University

More information

Exam in TFY4275/FY8907 CLASSICAL TRANSPORT THEORY Feb 14, 2014

Exam in TFY4275/FY8907 CLASSICAL TRANSPORT THEORY Feb 14, 2014 NTNU Page 1 of 5 Institutt for fysikk Contact during the exam: Professor Ingve Simonsen Exam in TFY4275/FY8907 CLASSICAL TRANSPORT THEORY Feb 14, 2014 Allowed help: Alternativ D All written material This

More information

Barrier Option. 2 of 33 3/13/2014

Barrier Option. 2 of 33 3/13/2014 FPGA-based Reconfigurable Computing for Pricing Multi-Asset Barrier Options RAHUL SRIDHARAN, GEORGE COOKE, KENNETH HILL, HERMAN LAM, ALAN GEORGE, SAAHPC '12, PROCEEDINGS OF THE 2012 SYMPOSIUM ON APPLICATION

More information

6.231 DYNAMIC PROGRAMMING LECTURE 10 LECTURE OUTLINE

6.231 DYNAMIC PROGRAMMING LECTURE 10 LECTURE OUTLINE 6.231 DYNAMIC PROGRAMMING LECTURE 10 LECTURE OUTLINE Rollout algorithms Cost improvement property Discrete deterministic problems Approximations of rollout algorithms Discretization of continuous time

More information

Chapter 5 Finite Difference Methods. Math6911 W07, HM Zhu

Chapter 5 Finite Difference Methods. Math6911 W07, HM Zhu Chapter 5 Finite Difference Methods Math69 W07, HM Zhu References. Chapters 5 and 9, Brandimarte. Section 7.8, Hull 3. Chapter 7, Numerical analysis, Burden and Faires Outline Finite difference (FD) approximation

More information

Space-time adaptive finite difference method for European multi-asset options

Space-time adaptive finite difference method for European multi-asset options Space-time adaptive finite difference method for European multi-asset options Per Lötstedt 1, Jonas Persson 1, Lina von Sydow 1 Ý, Johan Tysk 2 Þ 1 Division of Scientific Computing, Department of Information

More information

A Monte Carlo Based Analysis of Optimal Design Criteria

A Monte Carlo Based Analysis of Optimal Design Criteria A Monte Carlo Based Analysis of Optimal Design Criteria H. T. Banks, Kathleen J. Holm and Franz Kappel Center for Quantitative Sciences in Biomedicine Center for Research in Scientific Computation North

More information

A NOTE ON NUMERICAL SOLUTION OF A LINEAR BLACK-SCHOLES MODEL

A NOTE ON NUMERICAL SOLUTION OF A LINEAR BLACK-SCHOLES MODEL GANIT J. Bangladesh Math. Soc. (ISSN 1606-3694) Vol. 33 (2013) 103-115 A NOTE ON NUMERICAL SOLUTION OF A LINEAR BLACK-SCHOLES MODEL Md. Kazi Salah Uddin 1*, Mostak Ahmed 2 and Samir Kumar Bhowmik 1,3 1

More information

Fourier Space Time-stepping Method for Option Pricing with Lévy Processes

Fourier Space Time-stepping Method for Option Pricing with Lévy Processes FST method Extensions Indifference pricing Fourier Space Time-stepping Method for Option Pricing with Lévy Processes Vladimir Surkov University of Toronto Computational Methods in Finance Conference University

More information

Technical Appendix: Policy Uncertainty and Aggregate Fluctuations.

Technical Appendix: Policy Uncertainty and Aggregate Fluctuations. Technical Appendix: Policy Uncertainty and Aggregate Fluctuations. Haroon Mumtaz Paolo Surico July 18, 2017 1 The Gibbs sampling algorithm Prior Distributions and starting values Consider the model to

More information

Robust Optimization Applied to a Currency Portfolio

Robust Optimization Applied to a Currency Portfolio Robust Optimization Applied to a Currency Portfolio R. Fonseca, S. Zymler, W. Wiesemann, B. Rustem Workshop on Numerical Methods and Optimization in Finance June, 2009 OUTLINE Introduction Motivation &

More information

Improved radial basis function methods for multi-dimensional option pricing

Improved radial basis function methods for multi-dimensional option pricing Improved radial basis function methods for multi-dimensional option pricing Ulrika Pettersson a;, Elisabeth Larsson a;2;λ, Gunnar Marcusson b and Jonas Persson a; a Address: Department of Information Technology,

More information

Stock Loan Valuation Under Brownian-Motion Based and Markov Chain Stock Models

Stock Loan Valuation Under Brownian-Motion Based and Markov Chain Stock Models Stock Loan Valuation Under Brownian-Motion Based and Markov Chain Stock Models David Prager 1 1 Associate Professor of Mathematics Anderson University (SC) Based on joint work with Professor Qing Zhang,

More information

Monte Carlo Methods for Uncertainty Quantification

Monte Carlo Methods for Uncertainty Quantification Monte Carlo Methods for Uncertainty Quantification Abdul-Lateef Haji-Ali Based on slides by: Mike Giles Mathematical Institute, University of Oxford Contemporary Numerical Techniques Haji-Ali (Oxford)

More information

Contents Critique 26. portfolio optimization 32

Contents Critique 26. portfolio optimization 32 Contents Preface vii 1 Financial problems and numerical methods 3 1.1 MATLAB environment 4 1.1.1 Why MATLAB? 5 1.2 Fixed-income securities: analysis and portfolio immunization 6 1.2.1 Basic valuation of

More information

Galerkin Least Square FEM for the European option price with CEV model

Galerkin Least Square FEM for the European option price with CEV model Galerkin Least Square FEM for the European option price with CEV model A Major Qualifying Project Submitted to the Faculty of Worcester Polytechnic Institute In partial fulfillment of requirements for

More information

Seminar: Efficient Monte Carlo Methods for Uncertainty Quantification

Seminar: Efficient Monte Carlo Methods for Uncertainty Quantification Seminar: Efficient Monte Carlo Methods for Uncertainty Quantification Elisabeth Ullmann Lehrstuhl für Numerische Mathematik (M2) TU München Elisabeth Ullmann (TU München) Efficient Monte Carlo for UQ 1

More information