Case Study: Numerical Simulations of the Process by which Planets generate their Magnetic Fields. Stephan Stellmach UCSC

Size: px
Start display at page:

Download "Case Study: Numerical Simulations of the Process by which Planets generate their Magnetic Fields. Stephan Stellmach UCSC"

Transcription

1 Case Study: Numerical Simulations of the Process by which Planets generate their Magnetic Fields Stephan Stellmach UCSC 1

2 The Scientific Problem 2

3 The Magnetic Field of the Earth 3

4 Contributions to the Earth s magnetic field radial component of the Earth s magnetic field at satellite altitude. Courtesy of Nils Olsen 4

5 The Magnetic Field of the Earth Deviations from a purely dipolar field: declination

6 The magnetic field of the Earth: Secular Variation Jackson et al, 2000

7 Changes of the Earth Magnetic Field: The magnetic Poles b

8 The magnetic field of the Earth: Reversals

9 The magnetic field of the Earth: Reversals

10 The magnetic field of the Earth: Reversals

11 The geodynamo hypothesis fluid flow In du ct io n electric field current density O hm s La w Ampère s Law magnetic field Geoforschungszentrum Potsdam 11

12 The Mathematical Problem: momentum equation induction equation solenoidal conditions energy equation Par. Definition Meaning Planetary core Ra = α Τ g d / (2 Ω κ) ~ buoyancy forces/ rotational forces? q = κ / η ~ magn. diff. time / therm. diff. time O(10-6) Pr =ν / κ ~ therm. diff. time / visc. diff. time O(10-2) E = ν / (2 Ω L2) ~ rot. time scale / visc. diffusion time O(10-15) 12

13 Convection in Rotating Spherical Shells Busse, 1970 Kageyama & Sato, 1997

14 Cartridge belt dynamo α Effekt Kageyama & Sato, 1997 Ω Effekt

15 Numerical Simulations of Reversals Gary Glatzmaier

16 Parameter ranges for numerical simulations 10? The problem today Earth We still can't simulate the dynamo process under realistic conditions:? Ra num mo erical del s E flows are very turbulent We can't resolve all length scales We can't resolve all time scales

17 Local models to study the planetary dynamo problem spherical shell models realistic geometry might be compared to measured data simple local plane layer model more efficient numerics larger parameter ranges more small scale structure plane boundaries conducting fluid use periodic BCs in x,y-direction Investigate simple plane layer model to isolate and understand relevant physical processes 17

18 Goal: Develop simulation software for Cartesian dynamos which runs efficiently on massively parallel computers 18

19 The numerical method we dream of: Wish List: optimal accuracy for a given spatial and temporal resolution temporal (and spatial) resolution dictated by accuracy considerations, not by stability issues optimal operation count as small as possible per time step floating point operations per time step ~ #(unknowns) per time step should be able to handle all types of boundary conditions should run efficiently on all types of machines, including the fastest massively parallel machines available strong scaling: For a given resolution, computing time ~ #(CPUs)-1 weak scaling: If the resolution is increased along with #(CPUs) such that the data volume per CPU remains constant, the computing time should also remain constant. 19

20 High Performance Computers Numerical Simulations at extreme parameter values are necessary to understand natural dynamos. Use fastest machines available today! fastest today 20

21 The fastest machine available today: IBM Blue Gene IBM Blue Gene/L scalable to at least nodes Power PC 440 CPUs, 700 MHz relatively slow good flops/mw ratio 512 MB per node relatively small Networks: 3D torus collective Petascale computing by the end of the decade? 21

22 Which numerical approach is the way to go??? Question: Can we really exploit such machines with the current models? Possible choices: global spectral methods local low order methods spectral transform method global coupling FD, FV, FE,... only local coupling 22

23 First Option: Use a Local Discretization Method Example: Finite Volume Method Basic idea of finite volume methods Divide the domain into control volumes Integrate over control volume Use numerical Approximations for surface integrals gradients volume integrals If 2nd order approx. are used, only data from the six neighboring control volumes is needed 23

24 First Option: Use a local method How to parallelize a local method? Only data from a few grid levels (marked green) has to be exchanged! 24

25 Second Option: Use a global spectral method Basic Idea of Spectral Methods: Assume that we want to solve the differential equation: Expand all unknowns u(x) into a finite series of basis functions φn Substitute finite series into differential equation Minimize Residual function R Spectral methods mainly differ in minimization techniques and chosen basis functions 25

26 Second Option: Use a global spectral method How to parallelize a spectral method? Different algorithms have been proposed (we discuss one in particular later on...) But one thing is clear: To compute a spectral transform, global communication will be necessary! 26

27 Here, we had to make a first decision: We decided to use a global spectral method - mainly because of its superior accuracy 27

28 How it works in detail: Spectral Method I/V Eight scalar PDFs Reduce to five scalar PDEs Horizontal expansion Apply time stepping vertical discretization We have eight scalar PDEs for the eight unkowns 28

29 How it works in detail: Spectral Method II/V Eight scalar PDFs Reduce to five scalar PDEs Horizontal expansion Apply time stepping vertical discretization Result from potential theory: Solenoidal vector fields can be described by to potential function, called toroidal and poloidal potentials: Horizontal averages < > are added here to guarantee that e,f,g,h are horizontally periodic. Substitution into the governing equation leads to: five PDEs for the toroidal potentials (e, g), poloidal potentials (f, h) and for the temperature T. (+ equations for the so called mean fields <ux>, <uy >, <Bx>, <By > which only depend only on z,t and are therefore inexpensive to solve.) 29

30 How it works in detail: Spectral Method II/V Eight scalar PDFs Reduce to five scalar PDEs to be more specific: apply and Horizontal expansion Apply time stepping vertical discretization to the governing equations: with 30

31 How it works in detail: Spectral Method III/V Eight scalar PDFs Reduce to five scalar PDEs Horizontal expansion Apply time stepping vertical discretization We have periodic horizontal boundary conditions -> use Fourier basis functions Φ with Гx and Гy are the length and depth of the computational domain, Lmax and Mmax are the number of Fourier modes to use Substitute into governing equations and use orthogonality of basis functions This leads to: Nx Χ Ny PDEs for the coefficients 31

32 How it works in detail: Spectral Method III/V Eight scalar PDFs Reduce to five scalar PDEs Horizontal expansion Apply time stepping vertical discretization Again, to be more specific: with 32

33 How it works in detail: Spectral Method IV/V Eight scalar PDFs Reduce to five scalar PDEs Apply time stepping vertical discretization Use semi implicit time stepping scheme (explicit for non-linear terms F, implicit for remaining linear terms) Backward-DifferencingFormula scheme for linear terms (2nd order) Horizontal expansion BDF2/AB2 scheme Adams-Bashforth scheme for nonlinear terms (2nd order) This leads to: Nx Χ Ny ODEs for the Coefficients where Ф=(e,f,g,h,T) and the index (n+1) denotes the new time level. 33

34 How it works in detail: Spectral Method V/V Eight scalar PDFs Reduce to five scalar PDEs Horizontal expansion Apply time stepping vertical discretization Boundary conditions on top and bottom boundary -> Use expansion into Chebyshev-Polynomials graphical visualization of Chebyshev polynomials z d e re g e 34

35 How it works in detail: Spectral Method V/V Eight scalar PDFs Reduce to five scalar PDEs Horizontal expansion Use the Tau method to minimize the residual Leads to: Apply time stepping vertical discretization Nx Ny quasi-tridiagonal systems of equations for the Coefficients Nonlinear terms on right hand side are evaluated in physical (x,y,z) space and are then transformed to spectral space Use Gauss-Lobatto points in physical space -> fast transforms are available for conversion between physical and transform space 35

36 Back to our wish list What is possible with our spectral code? optimal accuracy for a given spatial and temporal resolution temporal (and spatial) resolution dictated by accuracy considerations, not by stability issues optimal operation count as small as possible per time step floating point operations per time step ~ #(unknowns) per time step should run efficiently on all types of machines, including the fastest massively parallel machines available Well, we have not discussed the parallelization yet... 36

37 Question: How do we parallelize a spectral method like this? 37

38 Biggest problem: How to parallelize the transforms??? 38

39 First observation: We have chosen a tensor-product basis, i.e. our 3D basis functions φ(x,y,z) are products of 1D basis functions: φ(x,y,z) = exp(iαx) exp(iβy) Tn(z) We can thus do the transform in three steps! 1) Perform a real-to-complex FFT of the x-coordinate 2) Then, perform a complex-to-complex FFT of the y-coordinate 3) Then, perform a Chebyshev transform along z For Backward Transform, do reverse transforms in reverse order. Idea: Do each step in-processor, each CPU for a subset of data. Communicate data between the steps. 39

40 Parallel Transforms: slabs for small Linux cluster Physical space: each processor holds xy-slab Fourier/Chebyshev Space: each process holds zy-slab xy-slab zy-slab 2d real to complex FFT transpose from xy-slabs to yz-slabs Chebyshev transform along z 40

41 Parallel Transforms: pencils for a massively parallel machine Physical space: each processor holds x-pencil Fourier/Chebyshev Space: each process holds z-pencil x-pencils z-pencils Intermediate state: each process holds y-pencil y-pencils FFT along x transpose FFT along y transpose Chebyshev transf. along z 41

42 Second observation: With this data layout, all other steps in our algorithm don't require any communication! Transforms are the only operations which need explicit message passing! So, after parallelizing the transforms, we are almost done... 42

43 How efficient is our method on O(104) CPUs? open symbols: Virtual Node Mode filled symbols: Communication Coprocessor Mode 43

44 How efficient is our method on O(104) CPUs? With FPUs, the efficiency on a 2563 grid is still > 40% 44

45 Weak scaling: What happens if we increase resolution? 45

46 Weak scaling: What happens if we increase resolution? If we have more than a few ten thousand grid points per task, we achieve good weak scaling (up to the logarithmic factor log2(n)). 46

47 First conclusions It is possible to achieve good (weak and strong) scaling on massively parallel machines even with global spectral methods. But: Detailed timing shows that the code is clearly bandwidth-limited (i.e. parallel transposes scale, but consume a large fraction of the computing time) So, was it wise to choose the spectral approach? 47

48 Was is wise to choose the spectral approach? Actually, we tried the finite volume approach as well... No simple yes/no answer Apart from parallelization issues, each method has pros & cons (stability, accuracy, cache coherence...) As expected, finite volume code also scales reasonably Main difference: Spectral code exchanges huge amounts of data once in a while Finite volume code exchanges small amounts of data all the time Much will depend on detailed network structure 48

49 Application Example: Turbulent rotating Convection 49

50 Convection in a Rotating Rayleigh Benard Layers 50

51 Thank you!!! 51

Fluctuation dynamo amplified by intermittent shear bursts

Fluctuation dynamo amplified by intermittent shear bursts by intermittent Thanks to my collaborators: A. Busse (U. Glasgow), W.-C. Müller (TU Berlin) Dynamics Days Europe 8-12 September 2014 Mini-symposium on Nonlinear Problems in Plasma Astrophysics Introduction

More information

Stephan Stellmach, University of Münster / Germany

Stephan Stellmach, University of Münster / Germany NUMERICAL SIMULATION OF DOUBLE DIFFUSIVE CONVECTION IN OCEANS, STARS AND PLANETARY INTERIORS Stephan Stellmach, University of Münster / Germany with: Pascale Garaud, Adienne Traxler, Nic Brummell, Timour

More information

Turbulence in geodynamo simulations

Turbulence in geodynamo simulations Turbulence in geodynamo simulations Nathanaël Schaeffer, A. Fournier, D. Jault, J. Aubert, H-C. Nataf,... ISTerre / CNRS / Université Grenoble Alpes Journée des utilisateurs CIMENT, Grenoble, 23 June 2016

More information

2.2. Methods for Obtaining FD Expressions. There are several methods, and we will look at a few:

2.2. Methods for Obtaining FD Expressions. There are several methods, and we will look at a few: .. Methods for Obtaining FD Expressions There are several methods, and we will look at a few: ) Taylor series expansion the most common, but purely mathematical. ) Polynomial fitting or interpolation the

More information

Numerical Modelling in Fortran: day 8. Paul Tackley, 2017

Numerical Modelling in Fortran: day 8. Paul Tackley, 2017 Numerical Modelling in Fortran: day 8 Paul Tackley, 2017 Today s Goals 1. Introduction to parallel computing (applicable to Fortran or C; examples are in Fortran) 2. Finite Prandtl number convection Motivation:

More information

Stratified Convection Driven by Internal Heating

Stratified Convection Driven by Internal Heating Stratified Convection Driven by Internal Heating (a convective amplitudes talk) Nick Featherstone Collaborators: Brad Hindman Mark Miesch Juri Toomre The Rossby Number typical velocity v Rotational Timescale

More information

Lagrangian Statistics. of 3D MHD Convection. J. Pratt, W.-C. Müller. Boussinesq Simulation. Lagrangian. simulation. March 1, 2011

Lagrangian Statistics. of 3D MHD Convection. J. Pratt, W.-C. Müller. Boussinesq Simulation. Lagrangian. simulation. March 1, 2011 March 1, 2011 Our approach to the Dynamo Problem dynamo action: amplification of magnetic fields by turbulent flows, generation of large scale structures collaboration with the group of Schüssler et al.

More information

Convection-driven spherical dynamos: remarks on bistability and on simple models of the Solar cycle

Convection-driven spherical dynamos: remarks on bistability and on simple models of the Solar cycle University of Cambridge DAMTP, Astrophysics Group Seminar 2014-11-17 Convection-driven spherical dynamos: remarks on bistability and on simple models of the Solar cycle R.D. Simitev F.H. Busse School of

More information

Rotating dynamo turbulence: theoretical and numerical insights

Rotating dynamo turbulence: theoretical and numerical insights Rotating dynamo turbulence: theoretical and numerical insights Nathanaël Schaeffer 1, H.-C. Nataf 1, A. Fournier 2, J. Aubert 2, D. Jault 1, F. Plunian 1, P. Zitzke 1 1: ISTerre / CNRS /Université Joseph

More information

GEODYNAMO SIMULATIONS HOW REALISTIC ARE THEY?

GEODYNAMO SIMULATIONS HOW REALISTIC ARE THEY? Annu. Rev. Earth Planet. Sci. 2002. 30:237 57 DOI: 10.1146/annurev.earth.30.091201.140817 Copyright c 2002 by Annual Reviews. All rights reserved GEODYNAMO SIMULATIONS HOW REALISTIC ARE THEY? Gary A. Glatzmaier

More information

NIMROD Project Overview

NIMROD Project Overview NIMROD Project Overview Christopher Carey - Univ. Wisconsin NIMROD Team www.nimrodteam.org CScADS Workshop July 23, 2007 Project Overview NIMROD models the macroscopic dynamics of magnetized plasmas by

More information

Generation of magnetic fields by large-scale vortices in rotating convection

Generation of magnetic fields by large-scale vortices in rotating convection Generation of magnetic fields by large-scale vortices in rotating convection Céline Guervilly, David Hughes & Chris Jones School of Mathematics, University of Leeds, UK Generation of the geomagnetic field

More information

Solving PDEs with PGI CUDA Fortran Part 4: Initial value problems for ordinary differential equations

Solving PDEs with PGI CUDA Fortran Part 4: Initial value problems for ordinary differential equations Solving PDEs with PGI CUDA Fortran Part 4: Initial value problems for ordinary differential equations Outline ODEs and initial conditions. Explicit and implicit Euler methods. Runge-Kutta methods. Multistep

More information

Simulation Study on the Generation and Distortion Process of the Geomagnetic Field in Earth-like Conditions

Simulation Study on the Generation and Distortion Process of the Geomagnetic Field in Earth-like Conditions Chapter 1 Earth Science Simulation Study on the Generation and Distortion Process of the Geomagnetic Field in Earth-like Conditions Project Representative Yozo Hamano Authors Ataru Sakuraba Yusuke Oishi

More information

ab initio Electronic Structure Calculations

ab initio Electronic Structure Calculations ab initio Electronic Structure Calculations New scalability frontiers using the BG/L Supercomputer C. Bekas, A. Curioni and W. Andreoni IBM, Zurich Research Laboratory Rueschlikon 8803, Switzerland ab

More information

Diffusion / Parabolic Equations. PHY 688: Numerical Methods for (Astro)Physics

Diffusion / Parabolic Equations. PHY 688: Numerical Methods for (Astro)Physics Diffusion / Parabolic Equations Summary of PDEs (so far...) Hyperbolic Think: advection Real, finite speed(s) at which information propagates carries changes in the solution Second-order explicit methods

More information

Chapter 7: Natural Convection

Chapter 7: Natural Convection 7-1 Introduction 7- The Grashof Number 7-3 Natural Convection over Surfaces 7-4 Natural Convection Inside Enclosures 7-5 Similarity Solution 7-6 Integral Method 7-7 Combined Natural and Forced Convection

More information

Convection-driven dynamos in the limit of rapid rotation

Convection-driven dynamos in the limit of rapid rotation Convection-driven dynamos in the limit of rapid rotation Michael A. Calkins Jonathan M. Aurnou (UCLA), Keith Julien (CU), Louie Long (CU), Philippe Marti (CU), Steven M. Tobias (Leeds) *Department of Physics,

More information

Anisotropic turbulence in rotating magnetoconvection

Anisotropic turbulence in rotating magnetoconvection Anisotropic turbulence in rotating magnetoconvection André Giesecke Astrophysikalisches Institut Potsdam An der Sternwarte 16 14482 Potsdam MHD-Group seminar, 2006 André Giesecke (AIP) Anisotropic turbulence

More information

MRI beyond Fourier Encoding: From array detection to higher-order field dynamics

MRI beyond Fourier Encoding: From array detection to higher-order field dynamics MRI beyond Fourier Encoding: From array detection to higher-order field dynamics K. Pruessmann Institute for Biomedical Engineering ETH Zurich and University of Zurich Parallel MRI Signal sample: m γκ,

More information

DYNAMO THEORY: THE PROBLEM OF THE GEODYNAMO PRESENTED BY: RAMANDEEP GILL

DYNAMO THEORY: THE PROBLEM OF THE GEODYNAMO PRESENTED BY: RAMANDEEP GILL DYNAMO THEORY: THE PROBLEM OF THE GEODYNAMO PRESENTED BY: RAMANDEEP GILL MAGNETIC FIELD OF THE EARTH DIPOLE Field Structure Permanent magnetization of Core? 80% of field is dipole 20 % is non dipole 2)

More information

Notation Nodes are data points at which functional values are available or at which you wish to compute functional values At the nodes fx i

Notation Nodes are data points at which functional values are available or at which you wish to compute functional values At the nodes fx i LECTURE 6 NUMERICAL DIFFERENTIATION To find discrete approximations to differentiation (since computers can only deal with functional values at discrete points) Uses of numerical differentiation To represent

More information

A parallel implementation of an MHD code for the simulation of mechanically driven, turbulent dynamos in spherical geometry

A parallel implementation of an MHD code for the simulation of mechanically driven, turbulent dynamos in spherical geometry Computer Physics Communications 179 (28) 245 249 www.elsevier.com/locate/cpc A parallel implementation of an MHD code for the simulation of mechanically driven, turbulent dynamos in spherical geometry

More information

A numerical dynamo benchmark

A numerical dynamo benchmark Physics of the Earth and Planetary Interiors 128 (2001) 25 34 A numerical dynamo benchmark U.R. Christensen a,, J. Aubert b, P. Cardin b, E. Dormy c, S. Gibbons d, G.A. Glatzmaier e, E. Grote f, Y. Honkura

More information

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

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

More information

Transition and turbulence in MHD at very strong magnetic fields

Transition and turbulence in MHD at very strong magnetic fields Transition and turbulence in MHD at very strong magnetic fields Prasanta Dey, Yurong Zhao, Oleg Zikanov University of Michigan Dearborn, USA Dmitry Krasnov, Thomas Boeck, Andre Thess Ilmenau University

More information

Open boundary conditions in numerical simulations of unsteady incompressible flow

Open boundary conditions in numerical simulations of unsteady incompressible flow Open boundary conditions in numerical simulations of unsteady incompressible flow M. P. Kirkpatrick S. W. Armfield Abstract In numerical simulations of unsteady incompressible flow, mass conservation can

More information

Effects of Forcing Scheme on the Flow and the Relative Motion of Inertial Particles in DNS of Isotropic Turbulence

Effects of Forcing Scheme on the Flow and the Relative Motion of Inertial Particles in DNS of Isotropic Turbulence Effects of Forcing Scheme on the Flow and the Relative Motion of Inertial Particles in DNS of Isotropic Turbulence Rohit Dhariwal PI: Sarma L. Rani Department of Mechanical and Aerospace Engineering The

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

Partial Differential Equations

Partial Differential Equations Partial Differential Equations Introduction Deng Li Discretization Methods Chunfang Chen, Danny Thorne, Adam Zornes CS521 Feb.,7, 2006 What do You Stand For? A PDE is a Partial Differential Equation This

More information

The Blue Gene/P at Jülich Case Study & Optimization. W.Frings, Forschungszentrum Jülich,

The Blue Gene/P at Jülich Case Study & Optimization. W.Frings, Forschungszentrum Jülich, The Blue Gene/P at Jülich Case Study & Optimization W.Frings, Forschungszentrum Jülich, 26.08.2008 Jugene Case-Studies: Overview Case Study: PEPC Case Study: racoon Case Study: QCD CPU0CPU3 CPU1CPU2 2

More information

Thermal Analysis Contents - 1

Thermal Analysis Contents - 1 Thermal Analysis Contents - 1 TABLE OF CONTENTS 1 THERMAL ANALYSIS 1.1 Introduction... 1-1 1.2 Mathematical Model Description... 1-3 1.2.1 Conventions and Definitions... 1-3 1.2.2 Conduction... 1-4 1.2.2.1

More information

Chapter 9 Implicit integration, incompressible flows

Chapter 9 Implicit integration, incompressible flows Chapter 9 Implicit integration, incompressible flows The methods we discussed so far work well for problems of hydrodynamics in which the flow speeds of interest are not orders of magnitude smaller than

More information

Foundations of Geomagnetism

Foundations of Geomagnetism Foundations of Geomagnetism GEORGE BACKUS University of California, San Diego ROBERT PARKER University of California, San Diego CATHERINE CONSTABLE University of California, San Diego m.m CAMBRIDGE UNIVERSITY

More information

Available online at ScienceDirect. Procedia Engineering 90 (2014 )

Available online at   ScienceDirect. Procedia Engineering 90 (2014 ) Available online at www.sciencedirect.com ScienceDirect Procedia Engineering 9 (214 ) 599 64 1th International Conference on Mechanical Engineering, ICME 213 Validation criteria for DNS of turbulent heat

More information

Parity of solar global magnetic field determined by turbulent diffusivity

Parity of solar global magnetic field determined by turbulent diffusivity First Asia-Pacific Solar Physics Meeting ASI Conference Series, 2011, Vol. 1, pp 117 122 Edited by Arnab Rai Choudhuri & Dipankar Banerjee Parity of solar global magnetic field determined by turbulent

More information

The spectral transform method

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

More information

Effects of Forcing Scheme on the Flow and the Relative Motion of Inertial Particles in DNS of Isotropic Turbulence

Effects of Forcing Scheme on the Flow and the Relative Motion of Inertial Particles in DNS of Isotropic Turbulence Effects of Forcing Scheme on the Flow and the Relative Motion of Inertial Particles in DNS of Isotropic Turbulence Rohit Dhariwal and Vijaya Rani PI: Sarma L. Rani Department of Mechanical and Aerospace

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

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

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

More information

Multi-D MHD and B = 0

Multi-D MHD and B = 0 CapSel DivB - 01 Multi-D MHD and B = 0 keppens@rijnh.nl multi-d MHD and MHD wave anisotropies dimensionality > 1 non-trivial B = 0 constraint even if satisfied exactly t = 0: can numerically generate B

More information

Why does the magnetic field of the Earth reverse?

Why does the magnetic field of the Earth reverse? IMPRS Solar System Seminar June 2002 Why does the magnetic field of the Earth reverse? Dieter Schmitt (Katlenburg-Lindau) 1. Geomagnetic field >99% of matter in universe is plasma: gas of electrons, ions

More information

Konvektion und solares Magnetfeld

Konvektion und solares Magnetfeld Vorlesung Physik des Sonnensystems Univ. Göttingen, 2. Juni 2008 Konvektion und solares Magnetfeld Manfred Schüssler Max-Planck Planck-Institut für Sonnensystemforschung Katlenburg-Lindau Convection &

More information

Jupiter s Red Spot. Luke McGuire Program in Applied Mathematics University of Arizona. May 21, 2009

Jupiter s Red Spot. Luke McGuire Program in Applied Mathematics University of Arizona. May 21, 2009 Jupiter s Red Spot Luke McGuire Program in Applied Mathematics University of Arizona May 21, 2009 Abstract The Great Red Spot, the largest of Jupiter s long lived, approximately two dimensional, coherent

More information

Numerical methods for the Navier- Stokes equations

Numerical methods for the Navier- Stokes equations Numerical methods for the Navier- Stokes equations Hans Petter Langtangen 1,2 1 Center for Biomedical Computing, Simula Research Laboratory 2 Department of Informatics, University of Oslo Dec 6, 2012 Note:

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

Global Magnetorotational Instability with Inflow

Global Magnetorotational Instability with Inflow Global Magnetorotational Instability with Inflow Evy Kersalé PPARC Postdoctoral Research Associate Dept. of Appl. Maths University of Leeds Collaboration: D. Hughes & S. Tobias (Appl. Maths, Leeds) N.

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

Large scale magnetic fields and Dynamo theory. Roman Shcherbakov, Turbulence Discussion Group 14 Apr 2008

Large scale magnetic fields and Dynamo theory. Roman Shcherbakov, Turbulence Discussion Group 14 Apr 2008 Large scale magnetic fields and Dynamo theory Roman Shcherbakov, Turbulence Discussion Group 14 Apr 2008 The Earth Mainly dipolar magnetic field Would decay in 20kyr if not regenerated Declination of the

More information

A numerical MHD model for the solar tachocline with meridional flow

A numerical MHD model for the solar tachocline with meridional flow Astronomy & Astrophysics manuscript no. aniket March 9, 2005 (DOI: will be inserted by hand later) A numerical MHD model for the solar tachocline with meridional flow A. Sule, G. Rüdiger, and R. Arlt Astrophysikalisches

More information

Stability and Convergence Analysis of Fully Discrete Fourier Collocation Spectral Method for 3-D Viscous Burgers Equation

Stability and Convergence Analysis of Fully Discrete Fourier Collocation Spectral Method for 3-D Viscous Burgers Equation J Sci Comput (01) 53:10 18 DOI 10.1007/s10915-01-961-8 Stability and Convergence Analysis of Fully Discrete Fourier Collocation Spectral Method for 3-D Viscous Burgers Equation Sigal Gottlieb Cheng Wang

More information

SPARSE SOLVERS POISSON EQUATION. Margreet Nool. November 9, 2015 FOR THE. CWI, Multiscale Dynamics

SPARSE SOLVERS POISSON EQUATION. Margreet Nool. November 9, 2015 FOR THE. CWI, Multiscale Dynamics SPARSE SOLVERS FOR THE POISSON EQUATION Margreet Nool CWI, Multiscale Dynamics November 9, 2015 OUTLINE OF THIS TALK 1 FISHPACK, LAPACK, PARDISO 2 SYSTEM OVERVIEW OF CARTESIUS 3 POISSON EQUATION 4 SOLVERS

More information

Spectral simulations of wall-bounded flows on massively-parallel computers

Spectral simulations of wall-bounded flows on massively-parallel computers Paper 1 1 Spectral simulations of wall-bounded flows on massively-parallel computers By Qiang Li, Philipp Schlatter & Dan S. Henningson Linné Flow Centre, KTH Mechanics SE-100 44 Stockholm, Sweden 1.

More information

Contents lecture 6 2(17) Automatic Control III. Summary of lecture 5 (I/III) 3(17) Summary of lecture 5 (II/III) 4(17) H 2, H synthesis pros and cons:

Contents lecture 6 2(17) Automatic Control III. Summary of lecture 5 (I/III) 3(17) Summary of lecture 5 (II/III) 4(17) H 2, H synthesis pros and cons: Contents lecture 6 (7) Automatic Control III Lecture 6 Linearization and phase portraits. Summary of lecture 5 Thomas Schön Division of Systems and Control Department of Information Technology Uppsala

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

Planetary Dynamos: A Brief Overview

Planetary Dynamos: A Brief Overview Planetary Dynamos: A Brief Overview Nick Featherstone Dept. of Applied Mathematics & Research Computing University of Colorado 04/22/15 HAO Colloquium Series 1 ( with contributions and inspiration from

More information

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

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

More information

Ordinary Least Squares and its applications

Ordinary Least Squares and its applications Ordinary Least Squares and its applications Dr. Mauro Zucchelli University Of Verona December 5, 2016 Dr. Mauro Zucchelli Ordinary Least Squares and its applications December 5, 2016 1 / 48 Contents 1

More information

Turbulent three-dimensional MHD dynamo model in spherical shells: Regular oscillations of the dipolar field

Turbulent three-dimensional MHD dynamo model in spherical shells: Regular oscillations of the dipolar field Center for Turbulence Research Proceedings of the Summer Program 2010 475 Turbulent three-dimensional MHD dynamo model in spherical shells: Regular oscillations of the dipolar field By R. D. Simitev, F.

More information

Performance of the fusion code GYRO on three four generations of Crays. Mark Fahey University of Tennessee, Knoxville

Performance of the fusion code GYRO on three four generations of Crays. Mark Fahey University of Tennessee, Knoxville Performance of the fusion code GYRO on three four generations of Crays Mark Fahey mfahey@utk.edu University of Tennessee, Knoxville Contents Introduction GYRO Overview Benchmark Problem Test Platforms

More information

Originally published as:

Originally published as: Originally published as: Mandea, M., Olsen, N. (2009): Geomagnetic and Archeomagnetic Jerks: Where Do We Stand?. - Eos, Transactions, American Geophysical Union, 90, 24, 208-208 From geomagnetic jerks

More information

Stabilization and Acceleration of Algebraic Multigrid Method

Stabilization and Acceleration of Algebraic Multigrid Method Stabilization and Acceleration of Algebraic Multigrid Method Recursive Projection Algorithm A. Jemcov J.P. Maruszewski Fluent Inc. October 24, 2006 Outline 1 Need for Algorithm Stabilization and Acceleration

More information

The method of lines (MOL) for the diffusion equation

The method of lines (MOL) for the diffusion equation Chapter 1 The method of lines (MOL) for the diffusion equation The method of lines refers to an approximation of one or more partial differential equations with ordinary differential equations in just

More information

Research on Structure Formation of Plasmas Dominated by Multiple Hierarchical Dynamics

Research on Structure Formation of Plasmas Dominated by Multiple Hierarchical Dynamics Chapter 4 Epoch Making Simulation Research on Structure Formation of Plasmas Dominated by Multiple Hierarchical Dynamics Group Representative Yasuaki Kishimoto Naka Fusion Research Establishment, Japan

More information

HYPERSONIC AERO-THERMO-DYNAMIC HEATING PREDICTION WITH HIGH-ORDER DISCONTINOUS GALERKIN SPECTRAL ELEMENT METHODS

HYPERSONIC AERO-THERMO-DYNAMIC HEATING PREDICTION WITH HIGH-ORDER DISCONTINOUS GALERKIN SPECTRAL ELEMENT METHODS 1 / 36 HYPERSONIC AERO-THERMO-DYNAMIC HEATING PREDICTION WITH HIGH-ORDER DISCONTINOUS GALERKIN SPECTRAL ELEMENT METHODS Jesús Garicano Mena, E. Valero Sánchez, G. Rubio Calzado, E. Ferrer Vaccarezza Universidad

More information

DIRECT NUMERICAL SIMULATION IN A LID-DRIVEN CAVITY AT HIGH REYNOLDS NUMBER

DIRECT NUMERICAL SIMULATION IN A LID-DRIVEN CAVITY AT HIGH REYNOLDS NUMBER Conference on Turbulence and Interactions TI26, May 29 - June 2, 26, Porquerolles, France DIRECT NUMERICAL SIMULATION IN A LID-DRIVEN CAVITY AT HIGH REYNOLDS NUMBER E. Leriche, Laboratoire d Ingénierie

More information

Incompressible MHD simulations

Incompressible MHD simulations Incompressible MHD simulations Felix Spanier 1 Lehrstuhl für Astronomie Universität Würzburg Simulation methods in astrophysics Felix Spanier (Uni Würzburg) Simulation methods in astrophysics 1 / 20 Outline

More information

Basic Aspects of Discretization

Basic Aspects of Discretization Basic Aspects of Discretization Solution Methods Singularity Methods Panel method and VLM Simple, very powerful, can be used on PC Nonlinear flow effects were excluded Direct numerical Methods (Field Methods)

More information

22. Kinematic Dynamo Theory; Mean Field Theory. We seek solutions to the Induction (dynamo) equation

22. Kinematic Dynamo Theory; Mean Field Theory. We seek solutions to the Induction (dynamo) equation 238 22. Kinematic Dynamo Theory; Mean Field Theory Dynamo Solutions We seek solutions to the Induction (dynamo) equation B/ t = λ 2B + x (u x B) (22.1) that do not decay with time and have no external

More information

A new hybrid numerical scheme for modelling elastodynamics in unbounded media with near-source heterogeneities

A new hybrid numerical scheme for modelling elastodynamics in unbounded media with near-source heterogeneities A new hybrid numerical scheme for modelling elastodynamics in unbounded media with near-source heterogeneities Setare Hajarolasvadi Ahmed E. Elbanna https://www.youtube.com/watch?v=bltx92tuwha MOTIVATION

More information

Solving PDEs with Multigrid Methods p.1

Solving PDEs with Multigrid Methods p.1 Solving PDEs with Multigrid Methods Scott MacLachlan maclachl@colorado.edu Department of Applied Mathematics, University of Colorado at Boulder Solving PDEs with Multigrid Methods p.1 Support and Collaboration

More information

Dedalus: An Open-Source Spectral Magnetohydrodynamics Code

Dedalus: An Open-Source Spectral Magnetohydrodynamics Code Dedalus: An Open-Source Spectral Magnetohydrodynamics Code Keaton Burns University of California Berkeley Jeff Oishi SLAC National Accelerator Laboratory Received ; accepted ABSTRACT We developed the magnetohydrodynamic

More information

Emmanuel DORMY (CNRS / ENS)

Emmanuel DORMY (CNRS / ENS) Emmanuel DORMY (CNRS / ENS) dormy@phys.ens.fr The Earth s internal structure Mantle Fluid outer core ICB 3480 km 6366 km 1221 km Inner core CMB Roberts & King 2013 Governing Equations Governing Equations

More information

ENGI Partial Differentiation Page y f x

ENGI Partial Differentiation Page y f x ENGI 3424 4 Partial Differentiation Page 4-01 4. Partial Differentiation For functions of one variable, be found unambiguously by differentiation: y f x, the rate of change of the dependent variable can

More information

Massive Parallelization of First Principles Molecular Dynamics Code

Massive Parallelization of First Principles Molecular Dynamics Code Massive Parallelization of First Principles Molecular Dynamics Code V Hidemi Komatsu V Takahiro Yamasaki V Shin-ichi Ichikawa (Manuscript received April 16, 2008) PHASE is a first principles molecular

More information

Solving PDEs with CUDA Jonathan Cohen

Solving PDEs with CUDA Jonathan Cohen Solving PDEs with CUDA Jonathan Cohen jocohen@nvidia.com NVIDIA Research PDEs (Partial Differential Equations) Big topic Some common strategies Focus on one type of PDE in this talk Poisson Equation Linear

More information

On the Generation of Core Dynamo Action

On the Generation of Core Dynamo Action On the Generation of Core Dynamo Action CIDER Meeting, KITP 7/7/16 Jonathan Aurnou UCLA Earth & Space Sciences aurnou@ucla.edu Beyond record players? Treat core dynamics as a rotating magnetoconvection

More information

Classification of partial differential equations and their solution characteristics

Classification of partial differential equations and their solution characteristics 9 TH INDO GERMAN WINTER ACADEMY 2010 Classification of partial differential equations and their solution characteristics By Ankita Bhutani IIT Roorkee Tutors: Prof. V. Buwa Prof. S. V. R. Rao Prof. U.

More information

GEODYNAMO: NUMERICAL SIMULATIONS

GEODYNAMO: NUMERICAL SIMULATIONS Comp. by: womat Date:9/2/07 Time:20:05:52 Stage:First Proof File Path://spiina1001z/womat/production/ 302 GEODYNAMO: NUMERICAL SIMULATIONS The energy sources on the right-hand side of Eq. (5) are the same

More information

Power Requirements for Earth s Magnetic Field

Power Requirements for Earth s Magnetic Field Power Requirements for Earth s Magnetic Field QuickTime and a TIFF (Uncompressed) decompressor are needed to see this picture. Bruce Buffett University of Chicago Structure of the Earth Origin of Inner

More information

Dan s Morris s Notes on Stable Fluids (Jos Stam, SIGGRAPH 1999)

Dan s Morris s Notes on Stable Fluids (Jos Stam, SIGGRAPH 1999) Dan s Morris s Notes on Stable Fluids (Jos Stam, SIGGRAPH 1999) This is intended to be a detailed by fairly-low-math explanation of Stam s Stable Fluids, one of the key papers in a recent series of advances

More information

Vector and scalar variables laminar natural convection in 2D geometry arbitrary angle of inclination

Vector and scalar variables laminar natural convection in 2D geometry arbitrary angle of inclination Vector and scalar variables laminar natural convection in 2D geometry arbitrary angle of inclination Miomir Raos and Ljubiša Nešić Abstract The aim of this study 1 is to analyze vector and scalar depending

More information

Reynolds-averaged turbulence model for magnetohydrodynamic dynamo in a rotating spherical shell

Reynolds-averaged turbulence model for magnetohydrodynamic dynamo in a rotating spherical shell PHYSICS OF PLASMAS VOLUME 11, NUMBER 11 NOVEMBER 2004 Reynolds-averaged turbulence model for magnetohydrodynamic dynamo in a rotating spherical shell Fujihiro Hamba a) Institute of Industrial Science,

More information

Lecture 2. Introduction to FEM. What it is? What we are solving? Potential formulation Why? Boundary conditions

Lecture 2. Introduction to FEM. What it is? What we are solving? Potential formulation Why? Boundary conditions Introduction to FEM What it is? What we are solving? Potential formulation Why? Boundary conditions Lecture 2 Notation Typical notation on the course: Bolded quantities = matrices (A) and vectors (a) Unit

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

Global magnetorotational instability with inflow The non-linear regime

Global magnetorotational instability with inflow The non-linear regime Global magnetorotational instability with inflow The non-linear regime Evy Kersalé PPARC Postdoctoral Research Associate Dept. of Appl. Math. University of Leeds Collaboration: D. Hughes & S. Tobias (Dept.

More information

Multi-Scale Modeling of Turbulence and Microphysics in Clouds. Steven K. Krueger University of Utah

Multi-Scale Modeling of Turbulence and Microphysics in Clouds. Steven K. Krueger University of Utah Multi-Scale Modeling of Turbulence and Microphysics in Clouds Steven K. Krueger University of Utah 10,000 km Scales of Atmospheric Motion 1000 km 100 km 10 km 1 km 100 m 10 m 1 m 100 mm 10 mm 1 mm Planetary

More information

Scalable Non-Linear Compact Schemes

Scalable Non-Linear Compact Schemes Scalable Non-Linear Compact Schemes Debojyoti Ghosh Emil M. Constantinescu Jed Brown Mathematics Computer Science Argonne National Laboratory International Conference on Spectral and High Order Methods

More information

MATH 332: Vector Analysis Summer 2005 Homework

MATH 332: Vector Analysis Summer 2005 Homework MATH 332, (Vector Analysis), Summer 2005: Homework 1 Instructor: Ivan Avramidi MATH 332: Vector Analysis Summer 2005 Homework Set 1. (Scalar Product, Equation of a Plane, Vector Product) Sections: 1.9,

More information

9. Iterative Methods for Large Linear Systems

9. Iterative Methods for Large Linear Systems EE507 - Computational Techniques for EE Jitkomut Songsiri 9. Iterative Methods for Large Linear Systems introduction splitting method Jacobi method Gauss-Seidel method successive overrelaxation (SOR) 9-1

More information

10.34 Numerical Methods Applied to Chemical Engineering. Quiz 2

10.34 Numerical Methods Applied to Chemical Engineering. Quiz 2 10.34 Numerical Methods Applied to Chemical Engineering Quiz 2 This quiz consists of three problems worth 35, 35, and 30 points respectively. There are 4 pages in this quiz (including this cover page).

More information

A numerical study of dynamo action as a function of spherical shell geometry

A numerical study of dynamo action as a function of spherical shell geometry Earth and Planetary Science Letters 236 (2005) 542 557 www.elsevier.com/locate/epsl A numerical study of dynamo action as a function of spherical shell geometry M.H. Heimpel a, *, J.M. Aurnou b, F.M. Al-Shamali

More information

Earth System Modeling Domain decomposition

Earth System Modeling Domain decomposition Earth System Modeling Domain decomposition Graziano Giuliani International Centre for Theorethical Physics Earth System Physics Section Advanced School on Regional Climate Modeling over South America February

More information

Computation Fluid Dynamics

Computation Fluid Dynamics Computation Fluid Dynamics CFD I Jitesh Gajjar Maths Dept Manchester University Computation Fluid Dynamics p.1/189 Garbage In, Garbage Out We will begin with a discussion of errors. Useful to understand

More information

Natural convection simulations and numerical determination of critical tilt angles for a parallel plate channel

Natural convection simulations and numerical determination of critical tilt angles for a parallel plate channel Natural convection simulations and numerical determination of critical tilt angles for a parallel plate channel Ilker Tari Middle East Technical University (METU) Mechanical Engineering Dept. E-06 Ankara,

More information

0 Magnetically Confined Plasma

0 Magnetically Confined Plasma 0 Magnetically Confined Plasma 0.1 Particle Motion in Prescribed Fields The equation of motion for species s (= e, i) is written as d v ( s m s dt = q s E + vs B). The motion in a constant magnetic field

More information

Scaling laws for planetary dynamos driven by helical waves

Scaling laws for planetary dynamos driven by helical waves Scaling laws for planetary dynamos driven by helical waves P. A. Davidson A. Ranjan Cambridge What keeps planetary magnetic fields alive? (Earth, Mercury, Gas giants) Two ingredients of the early theories:

More information

Direct Numerical Simulations of converging-diverging channel flow

Direct Numerical Simulations of converging-diverging channel flow Intro Numerical code Results Conclusion Direct Numerical Simulations of converging-diverging channel flow J.-P. Laval (1), M. Marquillie (1) Jean-Philippe.Laval@univ-lille1.fr (1) Laboratoire de Me canique

More information

Modeling of ELM Dynamics for ITER

Modeling of ELM Dynamics for ITER Modeling of ELM Dynamics for ITER A.Y. PANKIN 1, G. BATEMAN 1, D.P. BRENNAN 2, A.H. KRITZ 1, S. KRUGER 3, P.B. SNYDER 4 and the NIMROD team 1 Lehigh University, 16 Memorial Drive East, Bethlehem, PA 18015

More information

Scaling properties of convection-driven dynamos in rotating spherical shells and application to planetary magnetic fields

Scaling properties of convection-driven dynamos in rotating spherical shells and application to planetary magnetic fields Geophys. J. Int. (006) 66, 97 4 doi: 0./j.365-46X.006.03009.x Scaling properties of convection-driven dynamos in rotating spherical shells and application to planetary magnetic fields U. R. Christensen

More information