Meshfree Exponential Integrators

Size: px
Start display at page:

Download "Meshfree Exponential Integrators"

Transcription

1 Meshfree joint work with A. Ostermann (Innsbruck) M. Caliari (Verona) Leopold Franzens Universität Innsbruck Innovative Integrators 3 October 2 Meshfree

2 Problem class: Goal: Time-dependent PDE s with dominating advection part Solution has a small essential support High dimensional problems Develop an integrator with high accuracy both in space and time Use the special form of the solution to save memory Meshfree

3 Example: Consider the Molenkamp Crowley equation t u = x (au) + y (bu) with The initial profile, a(x, y) = 2πy, b(x, y) = 2πx. u (x, y) = exp( (x.2) 2 (y.2) 2 ), rotates around the origin. Meshfree

4 Meshfree

5 Given a stiff initial-value problem u (t) = F (u(t)), u() = u. Linearising the problem at a state w gives v (t) = Av(t) + g (v(t)), v() = u w with A = DF (w), v(t) = u(t) w and g a nonlinear reminder. Using the variation-of-constant formula the solution has the form v(t) = e t A v + t e (t τ)a g (v(τ))dτ Meshfree

6 Given a stiff initial-value problem u (t) = F (u(t)), u() = u. Linearising the problem at a state w gives v (t) = Av(t) + g (v(t)), v() = u w with A = DF (w), v(t) = u(t) w and g a nonlinear reminder. Using the variation-of-constant formula the solution has the form v(t) = e t A v + t e (t τ)a g (v(τ))dτ Meshfree

7 Example: Exponential Euler Method g (v(τ)) g (v ) gives v = e h A v + hϕ (h A)g (v ). Here h denotes the step size and ϕ is the entire function ϕ (z) = ez z. Exponential and related functions will be approximated with the Leja point method (based on Newton s interpolation formula at a Leja sequence). Meshfree

8 The Leja point method needs a rough approximation of largest eigenvalues of the Operator. This can be done by splitting the operator in a symmetric and skew-symmetric part and computing the largest in magnitude eigenvalues of both parts. We get estimate of the spectrum in form of a rectangle with vertices ( a, ib),(, ib),(,ib),( a,ib), a,b. Distinguish two cases: a b, take Leja points on interval [ a,]. a < b, consider conjugate pairs of Leja points on domain {z C: R(z) = a/2,i(z) [ b,b]} Meshfree

9 Some properties: similar distribution as Chebyshev points defined recursively - combines well with Newton interpolation based on matrix-vector multiplications superlinear convergence real arithmetic Meshfree

10 Basis function: Radial Basis Functions Meshfree

11 Given a function f : R d R sampled at point set X = {x,..., x m } Approximate f by the interpolant s(ξ) = λ x φ( ξ x ) x X using a radial function φ : R + R. The coefficients λ = (λ x ) x X are chose such that with A = {φ ( x i x j ) } xi,x j X. s X = f X = Aλ = f X Meshfree

12 RBF interpolation: works in any dimension simple to implement high accuracy Meshfree

13 Compactly supported RBFs Meshfree

14 We use Wendland functions. Defined via φ d,k = I k φ d/2 +k+, φ l (r ) = ( r ) l + where (I φ)(r ) = r tφ(t)dt and d is the space dimension. d φ d,k (r ) smoothness φ, (r ) = ( r ) + C φ, (r ) = ( r ) 3 + (3r + ) 2 C 3 φ 3, (r ) = ( r ) 2 + C φ 3, (r ) = ( r ) 4 + (4r + ) 2 C φ 3,2 (r ) = ( r ) 6 + (35r 2 + 8r + 3) C 4 φ 3,3 (r ) = ( r ) 8 + (32r r 2 + 8r + ) C 6 Meshfree

15 Some properties of φ d,k (r ) smoothness 2k strictly positive definite on R d local interpolation error bounded by f (y) s(y) c f Ch k+/2 ρ, h ρ < h for h small enough, where h ρ (y) := max y Bρ (ξ) min x X ξ x 2 for a given ρ >. condition number of interpolation matrix A bounded by cond 2 (A) C q d 2k x, { } where q X = /2min xi,x j X xi x j 2 x i x j. Meshfree

16 Consider a linear differential equation discretized at X u t (t, ) X = Lu(t, ) X, u(, ) X = u X. Approximate Lu(t,ξ) by Ls(t,ξ) = L λ x (t)φ( ξ x ) = λ x (t)lφ( ξ x ). x X x X This gives s t (t, ) X = A L λ with A L = {Lφ ( x i x j ) } xi,x j X and λ = A u(, t) X. Meshfree

17 Consider a linear differential equation discretized at X s t (t, ) X = Ls(t, ) X, s(,) X = u X. Approximate Lu(t,ξ) by Ls(t,ξ) = L λ x (t)φ( ξ x ) = λ x (t)lφ( ξ x ). x X x X This gives s t (t, ) X = A L A s(t, ) X, with A L = {Lφ ( x i x j ) } xi,x j X. Meshfree

18 Standard forward difference approximation in time leads to a simple integrator s(t n+, ) X = s(t n, ) X + t A L A s(t n, ) X. Meshfree

19 For the error estimate in space use two set of points: interpolation points check points Every interpolation point has some checkpoints. Suppose f is known everywhere. Idea: interpolate at interpolation points evaluate at check points calculate error at check points to get error estimate in space Refinement If error at a check point is too large, check point becomes interpolation point. Coarsening If error at all check points corresponding to a interpolation point are small enough, interpolation point will be removed. Meshfree

20 Meshfree

21 Meshfree

22 Meshfree

23 Meshfree

24 Meshfree

25 Meshfree

26 Meshfree

27 Meshfree

28 Meshfree

29 Meshfree

30 Meshfree

31 check points For a given set of interpolation points calculate a Delaunay triangulation Take circumcenters of resulting triangles as check points. Two reasons Check points maximize the local error bound If a refinement is needed, adding such a check point minimizes the growth or condition number of interpolation matrix. Meshfree

32 Example: Consider the Molenkamp Crowley equation t u = x (au) + y (bu) with a(x, y) = 2πy, b(x, y) = 2πx and u (x, y) = exp( (x.2) 2 (y.2) 2 ). Meshfree

33 The initial profile rotates around the origin. Tolerances: Space: 3 ; Time: 3 ; constant time step size: 5 2 Compute 4 turns of the pulse (8 steps) Meshfree

34 2 exact numeric Meshfree

35 Two numerical experiments: achieved accuracy (for prescribed tolerances) long time computation Step size for time evolution: 2. Meshfree

36 Error at T = error tolerance Meshfree

37 Required number of basis functions 4 number of points tolerance Meshfree

38 Long time computation ( turns), tolerance = 5 2 t= x 6 2 t= 5 x 3 2 t=3 2 x t=5 x 3 2 t=8 x 3 2 t= Meshfree

39 Global error 2 error turns Meshfree

40 Number of basis functions number of points time Meshfree

41 Example2: Consider the semilinear advection-diffusion-reaction problem ( ) t u = /2 xx u + y y u + 6 ( x u + y u ) + 7u (u /2)( u) Integrated with exponential Rosenbrock 3(2) up to T =.. Meshfree

42 Meshfree

43 Global error at T =. error anticipated err. global err. tolerance tolerance Meshfree

44 Number of time steps and number of interpolation points 4 number of points number of steps tolerance Meshfree

45 Development of interpolation point set Integrate advection-diffusion-reaction problem up to T =.3, with tolerance 5 4 Meshfree

46 Meshfree

47 Development of interpolation point set 2 t= 2 t=.64 2 t= t=.34 2 t=.97 2 t= Meshfree

48 4 35 number of points time Meshfree

49 Outlook efficient implementation error analysis solve real life problems Meshfree

Comparison of various methods for computing the action of the matrix exponential

Comparison of various methods for computing the action of the matrix exponential BIT manuscript No. (will be inserted by the editor) Comparison of various methods for computing the action of the matrix exponential Marco Caliari Peter Kandolf Alexander Ostermann Stefan Rainer Received:

More information

Splitting methods with boundary corrections

Splitting methods with boundary corrections Splitting methods with boundary corrections Alexander Ostermann University of Innsbruck, Austria Joint work with Lukas Einkemmer Verona, April/May 2017 Strang s paper, SIAM J. Numer. Anal., 1968 S (5)

More information

Linear algebra for exponential integrators

Linear algebra for exponential integrators Linear algebra for exponential integrators Antti Koskela KTH Royal Institute of Technology Beräkningsmatematikcirkus, 28 May 2014 The problem Considered: time integration of stiff semilinear initial value

More information

Exponential multistep methods of Adams-type

Exponential multistep methods of Adams-type Exponential multistep methods of Adams-type Marlis Hochbruck and Alexander Ostermann KARLSRUHE INSTITUTE OF TECHNOLOGY (KIT) 0 KIT University of the State of Baden-Wuerttemberg and National Laboratory

More information

Implementation of exponential Rosenbrock-type integrators

Implementation of exponential Rosenbrock-type integrators Implementation of exponential Rosenbrock-type integrators Marco Caliari a,b, Alexander Ostermann b, a Department of Pure and Applied Mathematics, University of Padua, Via Trieste 63, I-35121 Padova, Italy

More information

Approximating the matrix exponential of an advection-diffusion operator using the incomplete orthogonalization method

Approximating the matrix exponential of an advection-diffusion operator using the incomplete orthogonalization method Approximating the matrix exponential of an advection-diffusion operator using the incomplete orthogonalization method Antti Koskela KTH Royal Institute of Technology, Lindstedtvägen 25, 10044 Stockholm,

More information

Exponential integration of large systems of ODEs

Exponential integration of large systems of ODEs Exponential integration of large systems of ODEs Jitse Niesen (University of Leeds) in collaboration with Will Wright (Melbourne University) 23rd Biennial Conference on Numerical Analysis, June 2009 Plan

More information

Exponential integrators for semilinear parabolic problems

Exponential integrators for semilinear parabolic problems Exponential integrators for semilinear parabolic problems Marlis Hochbruck Heinrich-Heine University Düsseldorf Germany Innsbruck, October 2004 p. Outline Exponential integrators general class of methods

More information

The Leja method revisited: backward error analysis for the matrix exponential

The Leja method revisited: backward error analysis for the matrix exponential The Leja method revisited: backward error analysis for the matrix exponential M. Caliari 1, P. Kandolf 2, A. Ostermann 2, and S. Rainer 2 1 Dipartimento di Informatica, Università di Verona, Italy 2 Institut

More information

Integration of Vlasov-type equations

Integration of Vlasov-type equations Alexander Ostermann University of Innsbruck, Austria Joint work with Lukas Einkemmer Verona, April/May 2017 Plasma the fourth state of matter 99% of the visible matter in the universe is made of plasma

More information

The Leja method revisited: backward error analysis for the matrix exponential

The Leja method revisited: backward error analysis for the matrix exponential The Leja method revisited: backward error analysis for the matrix exponential M. Caliari 1, P. Kandolf 2, A. Ostermann 2, and S. Rainer 2 1 Dipartimento di Informatica, Università di Verona, Italy 2 Institut

More information

Chapter Two: Numerical Methods for Elliptic PDEs. 1 Finite Difference Methods for Elliptic PDEs

Chapter Two: Numerical Methods for Elliptic PDEs. 1 Finite Difference Methods for Elliptic PDEs Chapter Two: Numerical Methods for Elliptic PDEs Finite Difference Methods for Elliptic PDEs.. Finite difference scheme. We consider a simple example u := subject to Dirichlet boundary conditions ( ) u

More information

The LEM exponential integrator for advection-diffusion-reaction equations

The LEM exponential integrator for advection-diffusion-reaction equations The LEM exponential integrator for advection-diffusion-reaction equations Marco Caliari a, Marco Vianello a,, Luca Bergamaschi b a Dept. of Pure and Applied Mathematics, University of Padova. b Dept. of

More information

MATH 590: Meshfree Methods

MATH 590: Meshfree Methods MATH 590: Meshfree Methods Chapter 43: RBF-PS Methods in MATLAB Greg Fasshauer Department of Applied Mathematics Illinois Institute of Technology Fall 2010 fasshauer@iit.edu MATH 590 Chapter 43 1 Outline

More information

Partial Differential Equations

Partial Differential Equations M3M3 Partial Differential Equations Solutions to problem sheet 3/4 1* (i) Show that the second order linear differential operators L and M, defined in some domain Ω R n, and given by Mφ = Lφ = j=1 j=1

More information

A review of stability and dynamical behaviors of differential equations:

A review of stability and dynamical behaviors of differential equations: A review of stability and dynamical behaviors of differential equations: scalar ODE: u t = f(u), system of ODEs: u t = f(u, v), v t = g(u, v), reaction-diffusion equation: u t = D u + f(u), x Ω, with boundary

More information

Application of modified Leja sequences to polynomial interpolation

Application of modified Leja sequences to polynomial interpolation Special Issue for the years of the Padua points, Volume 8 5 Pages 66 74 Application of modified Leja sequences to polynomial interpolation L. P. Bos a M. Caliari a Abstract We discuss several applications

More information

Comparing Leja and Krylov approximations of large scale matrix exponentials

Comparing Leja and Krylov approximations of large scale matrix exponentials Comparing Leja and Krylov approximations of large scale matrix exponentials L. Bergamaschi 1, M. Caliari 2, A. Martínez 2, and M. Vianello 2 1 Dept. of Math. Methods and Models, University of Padova, berga@dmsa.unipd.it

More information

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

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

More information

Lecture Notes on PDEs

Lecture Notes on PDEs Lecture Notes on PDEs Alberto Bressan February 26, 2012 1 Elliptic equations Let IR n be a bounded open set Given measurable functions a ij, b i, c : IR, consider the linear, second order differential

More information

Cache Oblivious Stencil Computations

Cache Oblivious Stencil Computations Cache Oblivious Stencil Computations S. HUNOLD J. L. TRÄFF F. VERSACI Lectures on High Performance Computing 13 April 2015 F. Versaci (TU Wien) Cache Oblivious Stencil Computations 13 April 2015 1 / 19

More information

Krylov methods for the computation of matrix functions

Krylov methods for the computation of matrix functions Krylov methods for the computation of matrix functions Jitse Niesen (University of Leeds) in collaboration with Will Wright (Melbourne University) Heriot-Watt University, March 2010 Outline Definition

More information

Accurate evaluation of divided differences for polynomial interpolation of exponential propagators

Accurate evaluation of divided differences for polynomial interpolation of exponential propagators Computing 80, 189 201 (2007) DOI 10.1007/s00607-007-0227-1 Printed in The Netherlands Accurate evaluation of divided differences for polynomial interpolation of exponential propagators M. Caliari, Padua

More information

Radial Basis Function generated Finite Difference Methods for Pricing of Financial Derivatives

Radial Basis Function generated Finite Difference Methods for Pricing of Financial Derivatives Digital Comprehensive Summaries of Uppsala Dissertations from the Faculty of Science and Technology 1702 Radial Basis Function generated Finite Difference Methods for Pricing of Financial Derivatives SLOBODAN

More information

The ReLPM Exponential Integrator for FE Discretizations of Advection-Diffusion Equations

The ReLPM Exponential Integrator for FE Discretizations of Advection-Diffusion Equations The ReLPM Exponential Integrator for FE Discretizations of Advection-Diffusion Equations Luca Bergamaschi 1, Marco Caliari 2, and Marco Vianello 3 1 Dip.to di Met. e Mod. Mat. per le Scienze Appl., Università

More information

Radial basis function partition of unity methods for PDEs

Radial basis function partition of unity methods for PDEs Radial basis function partition of unity methods for PDEs Elisabeth Larsson, Scientific Computing, Uppsala University Credit goes to a number of collaborators Alfa Ali Alison Lina Victor Igor Heryudono

More information

Chapter 1: The Finite Element Method

Chapter 1: The Finite Element Method Chapter 1: The Finite Element Method Michael Hanke Read: Strang, p 428 436 A Model Problem Mathematical Models, Analysis and Simulation, Part Applications: u = fx), < x < 1 u) = u1) = D) axial deformation

More information

Exponential integrators

Exponential integrators Acta Numerica (2), pp. 29 286 c Cambridge University Press, 2 doi:.7/s962492948 Printed in the United Kingdom Exponential integrators Marlis Hochbruck Karlsruher Institut für Technologie, Institut für

More information

EXPONENTIAL ROSENBROCK-TYPE METHODS

EXPONENTIAL ROSENBROCK-TYPE METHODS EXPONENTIAL ROSENBROCK-TYPE METHODS MARLIS HOCHBRUCK, ALEXANDER OSTERMANN, AND JULIA SCHWEITZER Abstract. We introduce a new class of exponential integrators for the numerical integration of large-scale

More information

Semi-implicit Krylov Deferred Correction Methods for Ordinary Differential Equations

Semi-implicit Krylov Deferred Correction Methods for Ordinary Differential Equations Semi-implicit Krylov Deferred Correction Methods for Ordinary Differential Equations Sunyoung Bu University of North Carolina Department of Mathematics CB # 325, Chapel Hill USA agatha@email.unc.edu Jingfang

More information

Exponential Runge-Kutta methods for parabolic problems

Exponential Runge-Kutta methods for parabolic problems Exponential Runge-Kutta methods for parabolic problems Marlis Hochbruck a,, Alexander Ostermann b a Mathematisches Institut, Heinrich-Heine Universität Düsseldorf, Universitätsstraße 1, D-4225 Düsseldorf,

More information

Numerical solution of surface PDEs with Radial Basis Functions

Numerical solution of surface PDEs with Radial Basis Functions Numerical solution of surface PDEs with Radial Basis Functions Andriy Sokolov Institut für Angewandte Mathematik (LS3) TU Dortmund andriy.sokolov@math.tu-dortmund.de TU Dortmund June 1, 2017 Outline 1

More information

x n+1 = x n f(x n) f (x n ), n 0.

x n+1 = x n f(x n) f (x n ), n 0. 1. Nonlinear Equations Given scalar equation, f(x) = 0, (a) Describe I) Newtons Method, II) Secant Method for approximating the solution. (b) State sufficient conditions for Newton and Secant to converge.

More information

Introduction. Finite and Spectral Element Methods Using MATLAB. Second Edition. C. Pozrikidis. University of Massachusetts Amherst, USA

Introduction. Finite and Spectral Element Methods Using MATLAB. Second Edition. C. Pozrikidis. University of Massachusetts Amherst, USA Introduction to Finite and Spectral Element Methods Using MATLAB Second Edition C. Pozrikidis University of Massachusetts Amherst, USA (g) CRC Press Taylor & Francis Group Boca Raton London New York CRC

More information

Past, present and space-time

Past, present and space-time Past, present and space-time Arnold Reusken Chair for Numerical Mathematics RWTH Aachen Utrecht, 12.11.2015 Reusken (RWTH Aachen) Past, present and space-time Utrecht, 12.11.2015 1 / 20 Outline Past. Past

More information

Numerical Analysis Preliminary Exam 10 am to 1 pm, August 20, 2018

Numerical Analysis Preliminary Exam 10 am to 1 pm, August 20, 2018 Numerical Analysis Preliminary Exam 1 am to 1 pm, August 2, 218 Instructions. You have three hours to complete this exam. Submit solutions to four (and no more) of the following six problems. Please start

More information

National Taiwan University

National Taiwan University National Taiwan University Meshless Methods for Scientific Computing (Advisor: C.S. Chen, D.L. oung) Final Project Department: Mechanical Engineering Student: Kai-Nung Cheng SID: D9956 Date: Jan. 8 The

More information

Martin Luther Universität Halle Wittenberg Institut für Mathematik

Martin Luther Universität Halle Wittenberg Institut für Mathematik Martin Luther Universität Halle Wittenberg Institut für Mathematik Implicit peer methods for large stiff ODE systems St. Beck, R. Weiner, H. Podhaisky and B. A. Schmitt Report No. 07 (2010) Editors: Professors

More information

An adaptive RBF-based Semi-Lagrangian scheme for HJB equations

An adaptive RBF-based Semi-Lagrangian scheme for HJB equations An adaptive RBF-based Semi-Lagrangian scheme for HJB equations Roberto Ferretti Università degli Studi Roma Tre Dipartimento di Matematica e Fisica Numerical methods for Hamilton Jacobi equations in optimal

More information

In practice one often meets a situation where the function of interest, f(x), is only represented by a discrete set of tabulated points,

In practice one often meets a situation where the function of interest, f(x), is only represented by a discrete set of tabulated points, 1 Interpolation 11 Introduction In practice one often meets a situation where the function of interest, f(x), is only represented by a discrete set of tabulated points, {x i, y i = f(x i ) i = 1 n, obtained,

More information

arxiv: v1 [math.na] 6 Nov 2017

arxiv: v1 [math.na] 6 Nov 2017 Efficient boundary corrected Strang splitting Lukas Einkemmer Martina Moccaldi Alexander Ostermann arxiv:1711.02193v1 [math.na] 6 Nov 2017 Version of November 6, 2017 Abstract Strang splitting is a well

More information

256 Summary. D n f(x j ) = f j+n f j n 2n x. j n=1. α m n = 2( 1) n (m!) 2 (m n)!(m + n)!. PPW = 2π k x 2 N + 1. i=0?d i,j. N/2} N + 1-dim.

256 Summary. D n f(x j ) = f j+n f j n 2n x. j n=1. α m n = 2( 1) n (m!) 2 (m n)!(m + n)!. PPW = 2π k x 2 N + 1. i=0?d i,j. N/2} N + 1-dim. 56 Summary High order FD Finite-order finite differences: Points per Wavelength: Number of passes: D n f(x j ) = f j+n f j n n x df xj = m α m dx n D n f j j n= α m n = ( ) n (m!) (m n)!(m + n)!. PPW =

More information

Adaptive Collocation with Kernel Density Estimation

Adaptive Collocation with Kernel Density Estimation Examples of with Kernel Density Estimation Howard C. Elman Department of Computer Science University of Maryland at College Park Christopher W. Miller Applied Mathematics and Scientific Computing Program

More information

Contents. Preface to the Third Edition (2007) Preface to the Second Edition (1992) Preface to the First Edition (1985) License and Legal Information

Contents. Preface to the Third Edition (2007) Preface to the Second Edition (1992) Preface to the First Edition (1985) License and Legal Information Contents Preface to the Third Edition (2007) Preface to the Second Edition (1992) Preface to the First Edition (1985) License and Legal Information xi xiv xvii xix 1 Preliminaries 1 1.0 Introduction.............................

More information

Positive Definite Kernels: Opportunities and Challenges

Positive Definite Kernels: Opportunities and Challenges Positive Definite Kernels: Opportunities and Challenges Michael McCourt Department of Mathematical and Statistical Sciences University of Colorado, Denver CUNY Mathematics Seminar CUNY Graduate College

More information

2. The Schrödinger equation for one-particle problems. 5. Atoms and the periodic table of chemical elements

2. The Schrödinger equation for one-particle problems. 5. Atoms and the periodic table of chemical elements 1 Historical introduction The Schrödinger equation for one-particle problems 3 Mathematical tools for quantum chemistry 4 The postulates of quantum mechanics 5 Atoms and the periodic table of chemical

More information

A. Iske RADIAL BASIS FUNCTIONS: BASICS, ADVANCED TOPICS AND MESHFREE METHODS FOR TRANSPORT PROBLEMS

A. Iske RADIAL BASIS FUNCTIONS: BASICS, ADVANCED TOPICS AND MESHFREE METHODS FOR TRANSPORT PROBLEMS Rend. Sem. Mat. Univ. Pol. Torino Vol. 61, 3 (23) Splines and Radial Functions A. Iske RADIAL BASIS FUNCTIONS: BASICS, ADVANCED TOPICS AND MESHFREE METHODS FOR TRANSPORT PROBLEMS Abstract. This invited

More information

Math 7824 Spring 2010 Numerical solution of partial differential equations Classroom notes and homework

Math 7824 Spring 2010 Numerical solution of partial differential equations Classroom notes and homework Math 7824 Spring 2010 Numerical solution of partial differential equations Classroom notes and homework Jan Mandel University of Colorado Denver May 12, 2010 1/20/09: Sec. 1.1, 1.2. Hw 1 due 1/27: problems

More information

CS 450 Numerical Analysis. Chapter 8: Numerical Integration and Differentiation

CS 450 Numerical Analysis. Chapter 8: Numerical Integration and Differentiation Lecture slides based on the textbook Scientific Computing: An Introductory Survey by Michael T. Heath, copyright c 2018 by the Society for Industrial and Applied Mathematics. http://www.siam.org/books/cl80

More information

1. Let a(x) > 0, and assume that u and u h are the solutions of the Dirichlet problem:

1. Let a(x) > 0, and assume that u and u h are the solutions of the Dirichlet problem: Mathematics Chalmers & GU TMA37/MMG800: Partial Differential Equations, 011 08 4; kl 8.30-13.30. Telephone: Ida Säfström: 0703-088304 Calculators, formula notes and other subject related material are not

More information

Partial Differential Equations

Partial Differential Equations Partial Differential Equations Xu Chen Assistant Professor United Technologies Engineering Build, Rm. 382 Department of Mechanical Engineering University of Connecticut xchen@engr.uconn.edu Contents 1

More information

Mathématiques appliquées (MATH0504-1) B. Dewals, Ch. Geuzaine

Mathématiques appliquées (MATH0504-1) B. Dewals, Ch. Geuzaine Lecture 2 The wave equation Mathématiques appliquées (MATH0504-1) B. Dewals, Ch. Geuzaine V1.0 28/09/2018 1 Learning objectives of this lecture Understand the fundamental properties of the wave equation

More information

MOX EXPONENTIAL INTEGRATORS FOR MULTIPLE TIME SCALE PROBLEMS OF ENVIRONMENTAL FLUID DYNAMICS. Innsbruck Workshop October

MOX EXPONENTIAL INTEGRATORS FOR MULTIPLE TIME SCALE PROBLEMS OF ENVIRONMENTAL FLUID DYNAMICS. Innsbruck Workshop October Innsbruck Workshop October 29 21 EXPONENTIAL INTEGRATORS FOR MULTIPLE TIME SCALE PROBLEMS OF ENVIRONMENTAL FLUID DYNAMICS Luca Bonaventura - Modellistica e Calcolo Scientifico Dipartimento di Matematica

More information

Stability Analysis of Stationary Solutions for the Cahn Hilliard Equation

Stability Analysis of Stationary Solutions for the Cahn Hilliard Equation Stability Analysis of Stationary Solutions for the Cahn Hilliard Equation Peter Howard, Texas A&M University University of Louisville, Oct. 19, 2007 References d = 1: Commun. Math. Phys. 269 (2007) 765

More information

CS520: numerical ODEs (Ch.2)

CS520: numerical ODEs (Ch.2) .. CS520: numerical ODEs (Ch.2) Uri Ascher Department of Computer Science University of British Columbia ascher@cs.ubc.ca people.cs.ubc.ca/ ascher/520.html Uri Ascher (UBC) CPSC 520: ODEs (Ch. 2) Fall

More information

Kernel-based Approximation. Methods using MATLAB. Gregory Fasshauer. Interdisciplinary Mathematical Sciences. Michael McCourt.

Kernel-based Approximation. Methods using MATLAB. Gregory Fasshauer. Interdisciplinary Mathematical Sciences. Michael McCourt. SINGAPORE SHANGHAI Vol TAIPEI - Interdisciplinary Mathematical Sciences 19 Kernel-based Approximation Methods using MATLAB Gregory Fasshauer Illinois Institute of Technology, USA Michael McCourt University

More information

MATH 590: Meshfree Methods

MATH 590: Meshfree Methods MATH 590: Meshfree Methods Chapter 14: The Power Function and Native Space Error Estimates Greg Fasshauer Department of Applied Mathematics Illinois Institute of Technology Fall 2010 fasshauer@iit.edu

More information

Comparing Leja and Krylov Approximations of Large Scale Matrix Exponentials

Comparing Leja and Krylov Approximations of Large Scale Matrix Exponentials Comparing Leja and Krylov Approximations of Large Scale Matrix Exponentials L. Bergamaschi 1,M.Caliari 2,A.Martínez 2, and M. Vianello 2 1 Dept. of Math. Methods and Models, University of Padova berga@dmsa.unipd.it

More information

LECTURE NOTES ELEMENTARY NUMERICAL METHODS. Eusebius Doedel

LECTURE NOTES ELEMENTARY NUMERICAL METHODS. Eusebius Doedel LECTURE NOTES on ELEMENTARY NUMERICAL METHODS Eusebius Doedel TABLE OF CONTENTS Vector and Matrix Norms 1 Banach Lemma 20 The Numerical Solution of Linear Systems 25 Gauss Elimination 25 Operation Count

More information

Non-smooth data error estimates for linearly implicit Runge Kutta methods

Non-smooth data error estimates for linearly implicit Runge Kutta methods IMA Journal of Numerical Analysis 2000 20, 167 184 Non-smooth data error estimates for linearly implicit Runge Kutta methods ALEXANDER OSTERMANN AND MECHTHILD THALHAMMER Institut für Mathematik und Geometrie,

More information

AIMS Exercise Set # 1

AIMS Exercise Set # 1 AIMS Exercise Set #. Determine the form of the single precision floating point arithmetic used in the computers at AIMS. What is the largest number that can be accurately represented? What is the smallest

More information

EAD 115. Numerical Solution of Engineering and Scientific Problems. David M. Rocke Department of Applied Science

EAD 115. Numerical Solution of Engineering and Scientific Problems. David M. Rocke Department of Applied Science EAD 115 Numerical Solution of Engineering and Scientific Problems David M. Rocke Department of Applied Science Multidimensional Unconstrained Optimization Suppose we have a function f() of more than one

More information

Numerical discretization of tangent vectors of hyperbolic conservation laws.

Numerical discretization of tangent vectors of hyperbolic conservation laws. Numerical discretization of tangent vectors of hyperbolic conservation laws. Michael Herty IGPM, RWTH Aachen www.sites.google.com/michaelherty joint work with Benedetto Piccoli MNCFF 2014, Bejing, 22.5.2014

More information

Recent Results for Moving Least Squares Approximation

Recent Results for Moving Least Squares Approximation Recent Results for Moving Least Squares Approximation Gregory E. Fasshauer and Jack G. Zhang Abstract. We describe two experiments recently conducted with the approximate moving least squares (MLS) approximation

More information

Numerical Integration in Meshfree Methods

Numerical Integration in Meshfree Methods Numerical Integration in Meshfree Methods Pravin Madhavan New College University of Oxford A thesis submitted for the degree of Master of Science in Mathematical Modelling and Scientific Computing Trinity

More information

Introduction to multiscale modeling and simulation. Explicit methods for ODEs : forward Euler. y n+1 = y n + tf(y n ) dy dt = f(y), y(0) = y 0

Introduction to multiscale modeling and simulation. Explicit methods for ODEs : forward Euler. y n+1 = y n + tf(y n ) dy dt = f(y), y(0) = y 0 Introduction to multiscale modeling and simulation Lecture 5 Numerical methods for ODEs, SDEs and PDEs The need for multiscale methods Two generic frameworks for multiscale computation Explicit methods

More information

Marlis Hochbruck 1, Michael Hönig 1 and Alexander Ostermann 2

Marlis Hochbruck 1, Michael Hönig 1 and Alexander Ostermann 2 Mathematical Modelling and Numerical Analysis Modélisation Mathématique et Analyse Numérique Will be set by the publisher REGULARIZATION OF NONLINEAR ILL-POSED PROBLEMS BY EXPONENTIAL INTEGRATORS Marlis

More information

Iterative Methods for Linear Systems

Iterative Methods for Linear Systems Iterative Methods for Linear Systems 1. Introduction: Direct solvers versus iterative solvers In many applications we have to solve a linear system Ax = b with A R n n and b R n given. If n is large the

More information

The Lattice Boltzmann method for hyperbolic systems. Benjamin Graille. October 19, 2016

The Lattice Boltzmann method for hyperbolic systems. Benjamin Graille. October 19, 2016 The Lattice Boltzmann method for hyperbolic systems Benjamin Graille October 19, 2016 Framework The Lattice Boltzmann method 1 Description of the lattice Boltzmann method Link with the kinetic theory Classical

More information

Exploiting off-diagonal rank structures in the solution of linear matrix equations

Exploiting off-diagonal rank structures in the solution of linear matrix equations Stefano Massei Exploiting off-diagonal rank structures in the solution of linear matrix equations Based on joint works with D. Kressner (EPFL), M. Mazza (IPP of Munich), D. Palitta (IDCTS of Magdeburg)

More information

Chapter 10 Exercises

Chapter 10 Exercises Chapter 10 Exercises From: Finite Difference Methods for Ordinary and Partial Differential Equations by R. J. LeVeque, SIAM, 2007. http://www.amath.washington.edu/ rl/fdmbook Exercise 10.1 (One-sided and

More information

Part 1. The diffusion equation

Part 1. The diffusion equation Differential Equations FMNN10 Graded Project #3 c G Söderlind 2016 2017 Published 2017-11-27. Instruction in computer lab 2017-11-30/2017-12-06/07. Project due date: Monday 2017-12-11 at 12:00:00. Goals.

More information

Partial Differential Equations

Partial Differential Equations Part II Partial Differential Equations Year 2015 2014 2013 2012 2011 2010 2009 2008 2007 2006 2005 2015 Paper 4, Section II 29E Partial Differential Equations 72 (a) Show that the Cauchy problem for u(x,

More information

MATH 590: Meshfree Methods

MATH 590: Meshfree Methods MATH 590: Meshfree Methods Chapter 9: Conditionally Positive Definite Radial Functions Greg Fasshauer Department of Applied Mathematics Illinois Institute of Technology Fall 2010 fasshauer@iit.edu MATH

More information

PLC Papers Created For:

PLC Papers Created For: PLC Papers Created For: Year 11 Topic Practice Paper: Factorising Quadratics Factorising difficult quadratic expressions 1 Grade 7 Objective: Factorise a quadratic expression of the form ax 2 + bx + c

More information

LECTURE # 0 BASIC NOTATIONS AND CONCEPTS IN THE THEORY OF PARTIAL DIFFERENTIAL EQUATIONS (PDES)

LECTURE # 0 BASIC NOTATIONS AND CONCEPTS IN THE THEORY OF PARTIAL DIFFERENTIAL EQUATIONS (PDES) LECTURE # 0 BASIC NOTATIONS AND CONCEPTS IN THE THEORY OF PARTIAL DIFFERENTIAL EQUATIONS (PDES) RAYTCHO LAZAROV 1 Notations and Basic Functional Spaces Scalar function in R d, d 1 will be denoted by u,

More information

Chapter 6 - Ordinary Differential Equations

Chapter 6 - Ordinary Differential Equations Chapter 6 - Ordinary Differential Equations 7.1 Solving Initial-Value Problems In this chapter, we will be interested in the solution of ordinary differential equations. Ordinary differential equations

More information

CHAPTER 5: Linear Multistep Methods

CHAPTER 5: Linear Multistep Methods CHAPTER 5: Linear Multistep Methods Multistep: use information from many steps Higher order possible with fewer function evaluations than with RK. Convenient error estimates. Changing stepsize or order

More information

[2] (a) Develop and describe the piecewise linear Galerkin finite element approximation of,

[2] (a) Develop and describe the piecewise linear Galerkin finite element approximation of, 269 C, Vese Practice problems [1] Write the differential equation u + u = f(x, y), (x, y) Ω u = 1 (x, y) Ω 1 n + u = x (x, y) Ω 2, Ω = {(x, y) x 2 + y 2 < 1}, Ω 1 = {(x, y) x 2 + y 2 = 1, x 0}, Ω 2 = {(x,

More information

RBF Collocation Methods and Pseudospectral Methods

RBF Collocation Methods and Pseudospectral Methods RBF Collocation Methods and Pseudospectral Methods G. E. Fasshauer Draft: November 19, 24 Abstract We show how the collocation framework that is prevalent in the radial basis function literature can be

More information

7 Hyperbolic Differential Equations

7 Hyperbolic Differential Equations Numerical Analysis of Differential Equations 243 7 Hyperbolic Differential Equations While parabolic equations model diffusion processes, hyperbolic equations model wave propagation and transport phenomena.

More information

Computer simulation of multiscale problems

Computer simulation of multiscale problems Progress in the SSF project CutFEM, Geometry, and Optimal design Computer simulation of multiscale problems Axel Målqvist and Daniel Elfverson University of Gothenburg and Uppsala University Umeå 2015-05-20

More information

Chapter 3 Second Order Linear Equations

Chapter 3 Second Order Linear Equations Partial Differential Equations (Math 3303) A Ë@ Õæ Aë áöß @. X. @ 2015-2014 ú GA JË@ É Ë@ Chapter 3 Second Order Linear Equations Second-order partial differential equations for an known function u(x,

More information

Course Notes for EE227C (Spring 2018): Convex Optimization and Approximation

Course Notes for EE227C (Spring 2018): Convex Optimization and Approximation Course Notes for EE7C (Spring 018): Convex Optimization and Approximation Instructor: Moritz Hardt Email: hardt+ee7c@berkeley.edu Graduate Instructor: Max Simchowitz Email: msimchow+ee7c@berkeley.edu October

More information

Boundary Value Problems and Iterative Methods for Linear Systems

Boundary Value Problems and Iterative Methods for Linear Systems Boundary Value Problems and Iterative Methods for Linear Systems 1. Equilibrium Problems 1.1. Abstract setting We want to find a displacement u V. Here V is a complete vector space with a norm v V. In

More information

1. Find the solution of the following uncontrolled linear system. 2 α 1 1

1. Find the solution of the following uncontrolled linear system. 2 α 1 1 Appendix B Revision Problems 1. Find the solution of the following uncontrolled linear system 0 1 1 ẋ = x, x(0) =. 2 3 1 Class test, August 1998 2. Given the linear system described by 2 α 1 1 ẋ = x +

More information

Introduction Examples of Fractal Tilings Creating the Tilings Tiles with Radial Symmetry Similarity Maps Variations.

Introduction Examples of Fractal Tilings Creating the Tilings Tiles with Radial Symmetry Similarity Maps Variations. Fractal Tilings Katie Moe and Andrea Brown December 13, 2006 Introduction Examples of Fractal Tilings Example 1 Example 2 Table of Contents Creating the Tilings Short Summary of Important Ideas Example

More information

Scientific Computing: An Introductory Survey

Scientific Computing: An Introductory Survey Scientific Computing: An Introductory Survey Chapter 11 Partial Differential Equations Prof. Michael T. Heath Department of Computer Science University of Illinois at Urbana-Champaign Copyright c 2002.

More information

Solving PDEs with freefem++

Solving PDEs with freefem++ Solving PDEs with freefem++ Tutorials at Basque Center BCA Olivier Pironneau 1 with Frederic Hecht, LJLL-University of Paris VI 1 March 13, 2011 Do not forget That everything about freefem++ is at www.freefem.org

More information

MATH 590: Meshfree Methods

MATH 590: Meshfree Methods MATH 590: Meshfree Methods Chapter 33: Adaptive Iteration Greg Fasshauer Department of Applied Mathematics Illinois Institute of Technology Fall 2010 fasshauer@iit.edu MATH 590 Chapter 33 1 Outline 1 A

More information

Control, Stabilization and Numerics for Partial Differential Equations

Control, Stabilization and Numerics for Partial Differential Equations Paris-Sud, Orsay, December 06 Control, Stabilization and Numerics for Partial Differential Equations Enrique Zuazua Universidad Autónoma 28049 Madrid, Spain enrique.zuazua@uam.es http://www.uam.es/enrique.zuazua

More information

Proofs and derivations

Proofs and derivations A Proofs and derivations Proposition 1. In the sheltering decision problem of section 1.1, if m( b P M + s) = u(w b P M + s), where u( ) is weakly concave and twice continuously differentiable, then f

More information

u = (A + F )u, u(0) = η, (1.1)

u = (A + F )u, u(0) = η, (1.1) A CONVERGENCE ANALYSIS OF THE PEACEMAN RACHFORD SCHEME FOR SEMILINEAR EVOLUTION EQUATIONS ESKIL HANSEN AND ERIK HENNINGSSON Abstract. The Peaceman Rachford scheme is a commonly used splitting method for

More information

MATH 590: Meshfree Methods

MATH 590: Meshfree Methods MATH 590: Meshfree Methods Chapter 33: Adaptive Iteration Greg Fasshauer Department of Applied Mathematics Illinois Institute of Technology Fall 2010 fasshauer@iit.edu MATH 590 Chapter 33 1 Outline 1 A

More information

Conservation Laws and Finite Volume Methods

Conservation Laws and Finite Volume Methods Conservation Laws and Finite Volume Methods AMath 574 Winter Quarter, 2017 Randall J. LeVeque Applied Mathematics University of Washington January 4, 2017 http://faculty.washington.edu/rjl/classes/am574w2017

More information

A Posteriori Error Bounds for Meshless Methods

A Posteriori Error Bounds for Meshless Methods A Posteriori Error Bounds for Meshless Methods Abstract R. Schaback, Göttingen 1 We show how to provide safe a posteriori error bounds for numerical solutions of well-posed operator equations using kernel

More information

MATH 590: Meshfree Methods

MATH 590: Meshfree Methods MATH 590: Meshfree Methods Chapter 43: RBF-PS Methods in MATLAB Greg Fasshauer Department of Applied Mathematics Illinois Institute of Technology Fall 2010 fasshauer@iit.edu MATH 590 Chapter 43 1 Outline

More information

Decay rates for partially dissipative hyperbolic systems

Decay rates for partially dissipative hyperbolic systems Outline Decay rates for partially dissipative hyperbolic systems Basque Center for Applied Mathematics Bilbao, Basque Country, Spain zuazua@bcamath.org http://www.bcamath.org/zuazua/ Numerical Methods

More information

Runge Kutta Chebyshev methods for parabolic problems

Runge Kutta Chebyshev methods for parabolic problems Runge Kutta Chebyshev methods for parabolic problems Xueyu Zhu Division of Appied Mathematics, Brown University December 2, 2009 Xueyu Zhu 1/18 Outline Introdution Consistency condition Stability Properties

More information

Marlis Hochbruck 1, Michael Hönig 1 and Alexander Ostermann 2

Marlis Hochbruck 1, Michael Hönig 1 and Alexander Ostermann 2 ESAIM: M2AN 43 (29) 79 72 DOI:.5/m2an/292 ESAIM: Mathematical Modelling and Numerical Analysis www.esaim-m2an.org REGULARIZATION OF NONLINEAR ILL-POSED PROBLEMS BY EXPONENTIAL INTEGRATORS Marlis Hochbruck,

More information