Partitioned Analysis of Coupled Systems

Size: px
Start display at page:

Download "Partitioned Analysis of Coupled Systems"

Transcription

1 Partitioned Analysis of Coupled Systems Hermann G. Matthies, Rainer Niekamp, Jan Steindorf Technische Universität Braunschweig Brunswick, Germany

2 Coupled Problems 2 Coupled problems often combine the models of two or more physical systems, they are multi-physics modells. Different approaches: Monolithical approach, which means one global model of everything Advantages: All encompassing theoretical and numerical treatment Disadvantages: Treatment is ever more complex, every time completely new start, new algorithms, new software, does not scale, not modular Partitioned approach, which means separate models plus coupling Advantages: Complexity constrained to one physical domain, theory may be well worked out, efficient numerical algorithms, existing sophisticated software for each subsystem, modular, scalable Disadvantages: Subsystems have to be coupled together, new numerical and algorithmic problems, coupling software necessary

3 Example: Fluid-Structure-Coupling 3 Fluid incompressible Newtonian fluid (i.e. Navier-Stokes eqns.) in ALE formulation: ϱ f ( v + (v χ) v) div σ + p = r f, 2σ = ν( v + ( v) T ) = 2ν s v, div v = 0, plus boundary conditions. Solid large deformation elastic St. Venant material in Lagrangean formulation: ϱ s ü DIV (F S) = r s, F = I + GRAD u S = λ(tr E)I + 2µE, 2E = (C I), C = F T F, plus boundary conditions. Arbitrary Lagrangean-Eulerian coordinate system: Lχ = β Γ u

4 Example: FSI Interface 4 Conditions on interface Γ I : At spatial location χ(t) = χ 0 + u(χ 0, t) Γ I continuity of velocities: v(χ(t), t) = u(χ 0, t). Variational formulation for velocity condition: Γ I τ I (v(χ(t), t) u(χ 0, t)) dγ I = 0 Conservation of momentum balance of tractions: (σ pi) n = 1 J F SF T n, J = det F. Variational formulation for traction condition treat like any other boundary traction, boundary traction is equal to Lagrange multiplier τ I.

5 Pure Differential Coupling 5 The simplest case is pure differential coupling: The first subsystem as evolution equation in some space X 1 : ẋ 1 = f 1 (x 1, x 2 ), x 1 X 1, The second subsystem as evolution equation in some space X 2 : ẋ 2 = f 2 (x 2, x 1 ), x 2 X 2, Combined nothing but a evolution equation for (x 1, x 2 ) X 1 X 2, direct identification of differential variables in both subsystems. Might have been produced by the partition of monolithic system, or by combination of subsystems with identifiable variables

6 Pure Explicit Coupling 6 Assume that subsystems have been discretised in time (and in space if desired), assume for simplicity same time-step in both subsystems. Approximation at time-step n denoted by x (n) j, (j = 1, 2), with explicit or implicit time-discrete evolution ϕ j, with functions Ψ j (n, t) to approximate evolution of variable x j in [t n 1, t n ]. x (n) 1 = ϕ 1 (x (n 1) 1, Ψ 2 (n, t)), x (n) 2 = ϕ 2 (x (n 1) 2, Ψ 1 (n, t)), Ψ j (n, t) are most easily produced by extrapolation of past values of x (m) j, (j = 1, 2; m = n 1, n 2,...). Simplest case is constant extrapolation pure weak or loose coupling (switching): Ψ j (n, t) x (n 1) j, (j = 1, 2)

7 Explicit Coupling Staggering 7 Advantages: Absolutely simple, can be performed in parallel Disadvantages: Critical time step will appear or may decrease, in case of simple Ψ j (n, t) only first order accurate in t, better extrapolation Ψ j (n, t) decreases stability limit. To achieve better method sacrificing inherent parallelism take as before Ψ 2 (n, t) x (n 1) 2 but then in a Gauss-Seidel fashion to give the basic staggering method: Ψ 1 (n, t) = ϕ 1 (x (n 1) 1, Ψ 2 (n, t)) = x (n) 1.

8 Implicit Coupling 8 Assume that subsystems integrators are implicit, x (n) 1 = φ 1 (x (n) 1, x(n 1) 1, Ψ 2 ), x (n) 2 = φ 2 (x (n) 2, x(n 1) 2, Ψ 1 ), Ψ j (n, t) an interpolation including still unknown x (n) j, simplest case purely constant extrapolation strong or tight coupling: Ψ j (n, t) x (n) j, (j = 1, 2), requires global iteration simplest case as before in time-stepping: in Jacobi or additive Schwarz fashion, or in Gauss-Seidel or multiplicative Schwarz fashion. Advantages: May be globally unconditionally stable, may be higher order in t without compromising stability, same results as monolithical approach. Disadvantages: Requires global iteration, but will converge for small t.

9 Differential-Algebraic Coupling 9 Assume that subsystems are differential-algebraic equations (DAEs) with local differential variables x 1 X 1, local algebraic variables y 1 Y 1 : ẋ 1 = f 1 (x 1, y 1, z), 0 = g 1 (x 1, x 2, y 1, z), same for the second subsystem with local differential variables x 2 X 2, local algebraic variables y 2 Y 2 : ẋ 2 = f 2 (x 2, y 2, z), 0 = g 2 (x 2, x 1, y 2, z). Coupling conditions formulated as algebraic constraints with global algebraic variables z Z: 0 = h(x 1, x 2, y 1, y 2, z).

10 Differential-Algebraic Regularity 10 Assume that each single subsystem, and also global system is an index-1 DAE. This means that the operator matrices D yj g j, [ ] Dyj g j D z g j, (j = 1, 2), D yj h D z h [ Dy g ] D z g D y h D z h have to be regular, where D q is the partial derivative w.r.t. q, and we have set g = (g 1, g 2 ) T and y = (y 1, y 2 ) T. After time discretisation we time-discretise DAEs with an implicit method we have a global system of equations: (x (n) 1, y(n) 1 )T = Φ 1 (x (n) 1, x(n 1) 1, y (n) 1, y(n 1) 1, z (n), z (n 1) ), (x (n) 2, y(n) 2 )T = Φ 2 (x (n) 2, x(n 1) 2, y (n) 2, y(n 1) 2, z (n), z (n 1) ), 0 = h(x (n) 1, x(n) 2, y(n) 1, y(n) 2, z(n) ).

11 Discrete Form of Fluid-Structure-Interaction 11 The Fluid and the ALE-Domain: M f v + N(v χ)v + K f v + B f p = r f + T T f τ I ;, B T f v = 0, K g χ = Au. The Solid: The Interface: M s ü + K s (u)u = r s T T s τ I. T f v = T s u. Equality of interface tractions on coupling interface already included in terms T T f τ I and T T s τ I.

12 The DAE Correspondence 12 The Fluid and the ALE-Domain: (with b := v, the fluid acceleration) and ψ = χ: [ v x 1 =, y χ] 1 = b [ p b, f 1 =, z = τ ψ] I, ψ M f b + N f (v ψ)v + K f v + B f p r f T T f τ I g 1 = B T f M 1 f ( N f(v ψ)v B f p K f v + r f + T T f τ I), K g ψ Aw The Solid: (with a := ẇ = ü, the structural acceleration). [ [ u w x 2 =, y w] 2 = a, f 2 =, z = τ a] I The Interface: g 2 = M s a + K s (u)u r s + T T s τ I ;, h = T f b T s a.

13 Global Equations for Strong Coupling 13 Coupling condition h = 0 usually included with one subsystem in solution process. Set ξ := (x 1, y 1, z) T = (v, χ, b, p, ψ, τ I ) T and ζ := (x 2, y 2 ) T = (u, w, a) T to include interface in first equation, otherwise include z = τ I in ζ and not in ξ. Assume that convergent iterative solvers for subsystems exist: and ξ κ = F 1 (ξ κ 1, ζ), κ = 1, 2,... ; ζ κ = F 2 (ζ κ 1, ξ), κ = 1, 2,... ; Simplest solution process is nonlinear block-jacobi, an additive or parallel Schwarz procedure: ξ κ = F ν 1 1 (ξ κ 1, ζ κ 1 ), ζ κ = F ν 2 2 (ζ κ 1, ξ κ 1 ) ;

14 Nonlinear block-gauss-seidel 14 Almost as simple is nonlinear block-gauss-seidel, a multiplicative or serial Schwarz procedure: ξ κ = F ν 1 1 (ξ κ 1, ζ κ 1 ), and with newly computed ξ κ, do ζ κ = F ν 2 2 (ζ κ 1, ξ κ ). Theorem:[Arnold, Günther] In block-g-s, let L be Lipschitz-constant of Ψ j, and let ( ) 1 α = max (D y 2 g 2 ) 1 D z g 2 D y1 h (D y1 g 1 ) 1 D z g 1 Dy2 h, t [0,T ] the iteration only converges if α < 1, and if at least κ iterations are performed so that Lα κ < 1, and the total global time-step error δ is bounded by δ < C(µ max{0,κ 2} ψ(x) + µ κ 1 ψ(y)) + ε 1 (x) + ε 2 (y), ψ is extrapolation error, ε j is subsystem integrator error, and µ = α + O( t) < 1.

15 Eliminating one Variable 15 One may see block-g-s in the following: F ν 1 1 : ζ κ 1 ξ κ, followed by: (ξ becomes internal ) F ν 2 2 : ξ κ ζ κ. In toto, there is a mapping on ζ alone: S : ζ κ 1 ζ κ ζ may be just the variables on interface. Fixed-point of the map S is part of the solution The fixed-point equation may be solved by some other method (e.g. preconditioned, Newton, Quasi-Newton, etc.)

16 Different Possibilities for block-gauss-seidel 16 For different ordering and distribution of constraint, we have 1st fluid plus coupling, 2nd solid: α = M 1 s T T s (T f M 1 T T f ) 1 T s,, where M 1 = M 1 f (M f B f M p B T f M p = (B T f M 1 f B f) 1. )M 1 f is a Schur complement, and 1st structure plus coupling, 2nd fluid: α = M 1 T T f (T sm 1 s T T s ) 1 T f. 1st fluid, 2nd solid plus coupling: α = (T s M 1 s T T s ) 1 (T f M 1 T T f ). 1st solid plus coupling, 2nd fluid: α = (T f M 1 T T f ) 1 (T s M 1 s T T s ). α depends on ϱ f /ϱ s.

17 Block-Newton 17 Desirable is an iteration scheme which will not depend on ordering and distribution of constraint: Block-Newton. In each block-newton iteration following system has to be solved: [ I Dξ F 1 D ζ F 1 D ξ F 2 Symbolic block-gauss elimination: ] [ ] ξκ I D ζ F 2 ζ κ = [ ] ξκ F 1 (ξ κ, ζ κ ). ζ κ F 2 (ζ κ, ξ κ ) ξ = (I D ξ F 1 ) 1 (ξ F 1 (ξ, ζ)) C ζ, with the multiplier matrix C := (I D ξ F 1 ) 1 [D ζ F 1 ]. Further with Schur complement matrix S: S ζ := (I [D ζ F 2 ] [D ξ F 2 ]C) ζ = r, with r := (ζ F 2 (ζ, ξ)) + [D ξ F 2 ]q, q := (I D ξ F 1 ) 1 (ξ F 1 (ξ, ζ)).

18 Solving the Block-Newton System 18 Solution proceeds by Krylov method (Bi-CGstab): Solving a system with (I D ξ F 1 ): Apply iterative solver F 1 Same with C, plus finite differences for [D ζ F 1 ] Solving the Schur-complement system: Use Bi-CGstab. Compute r with iterating subsystem solver F 2 ; compute action of S by finite differences. Theorem:[Mackens, Voss] If the single system solvers are quadratically convergent (or enough iterations are made in the approximative steps), the global iteration is also quadratically convergent.

19 Quasi-Newton 19 Quasi-Newton methods are generalisations of secant method: [H κ ] [ ] ξκ ζ κ = [ ] ξκ F 1 (ξ κ, ζ κ ). ζ κ F 2 (ζ κ, ξ κ ) Easy to solve with H κ (explicit inverse H 1 κ ). H κ changes by low rank only from step to step. H 1 κ = H 1 κ 1 + a κ b T κ a rank one update or a rank two update H 1 κ = H 1 κ 1 + a κ a T κ + +b κ b T κ a κ, b κ are easy to compute from known data

20 Ausflußrand A Simple Example 20 Fester Rand Einflußrand 1.0 Starrer Körper Elastische Struktur Fester Rand

21 Movement and Pressure Distribution 21

22 Tip Displacement Response Weak Coupling y Verschiebungen am Strukturende Simulationszeit t: dt = 0.02

23 Tip Displacement Response Strong Coupling y Verschiebungen am Strukturende Simulationszeit t: dt = 0.02

24 Iteration Count Approximatives Block Newton Block Gauß Seidel Iterationszahl Simulationszeit t: dt = 0.02

25 Solver Calls Approximatives Block Newton Block Gauß Seidel 80 Anzahl von Löseraufrufen Simulationszeit t: dt = 0.02

26 Another Example 26 Material St.Venant: η = 0.2, E = E l Navier-Lamé: η = 0.2, E = E r

27 Iteration Count 27 E l = 10 5, E r = E l = 10 5, E r = 10 6 E l = , E r = 10 6 iter cpu[t] Jacobi Gauss-Seidel BFGS Newton iter cpu[t] Jacobi - GS BFGS Newton iter cpu[t] Jacobi - GS - BFGS Newton

28 Conclusions 28 staggering algorithms may introduce critical time step coupling may introduce algebraic constraints DAEs are different from pure differential coupling block-gauss-seidel depends strongly on ordering in purely differential case may be made convergent with small t in DAE case may be unconditionally unstable Newton-methods are more robust

Part 3: Trust-region methods for unconstrained optimization. Nick Gould (RAL)

Part 3: Trust-region methods for unconstrained optimization. Nick Gould (RAL) Part 3: Trust-region methods for unconstrained optimization Nick Gould (RAL) minimize x IR n f(x) MSc course on nonlinear optimization UNCONSTRAINED MINIMIZATION minimize x IR n f(x) where the objective

More information

Project 1: Double Pendulum

Project 1: Double Pendulum Final Projects Introduction to Numerical Analysis II http://www.math.ucsb.edu/ atzberg/winter2009numericalanalysis/index.html Professor: Paul J. Atzberger Due: Friday, March 20th Turn in to TA s Mailbox:

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

Approximate Composite Minimization: Convergence Rates and Examples

Approximate Composite Minimization: Convergence Rates and Examples ISMP 2018 - Bordeaux Approximate Composite Minimization: Convergence Rates and S. Praneeth Karimireddy, Sebastian U. Stich, Martin Jaggi MLO Lab, EPFL, Switzerland sebastian.stich@epfl.ch July 4, 2018

More information

Hints on Some of the Exercises

Hints on Some of the Exercises Hints on Some of the Exercises of the book R. Seydel: Tools for Computational Finance. Springer, 00/004/006/009/01. Preparatory Remarks: Some of the hints suggest ideas that may simplify solving the exercises

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

IMPA Commodities Course : Forward Price Models

IMPA Commodities Course : Forward Price Models IMPA Commodities Course : Forward Price Models Sebastian Jaimungal sebastian.jaimungal@utoronto.ca Department of Statistics and Mathematical Finance Program, University of Toronto, Toronto, Canada http://www.utstat.utoronto.ca/sjaimung

More information

Stochastic Proximal Algorithms with Applications to Online Image Recovery

Stochastic Proximal Algorithms with Applications to Online Image Recovery 1/24 Stochastic Proximal Algorithms with Applications to Online Image Recovery Patrick Louis Combettes 1 and Jean-Christophe Pesquet 2 1 Mathematics Department, North Carolina State University, Raleigh,

More information

Chapter 3: Black-Scholes Equation and Its Numerical Evaluation

Chapter 3: Black-Scholes Equation and Its Numerical Evaluation Chapter 3: Black-Scholes Equation and Its Numerical Evaluation 3.1 Itô Integral 3.1.1 Convergence in the Mean and Stieltjes Integral Definition 3.1 (Convergence in the Mean) A sequence {X n } n ln of random

More information

Riemannian Geometry, Key to Homework #1

Riemannian Geometry, Key to Homework #1 Riemannian Geometry Key to Homework # Let σu v sin u cos v sin u sin v cos u < u < π < v < π be a parametrization of the unit sphere S {x y z R 3 x + y + z } Fix an angle < θ < π and consider the parallel

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

Calibration Lecture 1: Background and Parametric Models

Calibration Lecture 1: Background and Parametric Models Calibration Lecture 1: Background and Parametric Models March 2016 Motivation What is calibration? Derivative pricing models depend on parameters: Black-Scholes σ, interest rate r, Heston reversion speed

More information

A Trust Region Algorithm for Heterogeneous Multiobjective Optimization

A Trust Region Algorithm for Heterogeneous Multiobjective Optimization A Trust Region Algorithm for Heterogeneous Multiobjective Optimization Jana Thomann and Gabriele Eichfelder 8.0.018 Abstract This paper presents a new trust region method for multiobjective heterogeneous

More information

Trust Region Methods for Unconstrained Optimisation

Trust Region Methods for Unconstrained Optimisation Trust Region Methods for Unconstrained Optimisation Lecture 9, Numerical Linear Algebra and Optimisation Oxford University Computing Laboratory, MT 2007 Dr Raphael Hauser (hauser@comlab.ox.ac.uk) The Trust

More information

d n U i dx n dx n δ n U i

d n U i dx n dx n δ n U i Last time Taylor s series on equally spaced nodes Forward difference d n U i d n n U i h n + 0 h Backward difference d n U i d n n U i h n + 0 h Centered difference d n U i d n δ n U i or 2 h n + 0 h2

More information

AD in Monte Carlo for finance

AD in Monte Carlo for finance AD in Monte Carlo for finance Mike Giles giles@comlab.ox.ac.uk Oxford University Computing Laboratory AD & Monte Carlo p. 1/30 Overview overview of computational finance stochastic o.d.e. s Monte Carlo

More information

Dynamic Replication of Non-Maturing Assets and Liabilities

Dynamic Replication of Non-Maturing Assets and Liabilities Dynamic Replication of Non-Maturing Assets and Liabilities Michael Schürle Institute for Operations Research and Computational Finance, University of St. Gallen, Bodanstr. 6, CH-9000 St. Gallen, Switzerland

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

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

Multiname and Multiscale Default Modeling

Multiname and Multiscale Default Modeling Multiname and Multiscale Default Modeling Jean-Pierre Fouque University of California Santa Barbara Joint work with R. Sircar (Princeton) and K. Sølna (UC Irvine) Special Semester on Stochastics with Emphasis

More information

An adaptive cubic regularization algorithm for nonconvex optimization with convex constraints and its function-evaluation complexity

An adaptive cubic regularization algorithm for nonconvex optimization with convex constraints and its function-evaluation complexity An adaptive cubic regularization algorithm for nonconvex optimization with convex constraints and its function-evaluation complexity Coralia Cartis, Nick Gould and Philippe Toint Department of Mathematics,

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

What can we do with numerical optimization?

What can we do with numerical optimization? Optimization motivation and background Eddie Wadbro Introduction to PDE Constrained Optimization, 2016 February 15 16, 2016 Eddie Wadbro, Introduction to PDE Constrained Optimization, February 15 16, 2016

More information

PICOF, Palaiseau, April 2-4, 2012

PICOF, Palaiseau, April 2-4, 2012 The Sobolev gradient regularization strategy for optical tomography coupled with a finite element formulation of the radiative transfer equation Fabien Dubot, Olivier Balima, Yann Favennec, Daniel Rousse

More information

A Stochastic Levenberg-Marquardt Method Using Random Models with Application to Data Assimilation

A Stochastic Levenberg-Marquardt Method Using Random Models with Application to Data Assimilation A Stochastic Levenberg-Marquardt Method Using Random Models with Application to Data Assimilation E Bergou Y Diouane V Kungurtsev C W Royer July 5, 08 Abstract Globally convergent variants of the Gauss-Newton

More information

arxiv: v1 [q-fin.cp] 1 Nov 2016

arxiv: v1 [q-fin.cp] 1 Nov 2016 Essentially high-order compact schemes with application to stochastic volatility models on non-uniform grids arxiv:1611.00316v1 [q-fin.cp] 1 Nov 016 Bertram Düring Christof Heuer November, 016 Abstract

More information

Calibration Lecture 4: LSV and Model Uncertainty

Calibration Lecture 4: LSV and Model Uncertainty Calibration Lecture 4: LSV and Model Uncertainty March 2017 Recap: Heston model Recall the Heston stochastic volatility model ds t = rs t dt + Y t S t dw 1 t, dy t = κ(θ Y t ) dt + ξ Y t dw 2 t, where

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

Schémas implicites ou explicites sur mailles décalées pour Euler et Navier-Stokes compressible

Schémas implicites ou explicites sur mailles décalées pour Euler et Navier-Stokes compressible Schémas implicites ou explicites sur mailles décalées pour Euler et Navier-Stokes compressible R. Herbin, with T. Gallouët, L. Gastaldo, W. Kheriji, J.-C. Latché, T.T. Nguyen Université de Provence Institut

More information

Outline. 1 Introduction. 2 Algorithms. 3 Examples. Algorithm 1 General coordinate minimization framework. 1: Choose x 0 R n and set k 0.

Outline. 1 Introduction. 2 Algorithms. 3 Examples. Algorithm 1 General coordinate minimization framework. 1: Choose x 0 R n and set k 0. Outline Coordinate Minimization Daniel P. Robinson Department of Applied Mathematics and Statistics Johns Hopkins University November 27, 208 Introduction 2 Algorithms Cyclic order with exact minimization

More information

HIGH ORDER DISCONTINUOUS GALERKIN METHODS FOR 1D PARABOLIC EQUATIONS. Ahmet İzmirlioğlu. BS, University of Pittsburgh, 2004

HIGH ORDER DISCONTINUOUS GALERKIN METHODS FOR 1D PARABOLIC EQUATIONS. Ahmet İzmirlioğlu. BS, University of Pittsburgh, 2004 HIGH ORDER DISCONTINUOUS GALERKIN METHODS FOR D PARABOLIC EQUATIONS by Ahmet İzmirlioğlu BS, University of Pittsburgh, 24 Submitted to the Graduate Faculty of Art and Sciences in partial fulfillment of

More information

A Numerical Approach to the Estimation of Search Effort in a Search for a Moving Object

A Numerical Approach to the Estimation of Search Effort in a Search for a Moving Object Proceedings of the 1. Conference on Applied Mathematics and Computation Dubrovnik, Croatia, September 13 18, 1999 pp. 129 136 A Numerical Approach to the Estimation of Search Effort in a Search for a Moving

More information

Heterogeneous Firm, Financial Market Integration and International Risk Sharing

Heterogeneous Firm, Financial Market Integration and International Risk Sharing Heterogeneous Firm, Financial Market Integration and International Risk Sharing Ming-Jen Chang, Shikuan Chen and Yen-Chen Wu National DongHwa University Thursday 22 nd November 2018 Department of Economics,

More information

Decomposition Methods

Decomposition Methods Decomposition Methods separable problems, complicating variables primal decomposition dual decomposition complicating constraints general decomposition structures Prof. S. Boyd, EE364b, Stanford University

More information

FINITE DIFFERENCE METHODS

FINITE DIFFERENCE METHODS FINITE DIFFERENCE METHODS School of Mathematics 2013 OUTLINE Review 1 REVIEW Last time Today s Lecture OUTLINE Review 1 REVIEW Last time Today s Lecture 2 DISCRETISING THE PROBLEM Finite-difference approximations

More information

Model-independent bounds for Asian options

Model-independent bounds for Asian options Model-independent bounds for Asian options A dynamic programming approach Alexander M. G. Cox 1 Sigrid Källblad 2 1 University of Bath 2 CMAP, École Polytechnique University of Michigan, 2nd December,

More information

Dynamic Portfolio Execution Detailed Proofs

Dynamic Portfolio Execution Detailed Proofs Dynamic Portfolio Execution Detailed Proofs Gerry Tsoukalas, Jiang Wang, Kay Giesecke March 16, 2014 1 Proofs Lemma 1 (Temporary Price Impact) A buy order of size x being executed against i s ask-side

More information

Computational Finance Finite Difference Methods

Computational Finance Finite Difference Methods Explicit finite difference method Computational Finance Finite Difference Methods School of Mathematics 2018 Today s Lecture We now introduce the final numerical scheme which is related to the PDE solution.

More information

Numerical Methods in Option Pricing (Part III)

Numerical Methods in Option Pricing (Part III) Numerical Methods in Option Pricing (Part III) E. Explicit Finite Differences. Use of the Forward, Central, and Symmetric Central a. In order to obtain an explicit solution for the price of the derivative,

More information

IEOR E4703: Monte-Carlo Simulation

IEOR E4703: Monte-Carlo Simulation IEOR E4703: Monte-Carlo Simulation Other Miscellaneous Topics and Applications of Monte-Carlo Martin Haugh Department of Industrial Engineering and Operations Research Columbia University Email: martin.b.haugh@gmail.com

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

Lecture 4. Finite difference and finite element methods

Lecture 4. Finite difference and finite element methods Finite difference and finite element methods Lecture 4 Outline Black-Scholes equation From expectation to PDE Goal: compute the value of European option with payoff g which is the conditional expectation

More information

ERROR ESTIMATES FOR LINEAR-QUADRATIC ELLIPTIC CONTROL PROBLEMS

ERROR ESTIMATES FOR LINEAR-QUADRATIC ELLIPTIC CONTROL PROBLEMS ERROR ESTIMATES FOR LINEAR-QUADRATIC ELLIPTIC CONTROL PROBLEMS Eduardo Casas Departamento de Matemática Aplicada y Ciencias de la Computación Universidad de Cantabria 39005 Santander, Spain. eduardo.casas@unican.es

More information

Toward A Term Structure of Macroeconomic Risk

Toward A Term Structure of Macroeconomic Risk Toward A Term Structure of Macroeconomic Risk Pricing Unexpected Growth Fluctuations Lars Peter Hansen 1 2007 Nemmers Lecture, Northwestern University 1 Based in part joint work with John Heaton, Nan Li,

More information

Statistical and Computational Inverse Problems with Applications Part 5B: Electrical impedance tomography

Statistical and Computational Inverse Problems with Applications Part 5B: Electrical impedance tomography Statistical and Computational Inverse Problems with Applications Part 5B: Electrical impedance tomography Aku Seppänen Inverse Problems Group Department of Applied Physics University of Eastern Finland

More information

Parameterized Expectations

Parameterized Expectations Parameterized Expectations A Brief Introduction Craig Burnside Duke University November 2006 Craig Burnside (Duke University) Parameterized Expectations November 2006 1 / 10 Parameterized Expectations

More information

Solving the Stochastic Steady-State Diffusion Problem Using Multigrid

Solving the Stochastic Steady-State Diffusion Problem Using Multigrid 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

More information

Part 1: q Theory and Irreversible Investment

Part 1: q Theory and Irreversible Investment Part 1: q Theory and Irreversible Investment Goal: Endogenize firm characteristics and risk. Value/growth Size Leverage New issues,... This lecture: q theory of investment Irreversible investment and real

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

"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

Accelerated Stochastic Gradient Descent Praneeth Netrapalli MSR India

Accelerated Stochastic Gradient Descent Praneeth Netrapalli MSR India Accelerated Stochastic Gradient Descent Praneeth Netrapalli MSR India Presented at OSL workshop, Les Houches, France. Joint work with Prateek Jain, Sham M. Kakade, Rahul Kidambi and Aaron Sidford Linear

More information

An overview of some financial models using BSDE with enlarged filtrations

An overview of some financial models using BSDE with enlarged filtrations An overview of some financial models using BSDE with enlarged filtrations Anne EYRAUD-LOISEL Workshop : Enlargement of Filtrations and Applications to Finance and Insurance May 31st - June 4th, 2010, Jena

More information

Analysis of pricing American options on the maximum (minimum) of two risk assets

Analysis of pricing American options on the maximum (minimum) of two risk assets Interfaces Free Boundaries 4, (00) 7 46 Analysis of pricing American options on the maximum (minimum) of two risk assets LISHANG JIANG Institute of Mathematics, Tongji University, People s Republic of

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

Stability in geometric & functional inequalities

Stability in geometric & functional inequalities Stability in geometric & functional inequalities A. Figalli The University of Texas at Austin www.ma.utexas.edu/users/figalli/ Alessio Figalli (UT Austin) Stability in geom. & funct. ineq. Krakow, July

More information

GLOBAL CONVERGENCE OF GENERAL DERIVATIVE-FREE TRUST-REGION ALGORITHMS TO FIRST AND SECOND ORDER CRITICAL POINTS

GLOBAL CONVERGENCE OF GENERAL DERIVATIVE-FREE TRUST-REGION ALGORITHMS TO FIRST AND SECOND ORDER CRITICAL POINTS GLOBAL CONVERGENCE OF GENERAL DERIVATIVE-FREE TRUST-REGION ALGORITHMS TO FIRST AND SECOND ORDER CRITICAL POINTS ANDREW R. CONN, KATYA SCHEINBERG, AND LUíS N. VICENTE Abstract. In this paper we prove global

More information

Multi-period mean variance asset allocation: Is it bad to win the lottery?

Multi-period mean variance asset allocation: Is it bad to win the lottery? Multi-period mean variance asset allocation: Is it bad to win the lottery? Peter Forsyth 1 D.M. Dang 1 1 Cheriton School of Computer Science University of Waterloo Guangzhou, July 28, 2014 1 / 29 The Basic

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

1 Explicit Euler Scheme (or Euler Forward Scheme )

1 Explicit Euler Scheme (or Euler Forward Scheme ) Numerical methods for PDE in Finance - M2MO - Paris Diderot American options January 2018 Files: https://ljll.math.upmc.fr/bokanowski/enseignement/2017/m2mo/m2mo.html We look for a numerical approximation

More information

Saddlepoint Approximation Methods for Pricing. Financial Options on Discrete Realized Variance

Saddlepoint Approximation Methods for Pricing. Financial Options on Discrete Realized Variance Saddlepoint Approximation Methods for Pricing Financial Options on Discrete Realized Variance Yue Kuen KWOK Department of Mathematics Hong Kong University of Science and Technology Hong Kong * This is

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

On the Superlinear Local Convergence of a Filter-SQP Method. Stefan Ulbrich Zentrum Mathematik Technische Universität München München, Germany

On the Superlinear Local Convergence of a Filter-SQP Method. Stefan Ulbrich Zentrum Mathematik Technische Universität München München, Germany On the Superlinear Local Convergence of a Filter-SQP Method Stefan Ulbrich Zentrum Mathemati Technische Universität München München, Germany Technical Report, October 2002. Mathematical Programming manuscript

More information

Interest-rate pegs and central bank asset purchases: Perfect foresight and the reversal puzzle

Interest-rate pegs and central bank asset purchases: Perfect foresight and the reversal puzzle Interest-rate pegs and central bank asset purchases: Perfect foresight and the reversal puzzle Rafael Gerke Sebastian Giesen Daniel Kienzler Jörn Tenhofen Deutsche Bundesbank Swiss National Bank The views

More information

Rohini Kumar. Statistics and Applied Probability, UCSB (Joint work with J. Feng and J.-P. Fouque)

Rohini Kumar. Statistics and Applied Probability, UCSB (Joint work with J. Feng and J.-P. Fouque) Small time asymptotics for fast mean-reverting stochastic volatility models Statistics and Applied Probability, UCSB (Joint work with J. Feng and J.-P. Fouque) March 11, 2011 Frontier Probability Days,

More information

Sample Path Large Deviations and Optimal Importance Sampling for Stochastic Volatility Models

Sample Path Large Deviations and Optimal Importance Sampling for Stochastic Volatility Models Sample Path Large Deviations and Optimal Importance Sampling for Stochastic Volatility Models Scott Robertson Carnegie Mellon University scottrob@andrew.cmu.edu http://www.math.cmu.edu/users/scottrob June

More information

A Fuzzy Pay-Off Method for Real Option Valuation

A Fuzzy Pay-Off Method for Real Option Valuation A Fuzzy Pay-Off Method for Real Option Valuation April 2, 2009 1 Introduction Real options Black-Scholes formula 2 Fuzzy Sets and Fuzzy Numbers 3 The method Datar-Mathews method Calculating the ROV with

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

The coupling of electrical eddy current heat production and air cooling

The coupling of electrical eddy current heat production and air cooling Söllerhaus 2004 Institute of Applied Analysis and Numerical Simulation The coupling of electrical eddy current heat production and air cooling Institut of Applied Analysis and Numerical Simulation D-70569

More information

A Confluent Hypergeometric System Associated with Ф 3 and a Confluent Jordan-Pochhammer Equation. Shun Shimomura

A Confluent Hypergeometric System Associated with Ф 3 and a Confluent Jordan-Pochhammer Equation. Shun Shimomura Research Report KSTS/RR-98/002 Mar. 11, 1998 A Confluent Hypergeometric System Associated with Ф 3 and a Confluent Jordan-Pochhammer Equation by Department of Mathematics Keio University Department of

More information

RECURSIVE VALUATION AND SENTIMENTS

RECURSIVE VALUATION AND SENTIMENTS 1 / 32 RECURSIVE VALUATION AND SENTIMENTS Lars Peter Hansen Bendheim Lectures, Princeton University 2 / 32 RECURSIVE VALUATION AND SENTIMENTS ABSTRACT Expectations and uncertainty about growth rates that

More information

As an example, we consider the following PDE with one variable; Finite difference method is one of numerical method for the PDE.

As an example, we consider the following PDE with one variable; Finite difference method is one of numerical method for the PDE. 7. Introduction to the numerical integration of PDE. As an example, we consider the following PDE with one variable; Finite difference method is one of numerical method for the PDE. Accuracy requirements

More information

Testing for non-correlation between price and volatility jumps and ramifications

Testing for non-correlation between price and volatility jumps and ramifications Testing for non-correlation between price and volatility jumps and ramifications Claudia Klüppelberg Technische Universität München cklu@ma.tum.de www-m4.ma.tum.de Joint work with Jean Jacod, Gernot Müller,

More information

Portfolio selection with multiple risk measures

Portfolio selection with multiple risk measures Portfolio selection with multiple risk measures Garud Iyengar Columbia University Industrial Engineering and Operations Research Joint work with Carlos Abad Outline Portfolio selection and risk measures

More information

Numerical Solution of Two Asset Jump Diffusion Models for Option Valuation

Numerical Solution of Two Asset Jump Diffusion Models for Option Valuation Numerical Solution of Two Asset Jump Diffusion Models for Option Valuation Simon S. Clift and Peter A. Forsyth Original: December 5, 2005 Revised: January 31, 2007 Abstract Under the assumption that two

More information

Estimating Macroeconomic Models of Financial Crises: An Endogenous Regime-Switching Approach

Estimating Macroeconomic Models of Financial Crises: An Endogenous Regime-Switching Approach Estimating Macroeconomic Models of Financial Crises: An Endogenous Regime-Switching Approach Gianluca Benigno 1 Andrew Foerster 2 Christopher Otrok 3 Alessandro Rebucci 4 1 London School of Economics and

More information

Macroeconomics and finance

Macroeconomics and finance Macroeconomics and finance 1 1. Temporary equilibrium and the price level [Lectures 11 and 12] 2. Overlapping generations and learning [Lectures 13 and 14] 2.1 The overlapping generations model 2.2 Expectations

More information

13.3 A Stochastic Production Planning Model

13.3 A Stochastic Production Planning Model 13.3. A Stochastic Production Planning Model 347 From (13.9), we can formally write (dx t ) = f (dt) + G (dz t ) + fgdz t dt, (13.3) dx t dt = f(dt) + Gdz t dt. (13.33) The exact meaning of these expressions

More information

Weak Reflection Principle and Static Hedging of Barrier Options

Weak Reflection Principle and Static Hedging of Barrier Options Weak Reflection Principle and Static Hedging of Barrier Options Sergey Nadtochiy Department of Mathematics University of Michigan Apr 2013 Fields Quantitative Finance Seminar Fields Institute, Toronto

More information

Volatility Smiles and Yield Frowns

Volatility Smiles and Yield Frowns Volatility Smiles and Yield Frowns Peter Carr NYU CBOE Conference on Derivatives and Volatility, Chicago, Nov. 10, 2017 Peter Carr (NYU) Volatility Smiles and Yield Frowns 11/10/2017 1 / 33 Interest Rates

More information

Financial Computing with Python

Financial Computing with Python Introduction to Financial Computing with Python Matthieu Mariapragassam Why coding seems so easy? But is actually not Sprezzatura : «It s an art that doesn t seem to be an art» - The Book of the Courtier

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

European option pricing under parameter uncertainty

European option pricing under parameter uncertainty European option pricing under parameter uncertainty Martin Jönsson (joint work with Samuel Cohen) University of Oxford Workshop on BSDEs, SPDEs and their Applications July 4, 2017 Introduction 2/29 Introduction

More information

Arborescent Architecture for Decentralized Supervisory Control of Discrete Event Systems

Arborescent Architecture for Decentralized Supervisory Control of Discrete Event Systems Arborescent Architecture for Decentralized Supervisory Control of Discrete Event Systems Ahmed Khoumsi and Hicham Chakib Dept. Electrical & Computer Engineering, University of Sherbrooke, Canada Email:

More information

SLE and CFT. Mitsuhiro QFT2005

SLE and CFT. Mitsuhiro QFT2005 SLE and CFT Mitsuhiro Kato @ QFT2005 1. Introduction Critical phenomena Conformal Field Theory (CFT) Algebraic approach, field theory, BPZ(1984) Stochastic Loewner Evolution (SLE) Geometrical approach,

More information

Robust Portfolio Choice and Indifference Valuation

Robust Portfolio Choice and Indifference Valuation and Indifference Valuation Mitja Stadje Dep. of Econometrics & Operations Research Tilburg University joint work with Roger Laeven July, 2012 http://alexandria.tue.nl/repository/books/733411.pdf Setting

More information

Lecture 4. Extensions to the Open Economy. and. Emerging Market Crises

Lecture 4. Extensions to the Open Economy. and. Emerging Market Crises Lecture 4 Extensions to the Open Economy and Emerging Market Crises Mark Gertler NYU June 2009 0 Objectives Develop micro-founded open-economy quantitative macro model with real/financial interactions

More information

Non-semimartingales in finance

Non-semimartingales in finance Non-semimartingales in finance Pricing and Hedging Options with Quadratic Variation Tommi Sottinen University of Vaasa 1st Northern Triangular Seminar 9-11 March 2009, Helsinki University of Technology

More information

On a Manufacturing Capacity Problem in High-Tech Industry

On a Manufacturing Capacity Problem in High-Tech Industry Applied Mathematical Sciences, Vol. 11, 217, no. 2, 975-983 HIKARI Ltd, www.m-hikari.com https://doi.org/1.12988/ams.217.7275 On a Manufacturing Capacity Problem in High-Tech Industry Luca Grosset and

More information

Balance Sheet Recessions

Balance Sheet Recessions Balance Sheet Recessions Zhen Huo and José-Víctor Ríos-Rull University of Minnesota Federal Reserve Bank of Minneapolis CAERP CEPR NBER Conference on Money Credit and Financial Frictions Huo & Ríos-Rull

More information

Optimal energy management and stochastic decomposition

Optimal energy management and stochastic decomposition Optimal energy management and stochastic decomposition F. Pacaud P. Carpentier J.P. Chancelier M. De Lara JuMP-dev workshop, 2018 ENPC ParisTech ENSTA ParisTech Efficacity 1/23 Motivation We consider a

More information

Methods and Models of Loss Reserving Based on Run Off Triangles: A Unifying Survey

Methods and Models of Loss Reserving Based on Run Off Triangles: A Unifying Survey Methods and Models of Loss Reserving Based on Run Off Triangles: A Unifying Survey By Klaus D Schmidt Lehrstuhl für Versicherungsmathematik Technische Universität Dresden Abstract The present paper provides

More information

Energy norm estimates for eigenvector approximations

Energy norm estimates for eigenvector approximations for eigenvector approximations Z. Drmač L. 2 V. Kostrykin 3 K. Veselić 4 Department of Mathematics, University of Zagreb 2 Institut fuer Reine und Angewandte Mathematik, RWTH Aachen 3 Fraunhofer Institut

More information

On Existence of Equilibria. Bayesian Allocation-Mechanisms

On Existence of Equilibria. Bayesian Allocation-Mechanisms On Existence of Equilibria in Bayesian Allocation Mechanisms Northwestern University April 23, 2014 Bayesian Allocation Mechanisms In allocation mechanisms, agents choose messages. The messages determine

More information

Term Structure Lattice Models

Term Structure Lattice Models IEOR E4706: Foundations of Financial Engineering c 2016 by Martin Haugh Term Structure Lattice Models These lecture notes introduce fixed income derivative securities and the modeling philosophy used to

More information

1 Explicit Euler Scheme (or Euler Forward Scheme )

1 Explicit Euler Scheme (or Euler Forward Scheme ) Numerical methods for PDE in Finance - M2MO - Paris Diderot American options January 2017 Files: https://ljll.math.upmc.fr/bokanowski/enseignement/2016/m2mo/m2mo.html We look for a numerical approximation

More information

Robust Longevity Risk Management

Robust Longevity Risk Management Robust Longevity Risk Management Hong Li a,, Anja De Waegenaere a,b, Bertrand Melenberg a,b a Department of Econometrics and Operations Research, Tilburg University b Netspar Longevity 10 3-4, September,

More information

Multilevel Monte Carlo Simulation

Multilevel Monte Carlo Simulation Multilevel Monte Carlo p. 1/48 Multilevel Monte Carlo Simulation Mike Giles mike.giles@maths.ox.ac.uk Oxford University Mathematical Institute Oxford-Man Institute of Quantitative Finance Workshop on Computational

More information

STATE UNIVERSITY OF NEW YORK AT ALBANY Department of Economics. Ph. D. Comprehensive Examination: Macroeconomics Fall, 2010

STATE UNIVERSITY OF NEW YORK AT ALBANY Department of Economics. Ph. D. Comprehensive Examination: Macroeconomics Fall, 2010 STATE UNIVERSITY OF NEW YORK AT ALBANY Department of Economics Ph. D. Comprehensive Examination: Macroeconomics Fall, 2010 Section 1. (Suggested Time: 45 Minutes) For 3 of the following 6 statements, state

More information

Reserve Accumulation, Macroeconomic Stabilization and Sovereign Risk

Reserve Accumulation, Macroeconomic Stabilization and Sovereign Risk Reserve Accumulation, Macroeconomic Stabilization and Sovereign Risk Javier Bianchi 1 César Sosa-Padilla 2 2018 SED Annual Meeting 1 Minneapolis Fed & NBER 2 University of Notre Dame Motivation EMEs with

More information

Uncertainty, Liquidity and Financial Cycles

Uncertainty, Liquidity and Financial Cycles Uncertainty, Liquidity and Financial Cycles Ge Zhou Zhejiang University Jan 2019, ASSA Ge Zhou (Zhejiang University) Uncertainty, Liquidity and Financial Cycles Jan 2019 1 / 26 2500.00 Recession SP 500

More information