The spectral transform method

Size: px
Start display at page:

Download "The spectral transform method"

Transcription

1 The spectral transform method by Nils Wedi European Centre for Medium-Range Weather Forecasts Advanced Numerical Methods for Earth-System Modelling Slide 1

2 Advanced Numerical Methods for Earth-System Modelling Slide 2

3 The Integrated Forecasting System (IFS) technology applied at for the last 30 years A spectral transform, semi-lagrangian, semi-implicit (compressible) (non-)hydrostatic model Advanced Numerical Methods for Earth-System Modelling Slide 3

4 Schematic description of the spectral transform method in the IFS model FFT Fourier space Grid-point space -semi-lagrangian advection -physical parametrizations -products of terms No grid-staggering of prognostic variables Inverse FFT Fourier space LT Spectral space -horizontal gradients -semi-implicit calculations -horizontal diffusion Inverse LT FFT: Fast Fourier Transform, LT: Legendre Transform Advanced Numerical Methods for Earth-System Modelling Slide 4

5 Several transpositions within the spectral transforms need to communicate, e.g. using MPI alltoallv Advanced Numerical Methods for Earth-System Modelling Slide 5

6 Direct spectral transform (Forward) Fourier transform: Legendre transform: FFT (fast Fourier transform) using N F 2N+1 points (linear grid) (3N+1 if quadratic grid) Direct Legendre transform by Gaussian quadrature using N L (2N+1)/2 Gaussian latitudes (linear grid) ((3N+1)/2 if quadratic grid) (normalized) associated Legendre polynomials Advanced Numerical Methods for Earth-System Modelling Slide 6

7 Inverse spectral transform (Backward) Inverse Legendre transform N m m (,,, t) (,) t Y (, ) N m N n m Spherical harmonics n n Triangular truncation (isotropic) Triangular truncation: n N m = -N m = N m Advanced Numerical Methods for Earth-System Modelling Slide 7

8 A useful property of spherical harmonics total wavenumber 2 n( n 1 m ) n 2 a m n Earth radius Advanced Numerical Methods for Earth-System Modelling Slide 8

9 Fast Multipole Method (FMM) and spectral filtering (Jakob-Chien and Alpert, 1997; Tygert 2008) For all j=1,..,j FMM: We can do above sum for all points j in O(J+N) operations instead of O(J*N)! Example: From Christoffel-Darboux formula for associated Legendre polynomials We can do a direct and inverse Legendre transform for a single Fourier mode as: Advanced Numerical Methods for Earth-System Modelling Slide 9

10 The Gaussian grid About 30% reduction in number of points Full grid Reduced grid Reduction in the number of Fourier points at high latitudes is possible because the associated Legendre polynomials are very small near the poles for large m. Note: number of points nearly equivalent to quasi-uniform icosahedral grid cells of the ICON model. Advanced Numerical Methods for Earth-System Modelling Slide 10

11 Spectral vs. physical space 2N+1 gridpoints to N waves : linear grid 3N+1 gridpoints to N waves : quadratic grid 4N+1 gridpoints to N waves : cubic grid ~ 1-2 Δ ~ 2-3 Δ ~ 3-4 Δ Spatial filter range Effective resolution of NWP models today : 6-8 Δ (Abdalla et al, 2013) Advanced Numerical Methods for Earth-System Modelling Slide 11

12 Aliasing Aliasing of quadratic terms on the linear grid (2N+1 gridpoints per N waves), where the product of two variables transformed to spectral space cannot be accurately represented with the available number of waves (as quadratic terms would need a 3N+1 ratio). Absent outside the tropics in E-W direction due to the design of the reduced grid (obeying a 3N+1 ratio) but present throughout (and all resolutions) in N-S direction. De-aliasing in IFS: By subtracting the difference between a specially filtered and the unfiltered pressure gradient term at every time-step the stationary noise patterns can be removed at a cost of approx. 5% at T1279 (2 extra transforms). Advanced Numerical Methods for Earth-System Modelling Slide 12

13 De-aliasing E-W 500hPa adiabatic zonal wind tendencies (T159) Advanced Numerical Methods for Earth-System Modelling Slide 13

14 De-aliasing Advanced Numerical Methods for Earth-System Modelling Slide 14

15 De-aliasing N-S 500hPa adiabatic meridional wind tendencies (T159) Advanced Numerical Methods for Earth-System Modelling Slide 15

16 De-aliasing Advanced Numerical Methods for Earth-System Modelling Slide 16

17 Kinetic Energy Spectra 100 hpa Advanced Numerical Methods for Earth-System Modelling Slide 17

18 Kinetic Energy Spectra 100 hpa Advanced Numerical Methods for Earth-System Modelling Slide 18

19 A fast Legendre transform (FLT) (O Neil, Woolfe, Rokhlin, 2009; Tygert 2008, 2010) The computational complexity of the ordinary spectral transform is O(N^3) (where N is the truncation number of the series expansion in spherical harmonics) and it was therefore believed to be not computationally competitive with other methods at very high resolution The FLT is found to be O(N^2 log N^3) for horizontal resolutions up to T7999 (Wedi et al, 2013) Advanced Numerical Methods for Earth-System Modelling Slide 19

20 Number of floating point operations for direct or inverse spectral transforms of a single field, scaled by N 2 log 3 N dgemm FLT Advanced Numerical Methods for Earth-System Modelling Slide 20

21 Matrix-matrix multiply for each zonal wavenumber m Gaussian latitude Field, vertical level apply butterfly compression, this step is precomputed only once! Advanced Numerical Methods for Earth-System Modelling Slide 21 total wavenumber zonal wavenumber

22 Butterfly algorithm: pre-compute S C rxs rxk A kxs With each level l, double the columns and half the rows Advanced Numerical Methods for Earth-System Modelling Slide 22

23 Advanced Numerical Methods for Earth-System Modelling Slide 23

24 Advanced Numerical Methods for Earth-System Modelling Slide 24

25 Butterfly algorithm: apply f S Advanced Numerical Methods for Earth-System Modelling Slide 25

26 Interpolative Decomposition (ID) The compression uses the interpolative decomposition (ID) described in Cheng et al (2005). The r x s matrix S may be compressed such that S rxs C rxk A kxs With an r x k matrix C constituting a subset of the columns of S and the k x s matrix A containing a k x k identity as a submatrix. k is the ε-rank of the matrix S (see also e.g. Martinsson and Rokhlin, 2007). Advanced Numerical Methods for Earth-System Modelling Slide 26

27 T1279 FLT using different ID epsilons for INV (1.e-3) + DIR (1.e-7) Advanced Numerical Methods for Earth-System Modelling Slide 27

28 The FLT in a nutshell O(N 2 log 3 N) Speed-up the sums of products between associated Legendre polynomials at all Gaussian latitudes and the corresponding spectral coefficients of a field (e.g. temperature on given level) The essence of the FLT: Exploit similarities of associated Legendre polynomials at all (Gaussian) latitudes but different total wave-number Pre-compute (once, 0.1% of the total cost of a 10 day forecast) a compressed (approximate) representation of the matrices (for each m) involved Apply the compressed (reduced) representation at every time-step of the simulation. Advanced Numerical Methods for Earth-System Modelling Slide 28

29 Average wall-clock time compute cost of 10 7 spectral transforms scaled by N 2 log 3 N dgemm FLT Advanced Numerical Methods for Earth-System Modelling Slide 29

30 The quadratic or cubic grid (Wedi, 2014) Adjustment of formal accuracy/relative resolution in spectral and physical space. All nonlinear rhs forcings, advection, moist quantities, physical forcings and surface processes are computed on the higher resolution grid. All horizontal derivatives (T,vor/div, u/v,ln p) and the spectral computations are filtered to the cubic truncation wavenumber. Advanced Numerical Methods for Earth-System Modelling Slide 30

31 The computational cost distribution with full radiation and high-res wave model Advanced Numerical Methods for Earth-System Modelling Slide 31

32 10000 dgemm FLT 1000 Average total wall-clock time computational cost (ms) per transform as obtained from actual NWP simulations Advanced Numerical Methods for Earth-System Modelling Slide 32

33 10 km IFS model scaling on TITAN (CRESTA project) NO GPU! Advanced Numerical Methods for Earth-System Modelling Slide 33

34 5 km IFS model scaling on TITAN (CRESTA project) NO GPU! Advanced Numerical Methods for Earth-System Modelling Slide 34

35 ? The energy cost of computing bites us! Advanced Numerical Methods for Earth-System Modelling Slide 35

36 Additional slides Advanced Numerical Methods for Earth-System Modelling Slide 36

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

A Fast Spherical Filter with Uniform Resolution

A Fast Spherical Filter with Uniform Resolution JOURNAL OF COMPUTATIONAL PHYSICS 136, 580 584 (1997) ARTICLE NO. CP975782 A Fast Spherical Filter with Uniform Resolution Rüdiger Jakob-Chien*, and Bradley K. Alpert *Department of Computer Science & Engineering,

More information

Spectral transforms. Contents. ARPEGE-Climat Version 5.1. September Introduction 2

Spectral transforms. Contents. ARPEGE-Climat Version 5.1. September Introduction 2 Spectral transforms ARPEGE-Climat Version 5.1 September 2008 Contents 1 Introduction 2 2 Spectral representation 2 2.1 Spherical harmonics....................... 2 2.2 Collocation grid.........................

More information

Improving ECMWF s IFS model by Nils Wedi

Improving ECMWF s IFS model by Nils Wedi Improving ECMWF s IFS model by Nils Wedi wedi@ecmwf.int Anna Agusti-Panareda, Gianpaolo Balsamo, Peter Bauer, Peter Bechtold, Willem Deconinck, Mikhail Diamantakis, Mats Hamrud, Christian Kuehnlein, Martin

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

( )e ikx. ( ) = ˆq k

( )e ikx. ( ) = ˆq k ! Revised December 15, 2015 6:57 PM! 1 Chapter 13: Spectral Methods Copyright 2015, David A. Randall Introduction Assume that q( x,t) is real and integrable. If the domain is periodic, with period L, we

More information

A Global Atmospheric Model. Joe Tribbia NCAR Turbulence Summer School July 2008

A Global Atmospheric Model. Joe Tribbia NCAR Turbulence Summer School July 2008 A Global Atmospheric Model Joe Tribbia NCAR Turbulence Summer School July 2008 Outline Broad overview of what is in a global climate/weather model of the atmosphere Spectral dynamical core Some results-climate

More information

Representation of inhomogeneous, non-separable covariances by sparse wavelet-transformed matrices

Representation of inhomogeneous, non-separable covariances by sparse wavelet-transformed matrices Representation of inhomogeneous, non-separable covariances by sparse wavelet-transformed matrices Andreas Rhodin, Harald Anlauf German Weather Service (DWD) Workshop on Flow-dependent aspects of data assimilation,

More information

Recurrence Relations and Fast Algorithms

Recurrence Relations and Fast Algorithms Recurrence Relations and Fast Algorithms Mark Tygert Research Report YALEU/DCS/RR-343 December 29, 2005 Abstract We construct fast algorithms for decomposing into and reconstructing from linear combinations

More information

Current Limited Area Applications

Current Limited Area Applications Current Limited Area Applications Nils Gustafsson SMHI Norrköping, Sweden nils.gustafsson@smhi.se Outline of talk (contributions from many HIRLAM staff members) Specific problems of Limited Area Model

More information

Latest thoughts on stochastic kinetic energy backscatter - good and bad

Latest thoughts on stochastic kinetic energy backscatter - good and bad Latest thoughts on stochastic kinetic energy backscatter - good and bad by Glenn Shutts DARC Reading University May 15 2013 Acknowledgments ECMWF for supporting this work Martin Leutbecher Martin Steinheimer

More information

ICON. The Icosahedral Nonhydrostatic model: Formulation of the dynamical core and physics-dynamics coupling

ICON. The Icosahedral Nonhydrostatic model: Formulation of the dynamical core and physics-dynamics coupling ICON The Icosahedral Nonhydrostatic model: Formulation of the dynamical core and physics-dynamics coupling Günther Zängl and the ICON deelopment team PDEs on the sphere 2012 Outline Introduction: Main

More information

Formulation and performance of the Variable-Cubic Atmospheric Model

Formulation and performance of the Variable-Cubic Atmospheric Model Formulation and performance of the Variable-Cubic Atmospheric Model John McGregor CSIRO Marine and Atmospheric Research Aspendale, Melbourne Southern Hemisphere PDEs on the Sphere NCAR 11 April 2014 CSIRO

More information

Computational challenges in Numerical Weather Prediction

Computational challenges in Numerical Weather Prediction Computational challenges in Numerical Weather Prediction Mike Cullen Oxford 15 September 2008 Contents This presentation covers the following areas Historical background Current challenges Why does it

More information

Recent Developments in Numerical Methods for 4d-Var

Recent Developments in Numerical Methods for 4d-Var Recent Developments in Numerical Methods for 4d-Var Mike Fisher Slide 1 Recent Developments Numerical Methods 4d-Var Slide 2 Outline Non-orthogonal wavelets on the sphere: - Motivation: Covariance Modelling

More information

A fast randomized algorithm for approximating an SVD of a matrix

A fast randomized algorithm for approximating an SVD of a matrix A fast randomized algorithm for approximating an SVD of a matrix Joint work with Franco Woolfe, Edo Liberty, and Vladimir Rokhlin Mark Tygert Program in Applied Mathematics Yale University Place July 17,

More information

The WRF NMM Core. Zavisa Janjic Talk modified and presented by Matthew Pyle

The WRF NMM Core. Zavisa Janjic Talk modified and presented by Matthew Pyle The WRF NMM Core Zavisa Janjic (Zavisa.Janjic@noaa.gov) Talk modified and presented by Matthew Pyle (Matthew.Pyle@noaa.gov) NMM Dynamic Solver Basic Principles Equations / Variables Model Integration Horizontal

More information

Comparison between Wavenumber Truncation and Horizontal Diffusion Methods in Spectral Models

Comparison between Wavenumber Truncation and Horizontal Diffusion Methods in Spectral Models 152 MONTHLY WEATHER REVIEW Comparison between Wavenumber Truncation and Horizontal Diffusion Methods in Spectral Models PETER C. CHU, XIONG-SHAN CHEN, AND CHENWU FAN Department of Oceanography, Naval Postgraduate

More information

Fast Algorithms for the Computation of Oscillatory Integrals

Fast Algorithms for the Computation of Oscillatory Integrals Fast Algorithms for the Computation of Oscillatory Integrals Emmanuel Candès California Institute of Technology EPSRC Symposium Capstone Conference Warwick Mathematics Institute, July 2009 Collaborators

More information

MODEL TYPE (Adapted from COMET online NWP modules) 1. Introduction

MODEL TYPE (Adapted from COMET online NWP modules) 1. Introduction MODEL TYPE (Adapted from COMET online NWP modules) 1. Introduction Grid point and spectral models are based on the same set of primitive equations. However, each type formulates and solves the equations

More information

Linear model for investigation of nonlinear NWP model accuracy. Marko Zirk, University of Tartu

Linear model for investigation of nonlinear NWP model accuracy. Marko Zirk, University of Tartu Linear model for investigation of nonlinear NWP model accuracy Marko Zirk, University of Tartu Introduction A method for finding numerical solution of non-hydrostatic linear equations of atmospheric dynamics

More information

Spherical Harmonics and Related Topics. David Randall 2 S = 0, r 2 r r S 2. S = r n Y n

Spherical Harmonics and Related Topics. David Randall 2 S = 0, r 2 r r S 2. S = r n Y n ! Revised April 10, 2017 1:32 PM! 1 Spherical Harmonics and Related Topics David Randall The spherical surface harmonics are convenient functions for representing the distribution of geophysical quantities

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

Towards a Faster Spherical Harmonic transform

Towards a Faster Spherical Harmonic transform Towards a Faster Spherical Harmonic transform Nathanaël Schaeffer LGIT / CNRS / Université Joseph Fourier IUGG CMG, Pisa, 7 May 2010 N. Schaeffer (LGIT/CNRS/UJF) Towards a faster SHT IUGG CMG, Pisa, 7

More information

Analogues for Bessel Functions of the Christoffel-Darboux Identity

Analogues for Bessel Functions of the Christoffel-Darboux Identity Analogues for Bessel Functions of the Christoffel-Darboux Identity Mark Tygert Research Report YALEU/DCS/RR-1351 March 30, 2006 Abstract We derive analogues for Bessel functions of what is known as the

More information

ATS 421/521. Climate Modeling. Spring 2015

ATS 421/521. Climate Modeling. Spring 2015 ATS 421/521 Climate Modeling Spring 2015 Lecture 9 Hadley Circulation (Held and Hou, 1980) General Circulation Models (tetbook chapter 3.2.3; course notes chapter 5.3) The Primitive Equations (tetbook

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

The Spectral Method (MAPH 40260)

The Spectral Method (MAPH 40260) The Spectral Method (MAPH 40260) Part 4: Barotropic Vorticity Equation Peter Lynch School of Mathematical Sciences Outline Background Rossby-Haurwitz Waves Interaction Coefficients Transform Method The

More information

Fourier Analysis. 19th October 2015

Fourier Analysis. 19th October 2015 Fourier Analysis Hilary Weller 19th October 2015 This is brief introduction to Fourier analysis and how it is used in atmospheric and oceanic science, for: Analysing data (eg climate

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

MATHEMATICAL METHODS INTERPOLATION

MATHEMATICAL METHODS INTERPOLATION MATHEMATICAL METHODS INTERPOLATION I YEAR BTech By Mr Y Prabhaker Reddy Asst Professor of Mathematics Guru Nanak Engineering College Ibrahimpatnam, Hyderabad SYLLABUS OF MATHEMATICAL METHODS (as per JNTU

More information

PARTIAL DIFFERENTIAL EQUATIONS

PARTIAL DIFFERENTIAL EQUATIONS MATHEMATICAL METHODS PARTIAL DIFFERENTIAL EQUATIONS I YEAR B.Tech By Mr. Y. Prabhaker Reddy Asst. Professor of Mathematics Guru Nanak Engineering College Ibrahimpatnam, Hyderabad. SYLLABUS OF MATHEMATICAL

More information

Conservation of Mass Conservation of Energy Scaling Analysis. ESS227 Prof. Jin-Yi Yu

Conservation of Mass Conservation of Energy Scaling Analysis. ESS227 Prof. Jin-Yi Yu Lecture 2: Basic Conservation Laws Conservation of Momentum Conservation of Mass Conservation of Energy Scaling Analysis Conservation Law of Momentum Newton s 2 nd Law of Momentum = absolute velocity viewed

More information

Outline. The Spectral Method (MAPH 40260) Part 4: Barotropic Vorticity Equation. Outline. Background. Rossby-Haurwitz Waves.

Outline. The Spectral Method (MAPH 40260) Part 4: Barotropic Vorticity Equation. Outline. Background. Rossby-Haurwitz Waves. Outline The Spectral Method (MAPH 40260) Part 4: Barotropic Vorticity Equation Peter Lynch School of Mathematical Sciences Outline The dynamics of non-divergent flow on a rotating sphere are described

More information

Reflecting on the Goal and Baseline of Exascale Computing

Reflecting on the Goal and Baseline of Exascale Computing Reflecting on the Goal and Baseline of Exascale Computing Thomas C. Schulthess!1 Tracking supercomputer performance over time? Linpack benchmark solves: Ax = b!2 Tracking supercomputer performance over

More information

Randomized algorithms for the low-rank approximation of matrices

Randomized algorithms for the low-rank approximation of matrices Randomized algorithms for the low-rank approximation of matrices Yale Dept. of Computer Science Technical Report 1388 Edo Liberty, Franco Woolfe, Per-Gunnar Martinsson, Vladimir Rokhlin, and Mark Tygert

More information

1/18/2011. Conservation of Momentum Conservation of Mass Conservation of Energy Scaling Analysis ESS227 Prof. Jin-Yi Yu

1/18/2011. Conservation of Momentum Conservation of Mass Conservation of Energy Scaling Analysis ESS227 Prof. Jin-Yi Yu Lecture 2: Basic Conservation Laws Conservation Law of Momentum Newton s 2 nd Law of Momentum = absolute velocity viewed in an inertial system = rate of change of Ua following the motion in an inertial

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

Scalability Programme at ECMWF

Scalability Programme at ECMWF Scalability Programme at ECMWF Picture: Stan Tomov, ICL, University of Tennessee, Knoxville Peter Bauer, Mike Hawkins, George Mozdzynski, Tiago Quintino, Deborah Salmond, Stephan Siemen, Yannick Trémolet

More information

(f(x) P 3 (x)) dx. (a) The Lagrange formula for the error is given by

(f(x) P 3 (x)) dx. (a) The Lagrange formula for the error is given by 1. QUESTION (a) Given a nth degree Taylor polynomial P n (x) of a function f(x), expanded about x = x 0, write down the Lagrange formula for the truncation error, carefully defining all its elements. How

More information

ECMWF Overview. The European Centre for Medium-Range Weather Forecasts is an international. organisation supported by 23 European States.

ECMWF Overview. The European Centre for Medium-Range Weather Forecasts is an international. organisation supported by 23 European States. ECMWF Overview The European Centre for Medium-Range Weather Forecasts is an international organisation supported by 3 European States. The center was established in 1973 by a Convention and the real-time

More information

Advanced. Engineering Mathematics

Advanced. Engineering Mathematics Advanced Engineering Mathematics A new edition of Further Engineering Mathematics K. A. Stroud Formerly Principal Lecturer Department of Mathematics, Coventry University with additions by Dexter j. Booth

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

Mass-conserving and positive-definite semi-lagrangian advection in NCEP GFS: Decomposition for massively parallel computing without halo

Mass-conserving and positive-definite semi-lagrangian advection in NCEP GFS: Decomposition for massively parallel computing without halo Mass-conserving and positive-definite semi-lagrangian advection in NCEP GFS: Decomposition for massively parallel computing without halo Hann-Ming Henry Juang Environmental Modeling Center, NCEP NWS,NOAA,DOC,USA

More information

A stable treatment of conservative thermodynamic variables for semi-implicit semi-lagrangian dynamical cores

A stable treatment of conservative thermodynamic variables for semi-implicit semi-lagrangian dynamical cores A stable treatment of conservative thermodynamic variables for semi-implicit semi-lagrangian dynamical cores Kevin Viner Naval Research Laboratory, Monterey, CA September 26, 2012 Kevin Viner (NRL) PDE

More information

Optimal Prediction for Radiative Transfer: A New Perspective on Moment Closure

Optimal Prediction for Radiative Transfer: A New Perspective on Moment Closure Optimal Prediction for Radiative Transfer: A New Perspective on Moment Closure Benjamin Seibold MIT Applied Mathematics Mar 02 nd, 2009 Collaborator Martin Frank (TU Kaiserslautern) Partial Support NSF

More information

Progress in Numerical Methods at ECMWF

Progress in Numerical Methods at ECMWF Progress in Numerical Methods at ECMWF EWGLAM / SRNWP October 2016 W. Deconinck, G. Mengaldo, C. Kühnlein, P.K. Smolarkiewicz, N.P. Wedi, P. Bauer willem.deconinck@ecmwf.int ECMWF November 7, 2016 2 The

More information

TABLE OF CONTENTS INTRODUCTION, APPROXIMATION & ERRORS 1. Chapter Introduction to numerical methods 1 Multiple-choice test 7 Problem set 9

TABLE OF CONTENTS INTRODUCTION, APPROXIMATION & ERRORS 1. Chapter Introduction to numerical methods 1 Multiple-choice test 7 Problem set 9 TABLE OF CONTENTS INTRODUCTION, APPROXIMATION & ERRORS 1 Chapter 01.01 Introduction to numerical methods 1 Multiple-choice test 7 Problem set 9 Chapter 01.02 Measuring errors 11 True error 11 Relative

More information

Atmospheric Fronts. The material in this section is based largely on. Lectures on Dynamical Meteorology by Roger Smith.

Atmospheric Fronts. The material in this section is based largely on. Lectures on Dynamical Meteorology by Roger Smith. Atmospheric Fronts The material in this section is based largely on Lectures on Dynamical Meteorology by Roger Smith. Atmospheric Fronts 2 Atmospheric Fronts A front is the sloping interfacial region of

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

Evaluation of three spatial discretization schemes with the Galewsky et al. test

Evaluation of three spatial discretization schemes with the Galewsky et al. test Evaluation of three spatial discretization schemes with the Galewsky et al. test Seoleun Shin Matthias Sommer Sebastian Reich Peter Névir February 22, 2 Abstract We evaluate the Hamiltonian Particle Methods

More information

Green s Functions, Boundary Integral Equations and Rotational Symmetry

Green s Functions, Boundary Integral Equations and Rotational Symmetry Green s Functions, Boundary Integral Equations and Rotational Symmetry...or, How to Construct a Fast Solver for Stokes Equation Saibal De Advisor: Shravan Veerapaneni University of Michigan, Ann Arbor

More information

Split explicit methods

Split explicit methods Split explicit methods Almut Gassmann Meteorological Institute of the University of Bonn Germany St.Petersburg Summer School 2006 on nonhydrostatic dynamics and fine scale data assimilation Two common

More information

Stochastic methods for representing atmospheric model uncertainties in ECMWF's IFS model

Stochastic methods for representing atmospheric model uncertainties in ECMWF's IFS model Stochastic methods for representing atmospheric model uncertainties in ECMWF's IFS model Sarah-Jane Lock Model Uncertainty, Research Department, ECMWF With thanks to Martin Leutbecher, Simon Lang, Pirkka

More information

Numerical Mathematics

Numerical Mathematics Alfio Quarteroni Riccardo Sacco Fausto Saleri Numerical Mathematics Second Edition With 135 Figures and 45 Tables 421 Springer Contents Part I Getting Started 1 Foundations of Matrix Analysis 3 1.1 Vector

More information

A Fast N-Body Solver for the Poisson(-Boltzmann) Equation

A Fast N-Body Solver for the Poisson(-Boltzmann) Equation A Fast N-Body Solver for the Poisson(-Boltzmann) Equation Robert D. Skeel Departments of Computer Science (and Mathematics) Purdue University http://bionum.cs.purdue.edu/2008december.pdf 1 Thesis Poisson(-Boltzmann)

More information

Comparing the formulations of CCAM and VCAM and aspects of their performance

Comparing the formulations of CCAM and VCAM and aspects of their performance Comparing the formulations of CCAM and VCAM and aspects of their performance John McGregor CSIRO Marine and Atmospheric Research Aspendale, Melbourne PDEs on the Sphere Cambridge 28 September 2012 CSIRO

More information

Numerical Methods I Orthogonal Polynomials

Numerical Methods I Orthogonal Polynomials Numerical Methods I Orthogonal Polynomials Aleksandar Donev Courant Institute, NYU 1 donev@courant.nyu.edu 1 Course G63.2010.001 / G22.2420-001, Fall 2010 Nov. 4th and 11th, 2010 A. Donev (Courant Institute)

More information

Review. Numerical Methods Lecture 22. Prof. Jinbo Bi CSE, UConn

Review. Numerical Methods Lecture 22. Prof. Jinbo Bi CSE, UConn Review Taylor Series and Error Analysis Roots of Equations Linear Algebraic Equations Optimization Numerical Differentiation and Integration Ordinary Differential Equations Partial Differential Equations

More information

Exascale challenges for Numerical Weather Prediction : the ESCAPE project

Exascale challenges for Numerical Weather Prediction : the ESCAPE project Exascale challenges for Numerical Weather Prediction : the ESCAPE project O Olivier Marsden This project has received funding from the European Union s Horizon 2020 research and innovation programme under

More information

Blurring the boundary between dynamics and physics. Tim Palmer, Peter Düben, Hugh McNamara University of Oxford

Blurring the boundary between dynamics and physics. Tim Palmer, Peter Düben, Hugh McNamara University of Oxford Blurring the boundary between dynamics and physics Tim Palmer, Peter Düben, Hugh McNamara University of Oxford ρ +. = ρ p + ν t u u g 2 u Resolved scales The Canonical Numerical Ansatz Unresolved scales

More information

Numerical methods Revised March 2001

Numerical methods Revised March 2001 Revised March 00 By R. W. Riddaway (revised by M. Hortal) Table of contents. Some introductory ideas. Introduction. Classification of PDE's.3 Existence and uniqueness.4 Discretization.5 Convergence, consistency

More information

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

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

More information

Lateral Boundary Conditions

Lateral Boundary Conditions Lateral Boundary Conditions Introduction For any non-global numerical simulation, the simulation domain is finite. Consequently, some means of handling the outermost extent of the simulation domain its

More information

11 days (00, 12 UTC) 132 hours (06, 18 UTC) One unperturbed control forecast and 26 perturbed ensemble members. --

11 days (00, 12 UTC) 132 hours (06, 18 UTC) One unperturbed control forecast and 26 perturbed ensemble members. -- APPENDIX 2.2.6. CHARACTERISTICS OF GLOBAL EPS 1. Ensemble system Ensemble (version) Global EPS (GEPS1701) Date of implementation 19 January 2017 2. EPS configuration Model (version) Global Spectral Model

More information

Operational and research activities at ECMWF now and in the future

Operational and research activities at ECMWF now and in the future Operational and research activities at ECMWF now and in the future Sarah Keeley Education Officer Erland Källén Director of Research ECMWF An independent intergovernmental organisation established in 1975

More information

ICON. The Icosahedral Nonhydrostatic modelling framework

ICON. The Icosahedral Nonhydrostatic modelling framework ICON The Icosahedral Nonhydrostatic modelling framework Basic formulation, NWP and high-performance computing aspects, and its perspective towards a unified model for seamless prediction Günther Zängl,

More information

A Strategy for the Development of Coupled Ocean- Atmosphere Discontinuous Galerkin Models

A Strategy for the Development of Coupled Ocean- Atmosphere Discontinuous Galerkin Models A Strategy for the Development of Coupled Ocean- Atmosphere Discontinuous Galerkin Models Frank Giraldo Department of Applied Math, Naval Postgraduate School, Monterey CA 93943 Collaborators: Jim Kelly

More information

Laplace Transform Integration (ACM 40520)

Laplace Transform Integration (ACM 40520) Laplace Transform Integration (ACM 40520) Peter Lynch School of Mathematical Sciences Outline Basic Theory Residue Theorem Ordinary Differential Equations General Vector NWP Equation Lagrangian Formulation

More information

Hilbert Space Methods for Reduced-Rank Gaussian Process Regression

Hilbert Space Methods for Reduced-Rank Gaussian Process Regression Hilbert Space Methods for Reduced-Rank Gaussian Process Regression Arno Solin and Simo Särkkä Aalto University, Finland Workshop on Gaussian Process Approximation Copenhagen, Denmark, May 2015 Solin &

More information

Fast Multipole Methods for The Laplace Equation. Outline

Fast Multipole Methods for The Laplace Equation. Outline Fast Multipole Methods for The Laplace Equation Ramani Duraiswami Nail Gumerov Outline 3D Laplace equation and Coulomb potentials Multipole and local expansions Special functions Legendre polynomials Associated

More information

Background Error Covariance Modelling

Background Error Covariance Modelling Background Error Covariance Modelling Mike Fisher Slide 1 Outline Diagnosing the Statistics of Background Error using Ensembles of Analyses Modelling the Statistics in Spectral Space - Relaxing constraints

More information

2. Outline of the MRI-EPS

2. Outline of the MRI-EPS 2. Outline of the MRI-EPS The MRI-EPS includes BGM cycle system running on the MRI supercomputer system, which is developed by using the operational one-month forecasting system by the Climate Prediction

More information

ACCELERATING WEATHER PREDICTION WITH NVIDIA GPUS

ACCELERATING WEATHER PREDICTION WITH NVIDIA GPUS ACCELERATING WEATHER PREDICTION WITH NVIDIA GPUS Alan Gray, Developer Technology Engineer, NVIDIA ECMWF 18th Workshop on high performance computing in meteorology, 28 th September 2018 ESCAPE NVIDIA s

More information

Linear advection characteristics of a variable resolution global spectral method on the sphere

Linear advection characteristics of a variable resolution global spectral method on the sphere Linear advection characteristics of a variable resolution global spectral method on the sphere S. Janakiraman Seasonal Prediction of Indian Monsoon group, Centre for Development of Advanced Computing,

More information

Research Statement. James Bremer Department of Mathematics, University of California, Davis

Research Statement. James Bremer Department of Mathematics, University of California, Davis Research Statement James Bremer Department of Mathematics, University of California, Davis Email: bremer@math.ucdavis.edu Webpage: https.math.ucdavis.edu/ bremer I work in the field of numerical analysis,

More information

Preface. 2 Linear Equations and Eigenvalue Problem 22

Preface. 2 Linear Equations and Eigenvalue Problem 22 Contents Preface xv 1 Errors in Computation 1 1.1 Introduction 1 1.2 Floating Point Representation of Number 1 1.3 Binary Numbers 2 1.3.1 Binary number representation in computer 3 1.4 Significant Digits

More information

Introduction to Isentropic Coordinates: a new view of mean meridional & eddy circulations. Cristiana Stan

Introduction to Isentropic Coordinates: a new view of mean meridional & eddy circulations. Cristiana Stan Introduction to Isentropic Coordinates: a new view of mean meridional & eddy circulations Cristiana Stan School and Conference on the General Circulation of the Atmosphere and Oceans: a Modern Perspective

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

ECMWF Scalability Programme

ECMWF Scalability Programme ECMWF Scalability Programme Picture: Stan Tomov, ICL, University of Tennessee, Knoxville Peter Bauer, Mike Hawkins, Deborah Salmond, Stephan Siemen, Yannick Trémolet, and Nils Wedi Next generation science

More information

Introduction to Isentropic Coordinates:! a new view of mean meridional & eddy circulations" Cristiana Stan

Introduction to Isentropic Coordinates:! a new view of mean meridional & eddy circulations Cristiana Stan Introduction to Isentropic Coordinates:! a new view of mean meridional & eddy circulations" Cristiana Stan School and Conference on the General Circulation of the Atmosphere and Oceans: a Modern Perspective!

More information

Weather Forecasting Models in Met Éireann. Eoin Whelan UCD Seminar 3 rd April 2012

Weather Forecasting Models in Met Éireann. Eoin Whelan UCD Seminar 3 rd April 2012 Weather Forecasting Models in Met Éireann Eoin Whelan UCD Seminar 3 rd April 2012 Overview Background HIRLAM Models Local Implementation Verification Development work Background Met Éireann Dept of the

More information

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

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

More information

Challenges and Opportunities in Modeling of the Global Atmosphere

Challenges and Opportunities in Modeling of the Global Atmosphere Challenges and Opportunities in Modeling of the Global Atmosphere Zavisa Janjic, Vladimir Djurdjevic, Ratko Vasic, and Tom Black NOAA/NCEP/EMC, College Park, MD 20740, U.S.A. (Email: zavisa.janjic@noaa.gov)

More information

Assimilation Techniques (4): 4dVar April 2001

Assimilation Techniques (4): 4dVar April 2001 Assimilation echniques (4): 4dVar April By Mike Fisher European Centre for Medium-Range Weather Forecasts. able of contents. Introduction. Comparison between the ECMWF 3dVar and 4dVar systems 3. he current

More information

Parallel Algorithms for Four-Dimensional Variational Data Assimilation

Parallel Algorithms for Four-Dimensional Variational Data Assimilation Parallel Algorithms for Four-Dimensional Variational Data Assimilation Mie Fisher ECMWF October 24, 2011 Mie Fisher (ECMWF) Parallel 4D-Var October 24, 2011 1 / 37 Brief Introduction to 4D-Var Four-Dimensional

More information

Growth of forecast uncertainties in global prediction systems and IG wave dynamics

Growth of forecast uncertainties in global prediction systems and IG wave dynamics Growth of forecast uncertainties in global prediction systems and IG wave dynamics Nedjeljka Žagar and Žiga Zaplotnik Department of physics, Faculty of mathematics and physics, University of Ljubljana,

More information

Problem descriptions: Non-uniform fast Fourier transform

Problem descriptions: Non-uniform fast Fourier transform Problem descriptions: Non-uniform fast Fourier transform Lukas Exl 1 1 University of Vienna, Institut für Mathematik, Oskar-Morgenstern-Platz 1, A-1090 Wien, Austria December 11, 2015 Contents 0.1 Software

More information

Physics/Dynamics coupling

Physics/Dynamics coupling Physics/Dynamics coupling Sylvie Malardel ECMWF November 8, 2010 Sylvie Malardel (ECMWF) Physics/Dynamics coupling November 8, 2010 1 / 21 Coupling between Physics and Dynamics for convection permitting

More information

The General Circulation of the Atmosphere: A Numerical Experiment

The General Circulation of the Atmosphere: A Numerical Experiment The General Circulation of the Atmosphere: A Numerical Experiment Norman A. Phillips (1956) Presentation by Lukas Strebel and Fabian Thüring Goal of the Model Numerically predict the mean state of the

More information

Numerical Weather Prediction. Meteorology 311 Fall 2010

Numerical Weather Prediction. Meteorology 311 Fall 2010 Numerical Weather Prediction Meteorology 311 Fall 2010 Closed Set of Equations Same number of equations as unknown variables. Equations Momentum equations (3) Thermodynamic energy equation Continuity equation

More information

Exam 2. Average: 85.6 Median: 87.0 Maximum: Minimum: 55.0 Standard Deviation: Numerical Methods Fall 2011 Lecture 20

Exam 2. Average: 85.6 Median: 87.0 Maximum: Minimum: 55.0 Standard Deviation: Numerical Methods Fall 2011 Lecture 20 Exam 2 Average: 85.6 Median: 87.0 Maximum: 100.0 Minimum: 55.0 Standard Deviation: 10.42 Fall 2011 1 Today s class Multiple Variable Linear Regression Polynomial Interpolation Lagrange Interpolation Newton

More information

Numerical Weather prediction at the European Centre for Medium-Range Weather Forecasts (2)

Numerical Weather prediction at the European Centre for Medium-Range Weather Forecasts (2) Numerical Weather prediction at the European Centre for Medium-Range Weather Forecasts (2) Time series curves 500hPa geopotential Correlation coefficent of forecast anomaly N Hemisphere Lat 20.0 to 90.0

More information

Tangent-linear and adjoint models in data assimilation

Tangent-linear and adjoint models in data assimilation Tangent-linear and adjoint models in data assimilation Marta Janisková and Philippe Lopez ECMWF Thanks to: F. Váňa, M.Fielding 2018 Annual Seminar: Earth system assimilation 10-13 September 2018 Tangent-linear

More information

ON INTERPOLATION AND INTEGRATION IN FINITE-DIMENSIONAL SPACES OF BOUNDED FUNCTIONS

ON INTERPOLATION AND INTEGRATION IN FINITE-DIMENSIONAL SPACES OF BOUNDED FUNCTIONS COMM. APP. MATH. AND COMP. SCI. Vol., No., ON INTERPOLATION AND INTEGRATION IN FINITE-DIMENSIONAL SPACES OF BOUNDED FUNCTIONS PER-GUNNAR MARTINSSON, VLADIMIR ROKHLIN AND MARK TYGERT We observe that, under

More information

GSI Tutorial Background and Observation Errors: Estimation and Tuning. Daryl Kleist NCEP/EMC June 2011 GSI Tutorial

GSI Tutorial Background and Observation Errors: Estimation and Tuning. Daryl Kleist NCEP/EMC June 2011 GSI Tutorial GSI Tutorial 2011 Background and Observation Errors: Estimation and Tuning Daryl Kleist NCEP/EMC 29-30 June 2011 GSI Tutorial 1 Background Errors 1. Background error covariance 2. Multivariate relationships

More information

4. DATA ASSIMILATION FUNDAMENTALS

4. DATA ASSIMILATION FUNDAMENTALS 4. DATA ASSIMILATION FUNDAMENTALS... [the atmosphere] "is a chaotic system in which errors introduced into the system can grow with time... As a consequence, data assimilation is a struggle between chaotic

More information

Lecture 1. Equations of motion - Newton s second law in three dimensions. Pressure gradient + force force

Lecture 1. Equations of motion - Newton s second law in three dimensions. Pressure gradient + force force Lecture 3 Lecture 1 Basic dynamics Equations of motion - Newton s second law in three dimensions Acceleration = Pressure Coriolis + gravity + friction gradient + force force This set of equations is the

More information

Fast Algorithms for Spherical Harmonic Expansions

Fast Algorithms for Spherical Harmonic Expansions Fast Algorithms for Spherical Harmonic Expansions Vladimir Rokhlin and Mark Tygert Research Report YALEU/DCS/RR-1309 December 17, 004 Abstract An algorithm is introduced for the rapid evaluation at appropriately

More information

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

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

More information