Space-Time Localized Radial Basis Function Collocation Methods for PDEs

Size: px
Start display at page:

Download "Space-Time Localized Radial Basis Function Collocation Methods for PDEs"

Transcription

1 Space-Time Localized Radial Basis Function Collocation Methods for PDEs Alfa Heryudono Department of Mathematics University of Massachusetts Dartmouth ICERM Topical Workshop Providence August 27 This research is partly supported by NSF DMS Joint work with grad student: Jacob Sousa Computations are mostly done on UMassD Rapid Prototyping Server / 2

2 Dealing with Time-Dependent PDEs for RBF Methods Method of Lines RBF discretization in space + common ODE solver in time Min changes of PS/FD codes: replace differentiation matrices with RBF versions (Global, RBF-FD, RBF-PU, etc) PS/FD treatments for BCs: Strip-rows, Strip-rows move over columns, fictitious pts/ rect projection (for multiple bcs), penalty, etc Stability for linear pde case: Eigenvalue and Pseudospectra Simultaneous Space-Time RBF Boundary value collocation problem in space-time domain Time is treated as another space variable RBF-BVP solver have been studied for quite a while Less worry about choosing ODE solver based on PDE types Adaptivity, moving boundary, and BCs: same treatments as in BVP cases No need to rewrite the pde due to var trans (eg in moving boundary case) Analyzing stability is not clear (eg in moving boundary case) Might be epensive to solve (eg finding preconditioner, non-linear case) 2 / 2

3 Space-Time PS Collocation Method: D+t linear case PDE : IC : BC : u t = u (,t) [,) (,T] u(,) = f() u(,t) = g(t) Use PS or Block PS (Driscoll-Fornberg) to create differentiation matrices / 2

4 Space-Time PS Collocation Method: 2D+t, linear case ut = u + F (, y, t) IC : (, y, t) Ω (, T ] u(, y, ) = f (, y ) BC : u( Ω, t) = g ( Ω, t) kron s disease is worse in 2D + t case 5 PDE : P = symrcm(plinop); 2 L = gpuarray(linop(p,p)); -2 PL = gpuarray(plinop(p,p)); r = gpuarray(rhs(p)); 2-6 MAXITER = 3; TOL = e-4; RESTART = []; 3 [Ugpu,FLAG,RELRES,ITER,RESVEC] = nz = gmres(l,r,restart,tol,maxiter,pl); U(P) = gather(ugpu); / 2

5 Space-Time PS Collocation Method: D+t, nonlinear case Human tear film dynamics: D model: see H et al 27 h t +q = on X(t), where ( ) h 3 q(,t) = Sh 3 +βh2 Boundary conditions h(x(t),t) = h(,t) = h q(x(t),t) = X t h +Q top q(,t) = Q bot 2 8 t h(,t) Advance the solution in space-time domain: Slab by Slab (Show MATLAB) 5 / 2

6 RBF-FD Differentiation Matrices where Ω Ω s j () = n loc k= λ k φ k (), whereφ k ()isaradialbasisfunction centered at k Or in Lagrange formulation as s j () = n loc k= Ψ k ()u k, Ψ = [ Ψ () Ψ n loc () ] = [ φ () φ n loc () ][ A ], Ψ = [ Ψ () Ψn loc () ] = [ φ () φn loc () ][ A ], The matri A with entries a lk = φ k ( l ), l,k =,,n loc is local RBF interpolation matri BYODM: Bring Your Own Differentiation Matrices 6 / 2

7 Getting the space-time domain This is probably for programming on a lazy Sunday: Use Mathematica s DiscretizeRegion family commands Surprisingly, Mathematica has many built-in funky domains too This is also useful if you want to compare results with finite-element R = ImplicitRegion[-6 Sin[t] <=, {{, -, }, {t,, 5 Pi}}]; ev = DiscretizeRegion[R]; pts = MeshCoordinates[ev]; Eport["spacetimedommat", pts]; To obtained boundary points, you can use Mathematica or boundary command in MATLAB 7 / 2

8 t+d Advection Eample PDE : u t = u (,t) [X(t),) (,T] IC : u(,) = f() BC : u(,t) = g(t) solution in space-time domain IMQ-RBF: +(εr) 2 r2 = ( i ) 2 +(t t i ) 2 D t D f() = e ( 5+35y)2,g(t) = I u = f g P = symrcm(l); u(p) = L(P,P)\RHS(P); or MAXITER = 2; TOL = e-3; RESTART = []; [ML,MU] = ilu(l(p,p),struct( type, ilutp, droptol,e-6)); u(p) = gmres(l(p,p),rhs(p),restart,tol,maxiter,ml,mu); portion of system matri after applying MATLAB symrcm 8 / 2

9 t+d Advection Eample PDE : u t = u +F(,t) (,t) [X(t),) (,T] IC : u(,) = f() BC : u(,t) = g(t) solution in space-time domain IMQ-RBF: +(εr) 2 r2 = ( i ) 2 +(t t i ) 2 Get RBF-QR diffmat from Elisabeth s website f() = e ( 5+35y)2 n loc = 5,ε= D t D I u = F f g Test case Test case 2 Test case 3 Test case N slope = / 2

10 t+d Advection with Variable Speed Eample PDE : u t = a(,t)u +F(,t) (,t) [X(t),) (,T] IC : u(,) = f() BC : u(,t) = g(t) solution in space-time domain a(,t) = ep((+t)(+cos(3)) f() = e ( 5+35y)2 Bribe Varun for PHS diffmat n loc = 5,ε= D t diag(a)d F slope = -456 I u = f g Test case Test case 2 Test case 3 Test case N / 2

11 Analyzing Stability? Let s take a look at one step ( 2 levels) space-time global RBF method 2 j n n t + t 2 a j n n b t for a simple -D advection equation u PDE: t = u for [a,b) IC: u(,) = u () when t = BC: u(b,t) = g(t) at = b u() = n λ j φ(ε j )+ n λ j φ(ε j ), j= j= where { j } and { j } are centers at the old time level and new time level respectively / 2

12 2 j n n t + t 2 a j n n b t Our goal is to find the unknowns {λ j } and {λ j } This can be done by enforcing initial and boundary data and satisfying the PDE at the interior points that lead to solving system of linear equations A C B D λ λ n λ λ n = u o ( ) u o ( n ) g(t) / 2

13 A B C D λ λ n λ λ n = u o ( ) u o ( n ) g(t) The block matrices A,B,C,D are all n n matrices with elements: A ij = φ(ε i j ) B ij = φ(ε i j ) C ij = Lφ(ε i j ) D ij = Lφ(ε i j ) for all i,j =,,n and L := t The last row C and D must be slightly modified to satisfy the boundary condition at n = b 2 / 2

14 Amplification Matri and Stability Region The process of marching in time to the new time level is given by where u( ) u( n ) = G G = [ B A ][ A B C D u( ) u( n ) ] [ I and I is an n n identity matri The method is numerically stable if spectral radius ρ(g) < ], log(ε) log( t / ) IMQ, g(t) =, N = 5: to avoid blowing up the solution, the ratio of t/ vs shape parameter ε must be away from the darker alley in the the stability region, ie we want to avoid ρ(g) 3 / 2

15 Adaptivity for BVP based on Residual subsampling Initial coarse collection of nonoverlapping regular boes in R d that cover the domain Ω of interest 2 Geometric adaptation 3 Refining and Coarsening steps D initial boes Irregular geometry 75 2D initial boes 5 see 5 25 y y Driscoll & H (27) / 2

16 Rules of refining and coarsening centers Refinement strategy: converting all check points if Coarsening strategy: reactivate all RBF centers if all of its grand children have residual any of them have residual errors are greater than θ r described as into RBF centers as dots and remove errors less than θ c described as its parent a layout of quadtree With this rule, centers are located as leaves 5 / 2

17 Depth first search algorithm Pruning device to save computing pairwise distances:o(n q log(n)) instead of O(N) per query point Partial updates for lists of neighbors Embarassingly parallel neighbors search Values at are computed using local RBF interpolant of the bo whose midpoint is the parent node of the check points average distance computations Uniform nodes distribution N n q log 4 N Some non-uniform nodes distribution average distance computations N N n q log 4 N N 6 / 2

18 t+d Nonlinear Eample Burgers Equation 5 υu uu = u t, < < u(,t) = u(,t) = u(,) = sin(2π)+ 2 sin(π) where, υ = 3 MATLAB s fsolve is used to solve the nonlinear system Jacobian file is provided t 2 t t 2 t 5 N = / 2

19 Dealing with Multiple Boundary Conditions PDE : Tear film PDE in terms of h (,t) [X(t),) (,T] IC : h(,) = f() BC : h(,t) = h(x(t),t) = h h (,t) = g (t) h (X(t),t) = g 2 (X(t),t) PDE : h t = Sq,S is a constant q = nonlinear flu (,t) [X(t),) (,T] IC : h(,) = f() BC : h(,t) = h(x(t),t) = h q(,t) = g (t) q(x(t),t) = g 2 (X(t),t) h(,t) t / 2

20 t+2d Advection Eample u t = 5u +75u y +F(,y,t) (,y) [,) [,) u(,y,t) = f (,y,t) u(,,t) = f 2 (,,t) u(,y,) = g(,y) n loc = 5,ε=75 2 Error Test case Test case N /3 9 / 2

21 t+2d Wave Eample u tt = u (,y) (,) (,) u(,y,t) = at the boundary u(,y,) = g(,y) u t (,y,) = etra ghost/fictitious points for enforcing u t 2 / 2

22 On-going study or future questions Stability: Can it only be done through adaptivity? Least-Squares Space-time RBF-PU might be worth to try Adaptivity in terms of partitions Move away from points adaptivity Preconditioner? Possible GR application Application to 2D +t Human Tear Film Dynamics Enforce my grad students to finish the papers Fully open 2/3 open /3 open Closed y y y y ====================== 2 / 2

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

A numerical study of a technique for shifting eigenvalues of radial basis function differentiation matrices

A numerical study of a technique for shifting eigenvalues of radial basis function differentiation matrices A numerical study of a technique for shifting eigenvalues of radial basis function differentiation matrices Scott A. Sarra Marshall University and Alfa R.H. Heryudono University of Massachusetts Dartmouth

More information

APPLICATIONS OF FD APPROXIMATIONS FOR SOLVING ORDINARY DIFFERENTIAL EQUATIONS

APPLICATIONS OF FD APPROXIMATIONS FOR SOLVING ORDINARY DIFFERENTIAL EQUATIONS LECTURE 10 APPLICATIONS OF FD APPROXIMATIONS FOR SOLVING ORDINARY DIFFERENTIAL EQUATIONS Ordinary Differential Equations Initial Value Problems For Initial Value problems (IVP s), conditions are specified

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

A scaling perspective on accuracy and convergence in RBF approximations

A scaling perspective on accuracy and convergence in RBF approximations A scaling perspective on accuracy and convergence in RBF approximations Elisabeth Larsson With: Bengt Fornberg, Erik Lehto, and Natasha Flyer Division of Scientific Computing Department of Information

More information

Numerical solution of nonlinear sine-gordon equation with local RBF-based finite difference collocation method

Numerical solution of nonlinear sine-gordon equation with local RBF-based finite difference collocation method Numerical solution of nonlinear sine-gordon equation with local RBF-based finite difference collocation method Y. Azari Keywords: Local RBF-based finite difference (LRBF-FD), Global RBF collocation, sine-gordon

More information

STATE VARIABLE (SV) SYSTEMS

STATE VARIABLE (SV) SYSTEMS Copyright F.L. Lewis 999 All rights reserved Updated:Tuesday, August 05, 008 STATE VARIABLE (SV) SYSTEMS A natural description for dynamical systems is the nonlinear state-space or state variable (SV)

More information

Collocation approximation of the monodromy operator of periodic, linear DDEs

Collocation approximation of the monodromy operator of periodic, linear DDEs p. Collocation approximation of the monodromy operator of periodic, linear DDEs Ed Bueler 1, Victoria Averina 2, and Eric Butcher 3 13 July, 2004 SIAM Annual Meeting 2004, Portland 1=Dept. of Math. Sci.,

More information

8 A pseudo-spectral solution to the Stokes Problem

8 A pseudo-spectral solution to the Stokes Problem 8 A pseudo-spectral solution to the Stokes Problem 8.1 The Method 8.1.1 Generalities We are interested in setting up a pseudo-spectral method for the following Stokes Problem u σu p = f in Ω u = 0 in Ω,

More information

Pattern formation and Turing instability

Pattern formation and Turing instability Pattern formation and Turing instability. Gurarie Topics: - Pattern formation through symmetry breaing and loss of stability - Activator-inhibitor systems with diffusion Turing proposed a mechanism for

More information

MATH 333: Partial Differential Equations

MATH 333: Partial Differential Equations MATH 333: Partial Differential Equations Problem Set 9, Final version Due Date: Tues., Nov. 29, 2011 Relevant sources: Farlow s book: Lessons 9, 37 39 MacCluer s book: Chapter 3 44 Show that the Poisson

More information

THE RUNGE PHENOMENON AND SPATIALLY VARIABLE SHAPE PARAMETERS IN RBF INTERPOLATION

THE RUNGE PHENOMENON AND SPATIALLY VARIABLE SHAPE PARAMETERS IN RBF INTERPOLATION THE RUNGE PHENOMENON AND SPATIALLY VARIABLE SHAPE PARAMETERS IN RBF INTERPOLATION BENGT FORNBERG AND JULIA ZUEV Abstract. Many studies, mostly empirical, have been devoted to finding an optimal shape parameter

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

Theory, Solution Techniques and Applications of Singular Boundary Value Problems

Theory, Solution Techniques and Applications of Singular Boundary Value Problems Theory, Solution Techniques and Applications of Singular Boundary Value Problems W. Auzinger O. Koch E. Weinmüller Vienna University of Technology, Austria Problem Class z (t) = M(t) z(t) + f(t, z(t)),

More information

Proper Orthogonal Decomposition (POD)

Proper Orthogonal Decomposition (POD) Intro Results Problem etras Proper Orthogonal Decomposition () Advisor: Dr. Sorensen CAAM699 Department of Computational and Applied Mathematics Rice University September 5, 28 Outline Intro Results Problem

More information

Review for Exam 2 Ben Wang and Mark Styczynski

Review for Exam 2 Ben Wang and Mark Styczynski Review for Exam Ben Wang and Mark Styczynski This is a rough approximation of what we went over in the review session. This is actually more detailed in portions than what we went over. Also, please note

More information

The automatic solution of PDEs using a global spectral method

The automatic solution of PDEs using a global spectral method The automatic solution of PDEs using a global spectral method 2014 CBMS-NSF Conference, 29th June 2014 Alex Townsend PhD student University of Oxford (with Sheehan Olver) Supervised by Nick Trefethen,

More information

Linear Algebra II (finish from last time) Root finding

Linear Algebra II (finish from last time) Root finding Lecture 5: Topics: Linear lgebra II (finish from last time) Root finding -Cross product of two vectors -Finding roots of linear equations -Finding roots of nonlinear equations HW: HW 1, Part 3-4 given

More information

Numerical Methods - Boundary Value Problems for ODEs

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

More information

Chapter 1: Introduction

Chapter 1: Introduction Chapter 1: Introduction Definition: A differential equation is an equation involving the derivative of a function. If the function depends on a single variable, then only ordinary derivatives appear and

More information

Lesson 14: Van der Pol Circuit and ode23s

Lesson 14: Van der Pol Circuit and ode23s Lesson 4: Van der Pol Circuit and ode3s 4. Applied Problem. A series LRC circuit when coupled via mutual inductance with a triode circuit can generate a sequence of pulsing currents that have very rapid

More information

Recovery of high order accuracy in radial basis function approximation for discontinuous problems

Recovery of high order accuracy in radial basis function approximation for discontinuous problems Recovery of high order accuracy in radial basis function approximation for discontinuous problems Chris L. Bresten, Sigal Gottlieb 1, Daniel Higgs, Jae-Hun Jung* 2 Abstract Radial basis function(rbf) methods

More information

An Introduction to Algebraic Multigrid (AMG) Algorithms Derrick Cerwinsky and Craig C. Douglas 1/84

An Introduction to Algebraic Multigrid (AMG) Algorithms Derrick Cerwinsky and Craig C. Douglas 1/84 An Introduction to Algebraic Multigrid (AMG) Algorithms Derrick Cerwinsky and Craig C. Douglas 1/84 Introduction Almost all numerical methods for solving PDEs will at some point be reduced to solving A

More information

1. Introduction. A radial basis function (RBF) interpolant of multivariate data (x k, y k ), k = 1, 2,..., n takes the form

1. Introduction. A radial basis function (RBF) interpolant of multivariate data (x k, y k ), k = 1, 2,..., n takes the form A NEW CLASS OF OSCILLATORY RADIAL BASIS FUNCTIONS BENGT FORNBERG, ELISABETH LARSSON, AND GRADY WRIGHT Abstract Radial basis functions RBFs form a primary tool for multivariate interpolation, and they are

More information

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

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

More information

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

University of Alberta ENGM 541: Modeling and Simulation of Engineering Systems Laboratory #5

University of Alberta ENGM 541: Modeling and Simulation of Engineering Systems Laboratory #5 University of Alberta ENGM 54: Modeling and Simulation of Engineering Systems Laboratory #5 M.G. Lipsett, Updated 00 Integration Methods with Higher-Order Truncation Errors with MATLAB MATLAB is capable

More information

Breaking Computational Barriers: Multi-GPU High-Order RBF Kernel Problems with Millions of Points

Breaking Computational Barriers: Multi-GPU High-Order RBF Kernel Problems with Millions of Points Breaking Computational Barriers: Multi-GPU High-Order RBF Kernel Problems with Millions of Points Michael Griebel Christian Rieger Peter Zaspel Institute for Numerical Simulation Rheinische Friedrich-Wilhelms-Universität

More information

Bootstrap AMG. Kailai Xu. July 12, Stanford University

Bootstrap AMG. Kailai Xu. July 12, Stanford University Bootstrap AMG Kailai Xu Stanford University July 12, 2017 AMG Components A general AMG algorithm consists of the following components. A hierarchy of levels. A smoother. A prolongation. A restriction.

More information

Numerical Programming I (for CSE)

Numerical Programming I (for CSE) Technische Universität München WT 1/13 Fakultät für Mathematik Prof. Dr. M. Mehl B. Gatzhammer January 1, 13 Numerical Programming I (for CSE) Tutorial 1: Iterative Methods 1) Relaxation Methods a) Let

More information

A RADIAL BASIS FUNCTION METHOD FOR THE SHALLOW WATER EQUATIONS ON A SPHERE

A RADIAL BASIS FUNCTION METHOD FOR THE SHALLOW WATER EQUATIONS ON A SPHERE A RADIAL BASIS FUNCTION METHOD FOR THE SHALLOW WATER EQUATIONS ON A SPHERE NATASHA FLYER AND GRADY B. WRIGHT Abstract. The paper derives the first known numerical shallow water model on the sphere using

More information

Hyperbolic Systems of Conservation Laws. I - Basic Concepts

Hyperbolic Systems of Conservation Laws. I - Basic Concepts Hyperbolic Systems of Conservation Laws I - Basic Concepts Alberto Bressan Mathematics Department, Penn State University Alberto Bressan (Penn State) Hyperbolic Systems of Conservation Laws 1 / 27 The

More information

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

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

More information

INTRODUCTION TO COMPUTER METHODS FOR O.D.E.

INTRODUCTION TO COMPUTER METHODS FOR O.D.E. INTRODUCTION TO COMPUTER METHODS FOR O.D.E. 0. Introduction. The goal of this handout is to introduce some of the ideas behind the basic computer algorithms to approximate solutions to differential equations.

More information

Butcher tableau Can summarize an s + 1 stage Runge Kutta method using a triangular grid of coefficients

Butcher tableau Can summarize an s + 1 stage Runge Kutta method using a triangular grid of coefficients AM 205: lecture 13 Last time: ODE convergence and stability, Runge Kutta methods Today: the Butcher tableau, multi-step methods, boundary value problems Butcher tableau Can summarize an s + 1 stage Runge

More information

Department of Applied Mathematics Preliminary Examination in Numerical Analysis August, 2013

Department of Applied Mathematics Preliminary Examination in Numerical Analysis August, 2013 Department of Applied Mathematics Preliminary Examination in Numerical Analysis August, 013 August 8, 013 Solutions: 1 Root Finding (a) Let the root be x = α We subtract α from both sides of x n+1 = x

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

Background. Background. C. T. Kelley NC State University tim C. T. Kelley Background NCSU, Spring / 58

Background. Background. C. T. Kelley NC State University tim C. T. Kelley Background NCSU, Spring / 58 Background C. T. Kelley NC State University tim kelley@ncsu.edu C. T. Kelley Background NCSU, Spring 2012 1 / 58 Notation vectors, matrices, norms l 1 : max col sum... spectral radius scaled integral norms

More information

A Radial Basis Function (RBF) Compact Finite Difference (FD) Scheme for Reaction-Diffusion Equations on Surfaces

A Radial Basis Function (RBF) Compact Finite Difference (FD) Scheme for Reaction-Diffusion Equations on Surfaces Boise State University ScholarWorks Mathematics Faculty Publications and Presentations Department of Mathematics 1-1-2017 A Radial Basis Function (RBF) Compact Finite Difference (FD) Scheme for Reaction-Diffusion

More information

Optimal Control. Quadratic Functions. Single variable quadratic function: Multi-variable quadratic function:

Optimal Control. Quadratic Functions. Single variable quadratic function: Multi-variable quadratic function: Optimal Control Control design based on pole-placement has non unique solutions Best locations for eigenvalues are sometimes difficult to determine Linear Quadratic LQ) Optimal control minimizes a quadratic

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

Residual Force Equations

Residual Force Equations 3 Residual Force Equations NFEM Ch 3 Slide 1 Total Force Residual Equation Vector form r(u,λ) = 0 r = total force residual vector u = state vector with displacement DOF Λ = array of control parameters

More information

Chapter 3 Numerical Methods

Chapter 3 Numerical Methods Chapter 3 Numerical Methods Part 3 3.4 Differential Algebraic Systems 3.5 Integration of Differential Equations 1 Outline 3.4 Differential Algebraic Systems 3.4.1 Constrained Dynamics 3.4.2 First and Second

More information

A Stable Spectral Difference Method for Triangles

A Stable Spectral Difference Method for Triangles A Stable Spectral Difference Method for Triangles Aravind Balan 1, Georg May 1, and Joachim Schöberl 2 1 AICES Graduate School, RWTH Aachen, Germany 2 Institute for Analysis and Scientific Computing, Vienna

More information

Solving Boundary Value Problems (with Gaussians)

Solving Boundary Value Problems (with Gaussians) What is a boundary value problem? Solving Boundary Value Problems (with Gaussians) Definition A differential equation with constraints on the boundary Michael McCourt Division Argonne National Laboratory

More information

Numerical Methods I Solving Nonlinear Equations

Numerical Methods I Solving Nonlinear Equations Numerical Methods I Solving Nonlinear Equations Aleksandar Donev Courant Institute, NYU 1 donev@courant.nyu.edu 1 MATH-GA 2011.003 / CSCI-GA 2945.003, Fall 2014 October 16th, 2014 A. Donev (Courant Institute)

More information

. Frobenius-Perron Operator ACC Workshop on Uncertainty Analysis & Estimation. Raktim Bhattacharya

. Frobenius-Perron Operator ACC Workshop on Uncertainty Analysis & Estimation. Raktim Bhattacharya .. Frobenius-Perron Operator 2014 ACC Workshop on Uncertainty Analysis & Estimation Raktim Bhattacharya Laboratory For Uncertainty Quantification Aerospace Engineering, Texas A&M University. uq.tamu.edu

More information

Towards a highly-parallel PDE-Solver using Adaptive Sparse Grids on Compute Clusters

Towards a highly-parallel PDE-Solver using Adaptive Sparse Grids on Compute Clusters Towards a highly-parallel PDE-Solver using Adaptive Sparse Grids on Compute Clusters HIM - Workshop on Sparse Grids and Applications Alexander Heinecke Chair of Scientific Computing May 18 th 2011 HIM

More information

MODEL REDUCTION BY A CROSS-GRAMIAN APPROACH FOR DATA-SPARSE SYSTEMS

MODEL REDUCTION BY A CROSS-GRAMIAN APPROACH FOR DATA-SPARSE SYSTEMS MODEL REDUCTION BY A CROSS-GRAMIAN APPROACH FOR DATA-SPARSE SYSTEMS Ulrike Baur joint work with Peter Benner Mathematics in Industry and Technology Faculty of Mathematics Chemnitz University of Technology

More information

Introduction to the Optimal Control Software GPOPS II

Introduction to the Optimal Control Software GPOPS II Introduction to the Optimal Control Software GPOPS II Anil V. Rao Department of Mechanical and Aerospace Engineering University of Florida Gainesville, FL 32611-625 Tutorial on GPOPS II NSF CBMS Workshop

More information

k is a product of elementary matrices.

k is a product of elementary matrices. Mathematics, Spring Lecture (Wilson) Final Eam May, ANSWERS Problem (5 points) (a) There are three kinds of elementary row operations and associated elementary matrices. Describe what each kind of operation

More information

= V I = Bus Admittance Matrix. Chapter 6: Power Flow. Constructing Ybus. Example. Network Solution. Triangular factorization. Let

= V I = Bus Admittance Matrix. Chapter 6: Power Flow. Constructing Ybus. Example. Network Solution. Triangular factorization. Let Chapter 6: Power Flow Network Matrices Network Solutions Newton-Raphson Method Fast Decoupled Method Bus Admittance Matri Let I = vector of currents injected into nodes V = vector of node voltages Y bus

More information

Finite Difference Methods for Boundary Value Problems

Finite Difference Methods for Boundary Value Problems Finite Difference Methods for Boundary Value Problems October 2, 2013 () Finite Differences October 2, 2013 1 / 52 Goals Learn steps to approximate BVPs using the Finite Difference Method Start with two-point

More information

Solving Symmetric Indefinite Systems with Symmetric Positive Definite Preconditioners

Solving Symmetric Indefinite Systems with Symmetric Positive Definite Preconditioners Solving Symmetric Indefinite Systems with Symmetric Positive Definite Preconditioners Eugene Vecharynski 1 Andrew Knyazev 2 1 Department of Computer Science and Engineering University of Minnesota 2 Department

More information

Partitioned Methods for Multifield Problems

Partitioned Methods for Multifield Problems C Partitioned Methods for Multifield Problems Joachim Rang, 6.7.2016 6.7.2016 Joachim Rang Partitioned Methods for Multifield Problems Seite 1 C One-dimensional piston problem fixed wall Fluid flexible

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

Solving systems of ODEs with Matlab

Solving systems of ODEs with Matlab Solving systems of ODEs with Matlab James K. Peterson Department of Biological Sciences and Department of Mathematical Sciences Clemson University October 20, 2013 Outline 1 Systems of ODEs 2 Setting Up

More information

YURI LEVIN, MIKHAIL NEDIAK, AND ADI BEN-ISRAEL

YURI LEVIN, MIKHAIL NEDIAK, AND ADI BEN-ISRAEL Journal of Comput. & Applied Mathematics 139(2001), 197 213 DIRECT APPROACH TO CALCULUS OF VARIATIONS VIA NEWTON-RAPHSON METHOD YURI LEVIN, MIKHAIL NEDIAK, AND ADI BEN-ISRAEL Abstract. Consider m functions

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

AM 205: lecture 14. Last time: Boundary value problems Today: Numerical solution of PDEs

AM 205: lecture 14. Last time: Boundary value problems Today: Numerical solution of PDEs AM 205: lecture 14 Last time: Boundary value problems Today: Numerical solution of PDEs ODE BVPs A more general approach is to formulate a coupled system of equations for the BVP based on a finite difference

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

Shooting methods for numerical solutions of control problems constrained. by linear and nonlinear hyperbolic partial differential equations

Shooting methods for numerical solutions of control problems constrained. by linear and nonlinear hyperbolic partial differential equations Shooting methods for numerical solutions of control problems constrained by linear and nonlinear hyperbolic partial differential equations by Sung-Dae Yang A dissertation submitted to the graduate faculty

More information

Ordinary Differential Equations

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

More information

Preconditioning for radial basis function partition of unity methods

Preconditioning for radial basis function partition of unity methods Journal of Scientific Computing manuscript No. (will be inserted by the editor) Preconditioning for radial basis function partition of unity methods Alfa Heryudono Elisabeth Larsson Alison Ramage Lina

More information

Adaptive mesh refinement for neutron transport

Adaptive mesh refinement for neutron transport Adaptive mesh refinement for neutron transport TN98 Bachelor Thesis M.J. van Nijhuis 654 supervisor: D. Lathouwers August Abstract A study of an adaptive mesh refinement (AMR) algorithm to solve the neutron

More information

Applied Mathematics 205. Unit III: Numerical Calculus. Lecturer: Dr. David Knezevic

Applied Mathematics 205. Unit III: Numerical Calculus. Lecturer: Dr. David Knezevic Applied Mathematics 205 Unit III: Numerical Calculus Lecturer: Dr. David Knezevic Unit III: Numerical Calculus Chapter III.3: Boundary Value Problems and PDEs 2 / 96 ODE Boundary Value Problems 3 / 96

More information

Spectral Collocation Method for Parabolic Partial Differential Equations with Neumann Boundary Conditions

Spectral Collocation Method for Parabolic Partial Differential Equations with Neumann Boundary Conditions Applied Mathematical Sciences, Vol. 1, 2007, no. 5, 211-218 Spectral Collocation Method for Parabolic Partial Differential Equations with Neumann Boundary Conditions M. Javidi a and A. Golbabai b a Department

More information

Hyperbolic Systems of Conservation Laws. in One Space Dimension. II - Solutions to the Cauchy problem. Alberto Bressan

Hyperbolic Systems of Conservation Laws. in One Space Dimension. II - Solutions to the Cauchy problem. Alberto Bressan Hyperbolic Systems of Conservation Laws in One Space Dimension II - Solutions to the Cauchy problem Alberto Bressan Department of Mathematics, Penn State University http://www.math.psu.edu/bressan/ 1 Global

More information

Finite Elements for Nonlinear Problems

Finite Elements for Nonlinear Problems Finite Elements for Nonlinear Problems Computer Lab 2 In this computer lab we apply finite element method to nonlinear model problems and study two of the most common techniques for solving the resulting

More information

Numerical Solutions to PDE s

Numerical Solutions to PDE s Introduction Numerical Solutions to PDE s Mathematical Modelling Week 5 Kurt Bryan Let s start by recalling a simple numerical scheme for solving ODE s. Suppose we have an ODE u (t) = f(t, u(t)) for some

More information

Math Ordinary Differential Equations

Math Ordinary Differential Equations Math 411 - Ordinary Differential Equations Review Notes - 1 1 - Basic Theory A first order ordinary differential equation has the form x = f(t, x) (11) Here x = dx/dt Given an initial data x(t 0 ) = x

More information

The Discontinuous Galerkin Finite Element Method

The Discontinuous Galerkin Finite Element Method The Discontinuous Galerkin Finite Element Method Michael A. Saum msaum@math.utk.edu Department of Mathematics University of Tennessee, Knoxville The Discontinuous Galerkin Finite Element Method p.1/41

More information

Fall Exam II. Wed. Nov. 9, 2005

Fall Exam II. Wed. Nov. 9, 2005 Fall 005 10.34 Eam II. Wed. Nov. 9 005 (SOLUTION) Read through the entire eam before beginning work and budget your time. You are researching drug eluting stents and wish to understand better how the drug

More information

A High-Order Galerkin Solver for the Poisson Problem on the Surface of the Cubed Sphere

A High-Order Galerkin Solver for the Poisson Problem on the Surface of the Cubed Sphere A High-Order Galerkin Solver for the Poisson Problem on the Surface of the Cubed Sphere Michael Levy University of Colorado at Boulder Department of Applied Mathematics August 10, 2007 Outline 1 Background

More information

Notes on PCG for Sparse Linear Systems

Notes on PCG for Sparse Linear Systems Notes on PCG for Sparse Linear Systems Luca Bergamaschi Department of Civil Environmental and Architectural Engineering University of Padova e-mail luca.bergamaschi@unipd.it webpage www.dmsa.unipd.it/

More information

MATH 590: Meshfree Methods

MATH 590: Meshfree Methods MATH 590: Meshfree Methods Chapter 34: Improving the Condition Number of the Interpolation Matrix Greg Fasshauer Department of Applied Mathematics Illinois Institute of Technology Fall 2010 fasshauer@iit.edu

More information

The integrating factor method (Sect. 1.1)

The integrating factor method (Sect. 1.1) The integrating factor method (Sect. 1.1) Overview of differential equations. Linear Ordinary Differential Equations. The integrating factor method. Constant coefficients. The Initial Value Problem. Overview

More information

Atmospheric Dynamics with Polyharmonic Spline RBFs

Atmospheric Dynamics with Polyharmonic Spline RBFs Photos placed in horizontal position with even amount of white space between photos and header Atmospheric Dynamics with Polyharmonic Spline RBFs Greg Barnett Sandia National Laboratories is a multimission

More information

Final: Solutions Math 118A, Fall 2013

Final: Solutions Math 118A, Fall 2013 Final: Solutions Math 118A, Fall 2013 1. [20 pts] For each of the following PDEs for u(x, y), give their order and say if they are nonlinear or linear. If they are linear, say if they are homogeneous or

More information

Solution: Based on the slope of q(t): 20 A for 0 t 1 s dt = 0 for 3 t 4 s. 20 A for 4 t 5 s 0 for t 5 s 20 C. t (s) 20 C. i (A) Fig. P1.

Solution: Based on the slope of q(t): 20 A for 0 t 1 s dt = 0 for 3 t 4 s. 20 A for 4 t 5 s 0 for t 5 s 20 C. t (s) 20 C. i (A) Fig. P1. Problem 1.24 The plot in Fig. P1.24 displays the cumulative charge q(t) that has entered a certain device up to time t. Sketch a plot of the corresponding current i(t). q 20 C 0 1 2 3 4 5 t (s) 20 C Figure

More information

A MANIFOLD-BASED EXPONENTIALLY CONVERGENT ALGORITHM FOR SOLVING NON-LINEAR PARTIAL DIFFERENTIAL EQUATIONS

A MANIFOLD-BASED EXPONENTIALLY CONVERGENT ALGORITHM FOR SOLVING NON-LINEAR PARTIAL DIFFERENTIAL EQUATIONS Journal of Marine Science and Technology Vol. No. pp. -9 () DOI:.69/JMST--- A MANIOLD-ASED EXPONENTIALLY CONVERGENT ALGORITHM OR SOLVING NON-LINEAR PARTIAL DIERENTIAL EQUATIONS Chein-Shan Liu Key words:

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

A Discontinuous Galerkin Moving Mesh Method for Hamilton-Jacobi Equations

A Discontinuous Galerkin Moving Mesh Method for Hamilton-Jacobi Equations Int. Conference on Boundary and Interior Layers BAIL 6 G. Lube, G. Rapin Eds c University of Göttingen, Germany, 6 A Discontinuous Galerkin Moving Mesh Method for Hamilton-Jacobi Equations. Introduction

More information

Lecture 4: Numerical solution of ordinary differential equations

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

More information

Understand the existence and uniqueness theorems and what they tell you about solutions to initial value problems.

Understand the existence and uniqueness theorems and what they tell you about solutions to initial value problems. Review Outline To review for the final, look over the following outline and look at problems from the book and on the old exam s and exam reviews to find problems about each of the following topics.. Basics

More information

Finite Difference Methods (FDMs) 1

Finite Difference Methods (FDMs) 1 Finite Difference Methods (FDMs) 1 1 st - order Approxima9on Recall Taylor series expansion: Forward difference: Backward difference: Central difference: 2 nd - order Approxima9on Forward difference: Backward

More information

1 Review of Interpolation using Cubic Splines

1 Review of Interpolation using Cubic Splines cs412: introduction to numerical analysis 10/10/06 Lecture 12: Instructor: Professor Amos Ron Cubic Hermite Spline Interpolation Scribes: Yunpeng Li, Mark Cowlishaw 1 Review of Interpolation using Cubic

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

ODE Homework 1. Due Wed. 19 August 2009; At the beginning of the class

ODE Homework 1. Due Wed. 19 August 2009; At the beginning of the class ODE Homework Due Wed. 9 August 2009; At the beginning of the class. (a) Solve Lẏ + Ry = E sin(ωt) with y(0) = k () L, R, E, ω are positive constants. (b) What is the limit of the solution as ω 0? (c) Is

More information

Multilevel Low-Rank Preconditioners Yousef Saad Department of Computer Science and Engineering University of Minnesota. Modelling 2014 June 2,2014

Multilevel Low-Rank Preconditioners Yousef Saad Department of Computer Science and Engineering University of Minnesota. Modelling 2014 June 2,2014 Multilevel Low-Rank Preconditioners Yousef Saad Department of Computer Science and Engineering University of Minnesota Modelling 24 June 2,24 Dedicated to Owe Axelsson at the occasion of his 8th birthday

More information

Numerical Methods for PDEs

Numerical Methods for PDEs Numerical Methods for PDEs Problems 1. Numerical Differentiation. Find the best approximation to the second drivative d 2 f(x)/dx 2 at x = x you can of a function f(x) using (a) the Taylor series approach

More information

The amount of work to construct each new guess from the previous one should be a small multiple of the number of nonzeros in A.

The amount of work to construct each new guess from the previous one should be a small multiple of the number of nonzeros in A. AMSC/CMSC 661 Scientific Computing II Spring 2005 Solution of Sparse Linear Systems Part 2: Iterative methods Dianne P. O Leary c 2005 Solving Sparse Linear Systems: Iterative methods The plan: Iterative

More information

No. 579 November 2017

No. 579 November 2017 No. 579 November 27 Numerical study of the RBF-FD level set based method for partial differential equations on evolving-in-time surfaces A. Sokolov, O. Davydov, S. Turek ISSN: 29-767 Numerical study of

More information

Homework 1 Solutions

Homework 1 Solutions 18-9 Signals and Systems Profs. Byron Yu and Pulkit Grover Fall 18 Homework 1 Solutions Part One 1. (8 points) Consider the DT signal given by the algorithm: x[] = 1 x[1] = x[n] = x[n 1] x[n ] (a) Plot

More information

arxiv: v1 [physics.comp-ph] 29 Sep 2017

arxiv: v1 [physics.comp-ph] 29 Sep 2017 Meshfree Local Radial Basis Function Collocation Method with Image Nodes Seung Ki Baek and Minjae Kim arxiv:179.124v1 [physics.comp-ph] 29 Sep 217 Department of Physics, Pukyong National University, Busan

More information

MASSACHUSETTS INSTITUTE OF TECHNOLOGY DEPARTMENT OF MECHANICAL ENGINEERING CAMBRIDGE, MASSACHUSETTS NUMERICAL FLUID MECHANICS FALL 2011

MASSACHUSETTS INSTITUTE OF TECHNOLOGY DEPARTMENT OF MECHANICAL ENGINEERING CAMBRIDGE, MASSACHUSETTS NUMERICAL FLUID MECHANICS FALL 2011 MASSACHUSETTS INSTITUTE OF TECHNOLOGY DEPARTMENT OF MECHANICAL ENGINEERING CAMBRIDGE, MASSACHUSETTS 02139 2.29 NUMERICAL FLUID MECHANICS FALL 2011 QUIZ 2 The goals of this quiz 2 are to: (i) ask some general

More information

Numerical analysis of heat conduction problems on irregular domains by means of a collocation meshless method

Numerical analysis of heat conduction problems on irregular domains by means of a collocation meshless method Journal of Physics: Conference Series PAPER OPEN ACCESS Numerical analysis of heat conduction problems on irregular domains by means of a collocation meshless method To cite this article: R Zamolo and

More information

An Adaptive Mixed Finite Element Method using the Lagrange Multiplier Technique

An Adaptive Mixed Finite Element Method using the Lagrange Multiplier Technique An Adaptive Mixed Finite Element Method using the Lagrange Multiplier Technique by Michael Gagnon A Project Report Submitted to the Faculty of the WORCESTER POLYTECHNIC INSTITUTE In partial fulfillment

More information

Surprising Computations

Surprising Computations .... Surprising Computations Uri Ascher Department of Computer Science University of British Columbia ascher@cs.ubc.ca www.cs.ubc.ca/ ascher/ Uri Ascher (UBC) Surprising Computations Fall 2012 1 / 67 Motivation.

More information

ORDINARY DIFFERENTIAL EQUATIONS

ORDINARY DIFFERENTIAL EQUATIONS ORDINARY DIFFERENTIAL EQUATIONS GABRIEL NAGY Mathematics Department, Michigan State University, East Lansing, MI, 48824. JANUARY 3, 25 Summary. This is an introduction to ordinary differential equations.

More information