Atmospheric Dynamics with Polyharmonic Spline RBFs

Size: px
Start display at page:

Download "Atmospheric Dynamics with Polyharmonic Spline RBFs"

Transcription

1 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 laboratory managed and operated by National Technology and Engineering Solutions of Sandia, LLC., a wholly owned subsidiary of Honeywell International, Inc., for the U.S. Department of Energy s National Nuclear Security Administration under contract DE-NA SAND C

2 Outline Polyharmonic Spline (PHS) RBFs with Polynomials 1D Example Interpolation and Differentiation Weights Interpolation/Weights in D Weights on the Sphere Semi-Lagrangian Transport Governing Equations Limiter/Fixer Test Cases Results Eulerian Shallow Water Model Governing Equations Test Cases Results Conclusions and Future Work

3 Table of RBFs φ x, x R d, ε R Name (acronym) 1 + ε x Multiquadric (MQ) 1 Inverse Quadratic (IQ) 1 + ε x ε x Inverse Multiquadric (IMQ) e ε x Gaussian (GA) x k+1 x k log x, k N Polyharmonic Spline (PHS) =

4 Some RBFs in 1D Polyharmonic Spline RBFs Infinitely Differentiable RBFs 4

5 Example: Equi-spaced Interpolation in 1D PHS Basis Functions Approximation 5

6 Structure of the Linear System Least Squares Parabola: μ 1 + μ x + μ x 1 x 1 x 1 1 x x 1 x x 1 x 4 x 4 1 x 5 x 5 μ 1 μ μ = f 1 f f f 4 f 5 Polynomial Interpolant: μ 1 + μ x + μ x + μ 4 x + μ 5 x 4 1 x 1 x 1 x 1 4 x 1 1 x x x 4 x 1 x x x 4 x 1 x 4 x 4 x 4 4 x 4 1 x 5 x 5 x 5 4 x 5 μ 1 μ μ μ 4 μ 5 = f 1 f f f 4 f 5 5 PHS Interpolant: λ j x x j + μ1 + μ x + μ x 0 x 1 x x 1 x x 1 x 4 x 1 x 5 1 x 1 x 1 x x 1 0 x x x x 4 x x 5 1 x x x x 1 x x 0 x x 4 x x 5 1 x x x 4 x 1 x 4 x x 4 x 0 x 4 x 5 1 x 4 x 4 x 5 x 1 x 5 x x 5 x x 5 x x 5 x 5 λ 1 λ λ λ 4 λ 5 = f 1 f f f 4 f 5 j= x 1 x x x 4 x x 1 x x x 4 x μ 1 μ μ

7 Properties of Polyharmonic Splines PHS basis includes both RBFs and polynomials RBFs improve performance and allow the use of irregular nodes polynomials give convergence to smooth solutions (no saturation error) The interpolation problem is guaranteed to have a unique solution provided that polynomials are included up to the required degree, and the nodes are unisolvent. For k = 1,,, φ x = x k log x Polynomials up to degree k or higher φ x = x k+1 Polynomials up to degree k or higher Rule of thumb for modest polynomial degrees: Twice as many RBFs as polynomials Condition number of PHS A-matrix is invariant under rotation, translation, and uniform scaling No need to search for optimal shape parameter 7

8 Interpolation in D x = x, y n Given nodes x i, y i i=1 and corresponding function values f n i i=1, find a linear combination of RBF and polynomial basis functions that matches the data exactly. 1. Assume the appropriate form of the underlying approximation: n Φ x, y = λ j φ j x, y + μ k p k x, y, j=1 m k=1 where φ j x, y = φ x x j, y y j.. Require Φ to match the data at each node: Φ x i, y i = λ j φ j x i, y i n j=1 m + μ k p k x i, y i = f i, i = 1,,,, n. k=1. Enforce regularity conditions on the coefficients λ j : n λ j p k x j, y j = 0, k = 1,,,, m. j=1 4. Solve the symmetric linear system for λ j and μ k. 8

9 Differentiation Weights in D Interpolation Problem: A P T P O λ μ = f O, a ij = φ j x i, y i = φ x i x j, y i y j, i, j = 1,,,, n, p ik = p k x i, y i, i = 1,,,, n, k = 1,,,, m. Use LΦ x, y to approximate Lf x, y : LΦ n x, y = λ j Lφ j j=1 m x, y + μ k Lp k k=1 = b c λ μ = b c A P P T O weights 1 f O, b j = Lφ j x, y, j = 1,,,, n, c k = Lp k x, y, k = 1,,,, m. x, y 9

10 Derivative Approximation on the Sphere Given: nodes x, y, z on the sphere and function values f Find: differentiation matrices (DMs) W x, W y, W z to approximate x, Method: Use the fact that f x, y, zǁ is tangent to the sphere at x, y, zǁ For each node, get orthogonal unit vectors e x and e y tangent to the sphere Use D method to get matrices W x and W y that approximate x f f = e x + e f x y y f = f f x 1 = e x 1 + e f x y = e 1 y x 1 + e x y 1 y W x = diag e x 1 W x + diag e y 1 W y W y = diag e x W x + diag e y W y W z = diag e x W x + diag e y W y f and y y, z 10

11 Semi-Lagrangian Transport Governing Equations (velocity u is a known function) ρ t = u ρ ρ u, Dq Dt = t (Eulerian, short time-steps) + u q = 0. (Semi-Lagrangian, long time-steps) Quasi-Monotone Limiter for q (const. along flow trajectories) m k = min l (n) q kl and M k = max l Set q k (n+1) = min qk (n+1), Mk (n) q kl Set q k (n+1) = max qk (n+1), mk Mass Fixer tracermass σ N k=1 ρ k q k V k If tracermass < initialmass, add mass in cells with q k < M k If tracermass > initialmass, subtract mass from cells with q k > m k 11

12 Semi-Lagrangian Transport t n+1 t n 1

13 Pre-Processing Get DMs W x, W y, and W z for the continuity equation Find index of the n nearest neighbors to each node For each node x k = x k, y k, z k, write its n neighbors in terms of two orthogonal unit vectors e x, e y tangent to the sphere at x k, and one unit vector e zƹ normal to the sphere at x k, so that x kl = x kl e x + y kl e y + zƹ kl e z Ƹ, l = 1,,,, n. P k 1 Set C k = A k I n T, where P k O 6 6 O 6 n A k ij = φ x ki x kj, y ki y kj, i, j = 1,,,, n, P k = 1, x k, y k, x k, x k y k, y k. 1

14 Time Stepping 1. Step ρ t = u ρ ρ u from t n to t n+1 using several explicit Eulerian time steps (RK). Step x = u from t n+1 to t n to get departure points (RK4). Find the nearest fixed neighbor to each departure point 4. Use the corresponding pre-calculated cardinal coefficients C k and the newly formed row-vectors b k to get rows of the interpolation matrix W W k = b k C k 5. Update q on fixed nodes using weights W 6. Cycle quasi-monotone limiter and mass-fixer until the tracer mass is nearly equal to the initial tracer mass (diff<1e-1) 7. Repeat 14

15 Hyperviscosity Add a small dissipative term to the continuity equation ρ t = u ρ ρ u + γ max u Δx K 1 Δ K ρ Reduce high-frequency noise while keeping order of convergence intact Achieve stability in time using explicit time-stepping PHS are ideal for hyperviscosity, because applying the Laplace operator to a PHS returns another PHS φ x, y = x + y m/ Δφ x, y = φ x + φ y = m x + y (m )/ Parameter γ R is determined experimentally at low resolution, and remains unchanged as resolution increases 15

16 Transport Test Cases on the Sphere Initial Condition q 0 (ρ 0 = 1 in all cases) Taken from Nair and Lauritzen, 010 (NL010) Gaussian Hills (infinitely differentiable) Cosine Bells (once continuously differentiable) Slotted Cylinders (not continuous) Velocity Field (NL010) Case 1: Translating, vorticity-dominated flow CFL max = Case : Translating, divergence-dominated flow CFL max 5 Spatial Approximations (Minimum Energy (ME) Nodes) max u Δt Δx 8 Number of nodes N = 4 (576), 48 (04), , Interpolation (semi-lagrangian tracer transport) x + p1 + n19 Derivative Approximation (Eulerian continuity equation) x log x + p5 + n4 Time-stepping from t = 0 to t = 5 (one revolution) 16

17 θ Nodes and Initial Conditions for q Gaussian Hills (GH) Cosine Bells (CB) π N = 4 = 576 ME nodes Slotted Cylinders (SC) π λ 0 π 17

18 θ Time Snapshots, Velocity Case π 4 5 π λ 0 π 18

19 θ Time Snapshots, Velocity Case 0 1 π 4 5 π λ 0 π 19

20 GH, Velocity Case 1, Unlimited q q exact log 10 q exact log 10 N 0

21 CB, Velocity Case 1, Unlimited q q exact log 10 q exact log 10 N 1

22 SC, Velocity Case 1, Unlimited q q exact log 10 q exact log 10 N

23 N = θ N = 96. N = GH, Velocity Case 1 Unlimited Limited π π λ 0 π

24 N = θ N = 96. N = CB, Velocity Case 1 Unlimited Limited π π λ 0 π 4

25 N = θ N = 96. N = SC, Velocity Case 1 Unlimited Limited π π λ 0 π 5

26 N = θ N = 96. N = GH, Velocity Case Unlimited Limited π π λ 0 π 6

27 N = θ N = 96. N = CB, Velocity Case Unlimited Limited π π λ 0 π 7

28 N = θ N = 96. N = SC, Velocity Case Unlimited Limited π π λ 0 π 8

29 Advantages of Semi-Lagrangian Transport Large Time steps max u Δt Δx 1 Simple governing equation and solution algorithm Dq Dt = 0 D Dt = t + u q is constant along flow trajectories No spatial derivatives (1) time-step for departure points, () interpolate for new values of q No need for hyperviscosity High frequencies automatically damped by repeated interpolation Numerical solutions remain bounded even if the node set is poorly distributed Simple limiter to reduce oscillations and preserve bounds 9

30 Shallow Water Model Governing Equations: u t = u u f k u g h, h t = u h h u. f = Ω sin θ, where Ω = angular velocity of Earth, θ = latitude k is the unit normal to the sphere g is gravitational acceleration h = h s x, y, z + h x, y, z, t is the depth of the fluid Note: The velocity u is adjusted after every Runge-Kutta stage to remain tangent to the sphere u u u k k 0

31 Nodes Maximum Determinant (MD) Hammersley 1

32 Shallow Water Test Cases Taken from Williamson et al, JCP 199 Steady-state smooth flow h s = 0 Exact solution known Flow over an isolated mountain h s is a cone-shaped mountain centered at λ, θ = π, π 6 Exact solution unavailable Rossby-Haurwitz Wave u 0 and h 0 satisfy the barotropic vorticity equations h s = 0 Exact solution unavailable

33 Parameters for Shallow Water Tests Derivative approximations,, x y z φ x = x log x Polynomials up to degree 5 Stencil size 4 (twice as many RBFs as polynomials) Hyperviscosity Δ φ x = x 7 Polynomials up to degree 5 Stencil size 4 Parameter γ = Time Stepping ( stage, rd order Runge-Kutta) N = 4 N = 48 N = 96 N = 19 Δt (minutes)

34 Error Growth in Time MD Hammersley h h exact log 10 h exact h h exact log 10 h exact t (days) t (days) 4

35 Convergence Verification t = 5 h h exact log 10 h exact log 10 N 5

36 θ Time Snapshots, Isolated Mountain t = 0 t = π t = 6 t = 9 t = 1 t = 15 π π λ π 6

37 N = 19 θ N = 96 N = 48 Flow over Mountain, t = 15 MD Hammersley π π π λ π 7

38 N = 19 θ N = 96 N = 48 Rossby-Haurwitz, t = 14 MD Hammersley π π π λ π 8

39 Strengths of PHS RBF-FD Simple and accurate on the sphere Local and well suited for parallel computations Free from coordinate singularities Discretize directly from Cartesian equations Geometrically flexible Does not require a mesh Static Node Refinement Dynamic Node Refinement Robust Same configuration (basis, stencil-size, hyperviscosity parameter) runs on a wide variety of node-sets and test problems x log x + p5 + n4 for first derivative approximations 9

40 Future Work Transport D test cases on spherical shell (DCMIP test cases) More sophisticated fixer/limiter procedure Reduce parallel communication Shallow water equations Quantitative comparison to other methods Additional tests on the sphere from Williamson et al, JCP 199 Forced nonlinear system with a translating Low Evolution of highly nonlinear wave Nonhydrostatic Dynamical Core for climate/weather D benchmarks in Cartesian geometry with topography Fully D without using a terrain-following coordinate transformation Eulerian dynamics, semi-lagrangian transport with fixer/limiter 40

41 References Natasha Flyer, Gregory A. Barnett, Louis J. Wicker, Enhancing finite differences with radial basis functions: Experiments on the Navier Stokes equations, Journal of Computational Physics, Volume 16, pages 9-6, July 016. Natasha Flyer, Erik Lehto, Sebastien Blaise, Grady B. Wright, Amik St-Cyr, A guide to RBF-generated finite differences for nonlinear transport: Shallow water simulations on a sphere, Journal of Computational Physics, Vol 1, Issue 11, pages , 01. Bengt Fornberg and Natasha Flyer, A Primer on Radial Basis Functions with Applications to the Geosciences, CBMS-NSF, Regional Conference Series in Applied Mathematics (No. 87), September 015. Armin Iske, On the Approximation Order and Numerical Stability of Local Lagrange Interpolation by Polyharmonic Splines, Modern Developments in Multivariate Approximation, International Series of Numerical Mathematics, Vol 145, 00. Peter H. Lauritzen, Christiane Jablonowski, Mark A. Taylor, Ramachandran D. Nair, Numerical Techniques for Global Atmospheric Models, Lecture notes in Computational Science and Engineering, Vol 80, Springer-Verlag Berlin Heidelberg, 011. Ramachandran D. Nair, Peter H. Lauritzen, A class of deformational flow test cases for linear transport problems on the sphere, Journal of Computational Physics, Vol 9, Issue, pages , November 010. David L. Williamson, John B. Drake, James J. Hack, Rüdiger Jakob, Paul N. Swarztrauber, A standard test set for numerical approximations to the shallow water equations in spherical geometry, Journal of Computational Physics, Vol 10, Issue 1, pages 11-4,

Acceleration of Time Integration

Acceleration of Time Integration Acceleration of Time Integration edited version, with extra images removed Rick Archibald, John Drake, Kate Evans, Doug Kothe, Trey White, Pat Worley Research sponsored by the Laboratory Directed Research

More information

COMPARISON OF FINITE DIFFERENCE- AND PSEUDOSPECTRAL METHODS FOR CONVECTIVE FLOW OVER A SPHERE

COMPARISON OF FINITE DIFFERENCE- AND PSEUDOSPECTRAL METHODS FOR CONVECTIVE FLOW OVER A SPHERE COMPARISON OF FINITE DIFFERENCE- AND PSEUDOSPECTRAL METHODS FOR CONVECTIVE FLOW OVER A SPHERE BENGT FORNBERG and DAVID MERRILL Abstract. For modeling convective flows over a sphere or within a spherical

More information

SOLVING HYPERBOLIC PARTIAL DIFFERENTIAL EQUATIONS IN SPHERICAL GEOMETRY WITH RADIAL BASIS FUNCTIONS

SOLVING HYPERBOLIC PARTIAL DIFFERENTIAL EQUATIONS IN SPHERICAL GEOMETRY WITH RADIAL BASIS FUNCTIONS SOLVING HYPERBOLIC PARTIAL DIFFERENTIAL EQUATIONS IN SPHERICAL GEOMETRY WITH RADIAL BASIS FUNCTIONS NATASHA FLYER 1. Introduction Mathematical modeling of space and climate phenomena generally requires

More information

A High Order Conservative Semi-Lagrangian Discontinuous Galerkin Method for Two-Dimensional Transport Simulations

A High Order Conservative Semi-Lagrangian Discontinuous Galerkin Method for Two-Dimensional Transport Simulations Motivation Numerical methods Numerical tests Conclusions A High Order Conservative Semi-Lagrangian Discontinuous Galerkin Method for Two-Dimensional Transport Simulations Xiaofeng Cai Department of Mathematics

More information

Lecture 2: Reconstruction and decomposition of vector fields on the sphere with applications

Lecture 2: Reconstruction and decomposition of vector fields on the sphere with applications 2013 Dolomites Research Week on Approximation : Reconstruction and decomposition of vector fields on the sphere with applications Grady B. Wright Boise State University What's the problem with vector fields

More information

NCAR Global Atmospheric Core Workshop, Boulder, June 2008

NCAR Global Atmospheric Core Workshop, Boulder, June 2008 NCAR Global Atmospheric Core Workshop, Boulder, June 2008 D. Majewski based on Christiane Jablonowski (email: cjablono@umich.edu) University of Michigan Goals of the Test Suite NASA/GFDL Test cases should

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

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

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

A Class of Deformational Flow Test Cases for Linear Transport Problems on the Sphere

A Class of Deformational Flow Test Cases for Linear Transport Problems on the Sphere A Class of Deformational Flow Test Cases for Linear Transport Problems on the Sphere Ramachandran D. Nair,a, Peter H. Lauritzen b a Institute for Mathematics Applied to Geosciences (IMAGe), National Center

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

On simplifying incremental remap -based transport schemes

On simplifying incremental remap -based transport schemes On simplifying incremental remap -based transport schemes Peter H. Lauritzen a,, Christoph Erath b, Rashmi Mittal c a Climate and Global Dynamics Division, National Center for Atmospheric Research, P.O.

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

A high-order fully explicit incremental-remap -based semi-lagrangian shallow-water model

A high-order fully explicit incremental-remap -based semi-lagrangian shallow-water model INTERNATIONAL JOURNAL FOR NUMERICAL METHODS IN FLUIDS Int. J. Numer. Meth. Fluids 0000; 00:1 33 Published online in Wiley InterScience (www.interscience.wiley.com). A high-order fully explicit incremental-remap

More information

New variables in spherical geometry. David G. Dritschel. Mathematical Institute University of St Andrews.

New variables in spherical geometry. David G. Dritschel. Mathematical Institute University of St Andrews. New variables in spherical geometry David G Dritschel Mathematical Institute University of St Andrews http://www-vortexmcsst-andacuk Collaborators: Ali Mohebalhojeh (Tehran St Andrews) Jemma Shipton &

More information

A Nodal High-Order Discontinuous Galerkin Dynamical Core for Climate Simulations

A Nodal High-Order Discontinuous Galerkin Dynamical Core for Climate Simulations A Nodal High-Order Discontinuous Galerkin Dynamical Core for Climate Simulations Institute for Mathematics Applied to the Geosciences (IMAGe) National Center for Atmospheric Research (NCAR) Boulder CO

More information

A guide to RBF-generated finite differences for nonlinear transport: shallow water simulations on a sphere

A guide to RBF-generated finite differences for nonlinear transport: shallow water simulations on a sphere A guide to RBF-generated finite differences for nonlinear transport: shallow water simulations on a sphere Natasha Flyer a,, Erik Lehto b Sébastien Blaise c Grady B. Wright d,2 Amik St-Cyr e,3 a Institute

More information

Transport Schemes on a Sphere Using Radial Basis Functions

Transport Schemes on a Sphere Using Radial Basis Functions Transport Schemes on a Sphere Using Radial Basis Functions Natasha Flyer a,, Grady B. Wright b,1, a National Center for Atmospheric Research, Scientific Computing Division, 1850 Table Mesa Dr., Boulder,

More information

Theoretical and computational aspects of multivariate interpolation with increasingly flat radial basis functions

Theoretical and computational aspects of multivariate interpolation with increasingly flat radial basis functions Theoretical and computational aspects of multivariate interpolation with increasingly flat radial basis functions Elisabeth Larsson Bengt Fornberg June 0, 003 Abstract Multivariate interpolation of smooth

More information

A flux-corrected RBF-FD method for convection dominated problems in domains and on manifolds

A flux-corrected RBF-FD method for convection dominated problems in domains and on manifolds A flux-corrected RBF-FD method for convection dominated problems in domains and on manifolds Andriy Sokolov Dmitri Kuzmin, Oleg Davydov and Stefan Turek Institut für Angewandte Mathematik (LS3) TU Dortmund

More information

Seismic modeling with radial basis function-generated finite differences (RBF-FD)

Seismic modeling with radial basis function-generated finite differences (RBF-FD) Seismic modeling with radial basis function-generated finite differences (BF-FD) (Seismic modeling with BF-FD) Presented as a poster at the 14 SEG Annual Meeting in Denver, Colorado Authors: Bradley Martin

More information

The Shallow Water Equations

The Shallow Water Equations If you have not already done so, you are strongly encouraged to read the companion file on the non-divergent barotropic vorticity equation, before proceeding to this shallow water case. We do not repeat

More information

Computational Astrophysics

Computational Astrophysics Computational Astrophysics Lecture 1: Introduction to numerical methods Lecture 2:The SPH formulation Lecture 3: Construction of SPH smoothing functions Lecture 4: SPH for general dynamic flow Lecture

More information

Newton-Krylov-Schwarz Method for a Spherical Shallow Water Model

Newton-Krylov-Schwarz Method for a Spherical Shallow Water Model Newton-Krylov-Schwarz Method for a Spherical Shallow Water Model Chao Yang 1 and Xiao-Chuan Cai 2 1 Institute of Software, Chinese Academy of Sciences, Beijing 100190, P. R. China, yang@mail.rdcps.ac.cn

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

STABLE CALCULATION OF GAUSSIAN-BASED RBF-FD STENCILS

STABLE CALCULATION OF GAUSSIAN-BASED RBF-FD STENCILS STABLE CALCULATION OF GAUSSIAN-BASED RBF-FD STENCILS BENGT FORNBERG, ERIK LEHTO, AND COLLIN POWELL Abstract. Traditional finite difference (FD) methods are designed to be exact for low degree polynomials.

More information

Validation Metrics. Kathryn Maupin. Laura Swiler. June 28, 2017

Validation Metrics. Kathryn Maupin. Laura Swiler. June 28, 2017 Validation Metrics Kathryn Maupin Laura Swiler June 28, 2017 Sandia National Laboratories is a multimission laboratory managed and operated by National Technology and Engineering Solutions of Sandia LLC,

More information

The Hamiltonian Particle-Mesh Method for the Spherical Shallow Water Equations

The Hamiltonian Particle-Mesh Method for the Spherical Shallow Water Equations The Hamiltonian Particle-Mesh Method for the Spherical Shallow Water Equations Jason Fran CWI P.O. Box 94079, 1090 GB Amsterdam, The Netherlands Sebastian Reich Department of Mathematics, Imperial College

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

A Hamiltonian Numerical Scheme for Large Scale Geophysical Fluid Systems

A Hamiltonian Numerical Scheme for Large Scale Geophysical Fluid Systems A Hamiltonian Numerical Scheme for Large Scale Geophysical Fluid Systems Bob Peeters Joint work with Onno Bokhove & Jason Frank TW, University of Twente, Enschede CWI, Amsterdam PhD-TW colloquium, 9th

More information

Lecture IV: Time Discretization

Lecture IV: Time Discretization Lecture IV: Time Discretization Motivation Kinematics: continuous motion in continuous time Computer simulation: Discrete time steps t Discrete Space (mesh particles) Updating Position Force induces acceleration.

More information

GEOMETRICAL TOOLS FOR PDES ON A SURFACE WITH ROTATING SHALLOW WATER EQUATIONS ON A SPHERE

GEOMETRICAL TOOLS FOR PDES ON A SURFACE WITH ROTATING SHALLOW WATER EQUATIONS ON A SPHERE GEOETRICAL TOOLS FOR PDES ON A SURFACE WITH ROTATING SHALLOW WATER EQUATIONS ON A SPHERE BIN CHENG Abstract. This is an excerpt from my paper with A. ahalov [1]. PDE theories with Riemannian geometry are

More information

Level Set and Phase Field Methods: Application to Moving Interfaces and Two-Phase Fluid Flows

Level Set and Phase Field Methods: Application to Moving Interfaces and Two-Phase Fluid Flows Level Set and Phase Field Methods: Application to Moving Interfaces and Two-Phase Fluid Flows Abstract Maged Ismail Claremont Graduate University Level Set and Phase Field methods are well-known interface-capturing

More information

Divergence Formulation of Source Term

Divergence Formulation of Source Term Preprint accepted for publication in Journal of Computational Physics, 2012 http://dx.doi.org/10.1016/j.jcp.2012.05.032 Divergence Formulation of Source Term Hiroaki Nishikawa National Institute of Aerospace,

More information

Overview of the Numerics of the ECMWF. Atmospheric Forecast Model

Overview of the Numerics of the ECMWF. Atmospheric Forecast Model Overview of the Numerics of the Atmospheric Forecast Model M. Hortal Seminar 6 Sept 2004 Slide 1 Characteristics of the model Hydrostatic shallow-atmosphere approimation Pressure-based hybrid vertical

More information

MATH 590: Meshfree Methods

MATH 590: Meshfree Methods MATH 590: Meshfree Methods Chapter 5: Completely Monotone and Multiply Monotone Functions Greg Fasshauer Department of Applied Mathematics Illinois Institute of Technology Fall 2010 fasshauer@iit.edu MATH

More information

MATH 590: Meshfree Methods

MATH 590: Meshfree Methods MATH 590: Meshfree Methods Chapter 6: Scattered Data Interpolation with Polynomial Precision Greg Fasshauer Department of Applied Mathematics Illinois Institute of Technology Fall 2010 fasshauer@iit.edu

More information

A Proposed Test Suite for Atmospheric Model Dynamical Cores

A Proposed Test Suite for Atmospheric Model Dynamical Cores A Proposed Test Suite for Atmospheric Model Dynamical Cores Christiane Jablonowski (cjablono@umich.edu) University of Michigan, Ann Arbor PDEs on the Sphere Workshop Monterey, CA, June/26-29/2006 Motivation

More information

Lecture V: The game-engine loop & Time Integration

Lecture V: The game-engine loop & Time Integration Lecture V: The game-engine loop & Time Integration The Basic Game-Engine Loop Previous state: " #, %(#) ( #, )(#) Forces -(#) Integrate velocities and positions Resolve Interpenetrations Per-body change

More information

Pressure corrected SPH for fluid animation

Pressure corrected SPH for fluid animation Pressure corrected SPH for fluid animation Kai Bao, Hui Zhang, Lili Zheng and Enhua Wu Analyzed by Po-Ram Kim 2 March 2010 Abstract We present pressure scheme for the SPH for fluid animation In conventional

More information

A New Trust Region Algorithm Using Radial Basis Function Models

A New Trust Region Algorithm Using Radial Basis Function Models A New Trust Region Algorithm Using Radial Basis Function Models Seppo Pulkkinen University of Turku Department of Mathematics July 14, 2010 Outline 1 Introduction 2 Background Taylor series approximations

More information

Integration, differentiation, and root finding. Phys 420/580 Lecture 7

Integration, differentiation, and root finding. Phys 420/580 Lecture 7 Integration, differentiation, and root finding Phys 420/580 Lecture 7 Numerical integration Compute an approximation to the definite integral I = b Find area under the curve in the interval Trapezoid Rule:

More information

Semi-implicit methods, nonlinear balance, and regularized equations

Semi-implicit methods, nonlinear balance, and regularized equations ATMOSPHERIC SCIENCE LETTERS Atmos. Sci. Let. 8: 1 6 (7 Published online 9 January 7 in Wiley InterScience (www.interscience.wiley.com.1 Semi-implicit methods, nonlinear balance, and regularized equations

More information

06. Lagrangian Mechanics II

06. Lagrangian Mechanics II University of Rhode Island DigitalCommons@URI Classical Dynamics Physics Course Materials 2015 06. Lagrangian Mechanics II Gerhard Müller University of Rhode Island, gmuller@uri.edu Creative Commons License

More information

Adaptive C1 Macroelements for Fourth Order and Divergence-Free Problems

Adaptive C1 Macroelements for Fourth Order and Divergence-Free Problems Adaptive C1 Macroelements for Fourth Order and Divergence-Free Problems Roy Stogner Computational Fluid Dynamics Lab Institute for Computational Engineering and Sciences University of Texas at Austin March

More information

A Discontinuous Galerkin Global Shallow Water Model

A Discontinuous Galerkin Global Shallow Water Model 876 M O N T H L Y W E A T H E R R E V I E W VOLUME 133 A Discontinuous Galerkin Global Shallow Water Model RAMACHANDRAN D. NAIR, STEPHEN J. THOMAS, AND RICHARD D. LOFT Scientific Computing Division, National

More information

MATH Final Review

MATH Final Review MATH 1592 - Final Review 1 Chapter 7 1.1 Main Topics 1. Integration techniques: Fitting integrands to basic rules on page 485. Integration by parts, Theorem 7.1 on page 488. Guidelines for trigonometric

More information

Consistency Estimates for gfd Methods and Selection of Sets of Influence

Consistency Estimates for gfd Methods and Selection of Sets of Influence Consistency Estimates for gfd Methods and Selection of Sets of Influence Oleg Davydov University of Giessen, Germany Localized Kernel-Based Meshless Methods for PDEs ICERM / Brown University 7 11 August

More information

A simple model of topographic Rossby waves in the ocean

A simple model of topographic Rossby waves in the ocean A simple model of topographic Rossby waves in the ocean V.Teeluck, S.D.Griffiths, C.A.Jones University of Leeds April 18, 2013 V.Teeluck (University of Leeds) Topographic Rossby waves (TRW) in the ocean

More information

Experience with DNS of particulate flow using a variant of the immersed boundary method

Experience with DNS of particulate flow using a variant of the immersed boundary method Experience with DNS of particulate flow using a variant of the immersed boundary method Markus Uhlmann Numerical Simulation and Modeling Unit CIEMAT Madrid, Spain ECCOMAS CFD 2006 Motivation wide range

More information

Transport Schemes on a Sphere Using Radial Basis Functions

Transport Schemes on a Sphere Using Radial Basis Functions Transport Schemes on a Sphere Using Radial Basis Functions Natasha Flyer a,,1, Grady B. Wright b,2, a National Center for Atmospheric Research, Institute for Mathematics Applied to the Geosciences, 1850

More information

MATH 590: Meshfree Methods

MATH 590: Meshfree Methods MATH 590: Meshfree Methods Chapter 37: RBF Hermite Interpolation in MATLAB Greg Fasshauer Department of Applied Mathematics Illinois Institute of Technology Fall 2010 fasshauer@iit.edu MATH 590 Chapter

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

Photos placed in horizontal position with even amount of white space between photos and header

Photos placed in horizontal position with even amount of white space between photos and header Photos placed in horizontal position with even amount of white space between photos and header XPCA: Copula-based Decompositions for Ordinal Data Clifford Anderson-Bergman, Kina Kincher-Winoto and Tamara

More information

Control Volume. Dynamics and Kinematics. Basic Conservation Laws. Lecture 1: Introduction and Review 1/24/2017

Control Volume. Dynamics and Kinematics. Basic Conservation Laws. Lecture 1: Introduction and Review 1/24/2017 Lecture 1: Introduction and Review Dynamics and Kinematics Kinematics: The term kinematics means motion. Kinematics is the study of motion without regard for the cause. Dynamics: On the other hand, dynamics

More information

Lecture 1: Introduction and Review

Lecture 1: Introduction and Review Lecture 1: Introduction and Review Review of fundamental mathematical tools Fundamental and apparent forces Dynamics and Kinematics Kinematics: The term kinematics means motion. Kinematics is the study

More information

High-Order Finite-Volume Methods! Phillip Colella! Computational Research Division! Lawrence Berkeley National Laboratory!

High-Order Finite-Volume Methods! Phillip Colella! Computational Research Division! Lawrence Berkeley National Laboratory! High-Order Finite-Volume Methods! Phillip Colella! Computational Research Division! Lawrence Berkeley National Laboratory! Why Higher Order?! Locally-refined grids, mapped-multiblock grids smooth except

More information

1/3/2011. This course discusses the physical laws that govern atmosphere/ocean motions.

1/3/2011. This course discusses the physical laws that govern atmosphere/ocean motions. Lecture 1: Introduction and Review Dynamics and Kinematics Kinematics: The term kinematics means motion. Kinematics is the study of motion without regard for the cause. Dynamics: On the other hand, dynamics

More information

Large-scale atmospheric circulation, semi-geostrophic motion and Lagrangian particle methods

Large-scale atmospheric circulation, semi-geostrophic motion and Lagrangian particle methods Large-scale atmospheric circulation, semi-geostrophic motion and Lagrangian particle methods Colin Cotter (Imperial College London) & Sebastian Reich (Universität Potsdam) Outline 1. Hydrostatic and semi-geostrophic

More information

F11AE1 1. C = ρν r r. r u z r

F11AE1 1. C = ρν r r. r u z r F11AE1 1 Question 1 20 Marks) Consider an infinite horizontal pipe with circular cross-section of radius a, whose centre line is aligned along the z-axis; see Figure 1. Assume no-slip boundary conditions

More information

A recovery-assisted DG code for the compressible Navier-Stokes equations

A recovery-assisted DG code for the compressible Navier-Stokes equations A recovery-assisted DG code for the compressible Navier-Stokes equations January 6 th, 217 5 th International Workshop on High-Order CFD Methods Kissimmee, Florida Philip E. Johnson & Eric Johnsen Scientific

More information

Game Physics. Game and Media Technology Master Program - Utrecht University. Dr. Nicolas Pronost

Game Physics. Game and Media Technology Master Program - Utrecht University. Dr. Nicolas Pronost Game and Media Technology Master Program - Utrecht University Dr. Nicolas Pronost Soft body physics Soft bodies In reality, objects are not purely rigid for some it is a good approximation but if you hit

More information

A spectral finite volume transport scheme on the cubed-sphere

A spectral finite volume transport scheme on the cubed-sphere Applied Numerical Mathematics 57 (2007) 1021 1032 www.elsevier.com/locate/apnum A spectral finite volume transport scheme on the cubed-sphere Vani Cheruvu a,, Ramachandran D. Nair b, Henry M. Tufo a,b

More information

Math background. Physics. Simulation. Related phenomena. Frontiers in graphics. Rigid fluids

Math background. Physics. Simulation. Related phenomena. Frontiers in graphics. Rigid fluids Fluid dynamics Math background Physics Simulation Related phenomena Frontiers in graphics Rigid fluids Fields Domain Ω R2 Scalar field f :Ω R Vector field f : Ω R2 Types of derivatives Derivatives measure

More information

Fluid Dynamics Exercises and questions for the course

Fluid Dynamics Exercises and questions for the course Fluid Dynamics Exercises and questions for the course January 15, 2014 A two dimensional flow field characterised by the following velocity components in polar coordinates is called a free vortex: u r

More information

CAM-SE: Lecture I. Peter Hjort Lauritzen

CAM-SE: Lecture I. Peter Hjort Lauritzen CAM-SE: Lecture I Peter Hjort Lauritzen Atmospheric Modeling and Predictability Section Climate and Global Dynamics Laboratory National Center for Atmospheric Research 2nd WCRP Summer School on Climate

More information

GFD 2012 Lecture 1: Dynamics of Coherent Structures and their Impact on Transport and Predictability

GFD 2012 Lecture 1: Dynamics of Coherent Structures and their Impact on Transport and Predictability GFD 2012 Lecture 1: Dynamics of Coherent Structures and their Impact on Transport and Predictability Jeffrey B. Weiss; notes by Duncan Hewitt and Pedram Hassanzadeh June 18, 2012 1 Introduction 1.1 What

More information

V (r,t) = i ˆ u( x, y,z,t) + ˆ j v( x, y,z,t) + k ˆ w( x, y, z,t)

V (r,t) = i ˆ u( x, y,z,t) + ˆ j v( x, y,z,t) + k ˆ w( x, y, z,t) IV. DIFFERENTIAL RELATIONS FOR A FLUID PARTICLE This chapter presents the development and application of the basic differential equations of fluid motion. Simplifications in the general equations and common

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

CELESTIAL MECHANICS. Part I. Mathematical Preambles

CELESTIAL MECHANICS. Part I. Mathematical Preambles Chapter 1. Numerical Methods CELESTIAL MECHANICS Part I. Mathematical Preambles 1.1 Introduction 1.2 Numerical Integration 1.3 Quadratic Equations 1.4 The Solution of f(x) = 0 1.5 The Solution of Polynomial

More information

Multivariate Interpolation with Increasingly Flat Radial Basis Functions of Finite Smoothness

Multivariate Interpolation with Increasingly Flat Radial Basis Functions of Finite Smoothness Multivariate Interpolation with Increasingly Flat Radial Basis Functions of Finite Smoothness Guohui Song John Riddle Gregory E. Fasshauer Fred J. Hickernell Abstract In this paper, we consider multivariate

More information

Stable computations with flat radial basis functions using vector-valued rational approximations

Stable computations with flat radial basis functions using vector-valued rational approximations Stable computations with flat radial basis functions using vector-valued rational approximations Grady B. Wright a,, Bengt Fornberg b a Department of Mathematics, Boise State University, Boise, ID 83725-1555,

More information

Chapter 4. Nonlinear Hyperbolic Problems

Chapter 4. Nonlinear Hyperbolic Problems Chapter 4. Nonlinear Hyperbolic Problems 4.1. Introduction Reading: Durran sections 3.5-3.6. Mesinger and Arakawa (1976) Chapter 3 sections 6-7. Supplementary reading: Tannehill et al sections 4.4 and

More information

arxiv: v1 [math.na] 17 Oct 2016

arxiv: v1 [math.na] 17 Oct 2016 Stable computations with flat radial basis functions using vector-valued rational approximations Grady B. Wright a,, Bengt Fornberg b a Department of Mathematics, Boise State University, Boise, ID 83725-1555,

More information

Part IB Numerical Analysis

Part IB Numerical Analysis Part IB Numerical Analysis Definitions Based on lectures by G. Moore Notes taken by Dexter Chua Lent 206 These notes are not endorsed by the lecturers, and I have modified them (often significantly) after

More information

MATH 590: Meshfree Methods

MATH 590: Meshfree Methods MATH 590: Meshfree Methods Chapter 2: Radial Basis Function Interpolation in MATLAB Greg Fasshauer Department of Applied Mathematics Illinois Institute of Technology Fall 2010 fasshauer@iit.edu MATH 590

More information

A semi-implicit non-hydrostatic covariant dynamical kernel using spectral representation in the horizontal and a height based vertical coordinate

A semi-implicit non-hydrostatic covariant dynamical kernel using spectral representation in the horizontal and a height based vertical coordinate A semi-implicit non-hydrostatic covariant dynamical kernel using spectral representation in the horizontal and a height based vertical coordinate Juan Simarro and Mariano Hortal AEMET Agencia Estatal de

More information

Development of Yin-Yang Grid Global Model Using a New Dynamical Core ASUCA.

Development of Yin-Yang Grid Global Model Using a New Dynamical Core ASUCA. Development of Yin-Yang Grid Global Model Using a New Dynamical Core ASUCA. M. Sakamoto, J. Ishida, K. Kawano, K. Matsubayashi, K. Aranami, T. Hara, H. Kusabiraki, C. Muroi, Y. Kitamura Japan Meteorological

More information

Physics 106a, Caltech 4 December, Lecture 18: Examples on Rigid Body Dynamics. Rotating rectangle. Heavy symmetric top

Physics 106a, Caltech 4 December, Lecture 18: Examples on Rigid Body Dynamics. Rotating rectangle. Heavy symmetric top Physics 106a, Caltech 4 December, 2018 Lecture 18: Examples on Rigid Body Dynamics I go through a number of examples illustrating the methods of solving rigid body dynamics. In most cases, the problem

More information

Reduced-dimension Models in Nonlinear Finite Element Dynamics of Continuous Media

Reduced-dimension Models in Nonlinear Finite Element Dynamics of Continuous Media Reduced-dimension Models in Nonlinear Finite Element Dynamics of Continuous Media Petr Krysl, Sanjay Lall, and Jerrold E. Marsden, California Institute of Technology, Pasadena, CA 91125. pkrysl@cs.caltech.edu,

More information

Scientific Computing: An Introductory Survey

Scientific Computing: An Introductory Survey Scientific Computing: An Introductory Survey Chapter 7 Interpolation Prof. Michael T. Heath Department of Computer Science University of Illinois at Urbana-Champaign Copyright c 2002. Reproduction permitted

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

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

Soft Bodies. Good approximation for hard ones. approximation breaks when objects break, or deform. Generalization: soft (deformable) bodies

Soft Bodies. Good approximation for hard ones. approximation breaks when objects break, or deform. Generalization: soft (deformable) bodies Soft-Body Physics Soft Bodies Realistic objects are not purely rigid. Good approximation for hard ones. approximation breaks when objects break, or deform. Generalization: soft (deformable) bodies Deformed

More information

CHAPTER 4. Basics of Fluid Dynamics

CHAPTER 4. Basics of Fluid Dynamics CHAPTER 4 Basics of Fluid Dynamics What is a fluid? A fluid is a substance that can flow, has no fixed shape, and offers little resistance to an external stress In a fluid the constituent particles (atoms,

More information

Lagrangian Analysis of 2D and 3D Ocean Flows from Eulerian Velocity Data

Lagrangian Analysis of 2D and 3D Ocean Flows from Eulerian Velocity Data Flows from Second-year Ph.D. student, Applied Math and Scientific Computing Project Advisor: Kayo Ide Department of Atmospheric and Oceanic Science Center for Scientific Computation and Mathematical Modeling

More information

eff (r) which contains the influence of angular momentum. On the left is

eff (r) which contains the influence of angular momentum. On the left is 1 Fig. 13.1. The radial eigenfunctions R nl (r) of bound states in a square-well potential for three angular-momentum values, l = 0, 1, 2, are shown as continuous lines in the left column. The form V (r)

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 1 2 3 4 5 6 7 8 9 10 11 12 13 14 15 16 17 18 19 20 A RADIAL BASIS FUNCTION (RBF) COMPACT FINITE DIFFERENCE (FD) SCHEME FOR REACTION-DIFFUSION EQUATIONS ON SURFACES ERIK LEHTO, VARUN SHANKAR, AND GRADY

More information

Toward Approximate Moving Least Squares Approximation with Irregularly Spaced Centers

Toward Approximate Moving Least Squares Approximation with Irregularly Spaced Centers Toward Approximate Moving Least Squares Approximation with Irregularly Spaced Centers Gregory E. Fasshauer Department of Applied Mathematics, Illinois Institute of Technology, Chicago, IL 6066, U.S.A.

More information

INTERNAL GRAVITY WAVES

INTERNAL GRAVITY WAVES INTERNAL GRAVITY WAVES B. R. Sutherland Departments of Physics and of Earth&Atmospheric Sciences University of Alberta Contents Preface List of Tables vii xi 1 Stratified Fluids and Waves 1 1.1 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

Kernel B Splines and Interpolation

Kernel B Splines and Interpolation Kernel B Splines and Interpolation M. Bozzini, L. Lenarduzzi and R. Schaback February 6, 5 Abstract This paper applies divided differences to conditionally positive definite kernels in order to generate

More information

MATH 590: Meshfree Methods

MATH 590: Meshfree Methods MATH 590: Meshfree Methods Chapter 40: Symmetric RBF Collocation in MATLAB Greg Fasshauer Department of Applied Mathematics Illinois Institute of Technology Fall 2010 fasshauer@iit.edu MATH 590 Chapter

More information

Structural Dynamics Lecture 4. Outline of Lecture 4. Multi-Degree-of-Freedom Systems. Formulation of Equations of Motions. Undamped Eigenvibrations.

Structural Dynamics Lecture 4. Outline of Lecture 4. Multi-Degree-of-Freedom Systems. Formulation of Equations of Motions. Undamped Eigenvibrations. Outline of Multi-Degree-of-Freedom Systems Formulation of Equations of Motions. Newton s 2 nd Law Applied to Free Masses. D Alembert s Principle. Basic Equations of Motion for Forced Vibrations of Linear

More information

Radial Basis Functions generated Finite Differences (RBF-FD) for Solving High-Dimensional PDEs in Finance

Radial Basis Functions generated Finite Differences (RBF-FD) for Solving High-Dimensional PDEs in Finance 1 / 27 Radial Basis Functions generated Finite Differences (RBF-FD) for Solving High-Dimensional PDEs in Finance S. Milovanović, L. von Sydow Uppsala University Department of Information Technology Division

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

GAME PHYSICS SECOND EDITION. дяййтаййг 1 *

GAME PHYSICS SECOND EDITION. дяййтаййг 1 * GAME PHYSICS SECOND EDITION DAVID H. EBERLY дяййтаййг 1 * К AMSTERDAM BOSTON HEIDELBERG LONDON NEW YORK OXFORD PARIS SAN DIEGO SAN FRANCISCO SINGAPORE SYDNEY TOKYO MORGAN ELSEVIER Morgan Kaufmann Publishers

More information

Can problems in the geosciences inspire fundamental research in the mathematical and statistical sciences?

Can problems in the geosciences inspire fundamental research in the mathematical and statistical sciences? Can problems in the geosciences inspire fundamental research in the mathematical and statistical sciences? Grady B. Wright Department of Mathematics Center for the Geophysical Investigation of the Shallow

More information

d v 2 v = d v d t i n where "in" and "rot" denote the inertial (absolute) and rotating frames. Equation of motion F =

d v 2 v = d v d t i n where in and rot denote the inertial (absolute) and rotating frames. Equation of motion F = Governing equations of fluid dynamics under the influence of Earth rotation (Navier-Stokes Equations in rotating frame) Recap: From kinematic consideration, d v i n d t i n = d v rot d t r o t 2 v rot

More information