54
Discontinuous Galerkin Method for Atmospheric Modeling Ram Nair ([email protected]) Scientific Computing Division (NCAR) April 26, 2005 DGAM – p.1/47

Discontinuous Galerkin Method for Atmospheric Modeling

  • Upload
    others

  • View
    10

  • Download
    0

Embed Size (px)

Citation preview

Page 1: Discontinuous Galerkin Method for Atmospheric Modeling

Discontinuous Galerkin Method

for Atmospheric ModelingRam Nair

([email protected])

Scientific Computing Division (NCAR)

April 26, 2005

DGAM – p.1/47

Page 2: Discontinuous Galerkin Method for Atmospheric Modeling

Discontinuous Galerkin Method (DGM)

Motivation

DGM in Cartesian GeometryDGM in 1D (Algorithm)Modal & Nodal versions

Extension of DGM to 2DCartesian GeometrySpherical Geometry (Cubed-Sphere)

Flux form SW Model

Numerical experiments & Results

Parallel Implementation

Summary

DGAM – p.2/47

Page 3: Discontinuous Galerkin Method for Atmospheric Modeling

DGM: Motivation

DGM may be considered as a hybrid approachcombining the finite-volume and finite-elementmethods.

↑DGAM – p.3/47

Page 4: Discontinuous Galerkin Method for Atmospheric Modeling

DGM: Motivation

DGM may be considered as a hybrid approachcombining the finite-volume and finite-elementmethods.

Advantage:

↑DGAM – p.3/47

Page 5: Discontinuous Galerkin Method for Atmospheric Modeling

DGM: Motivation

DGM may be considered as a hybrid approachcombining the finite-volume and finite-elementmethods.

Advantage:Inherently conservative (Monotonic option)

↑DGAM – p.3/47

Page 6: Discontinuous Galerkin Method for Atmospheric Modeling

DGM: Motivation

DGM may be considered as a hybrid approachcombining the finite-volume and finite-elementmethods.

Advantage:Inherently conservative (Monotonic option)High-order accuracy & High parallel efficiency

↑DGAM – p.3/47

Page 7: Discontinuous Galerkin Method for Atmospheric Modeling

DGM: Motivation

DGM may be considered as a hybrid approachcombining the finite-volume and finite-elementmethods.

Advantage:Inherently conservative (Monotonic option)High-order accuracy & High parallel efficiency“Local” method & AMR capable

↑DGAM – p.3/47

Page 8: Discontinuous Galerkin Method for Atmospheric Modeling

DGM: Motivation

DGM may be considered as a hybrid approachcombining the finite-volume and finite-elementmethods.

Advantage:Inherently conservative (Monotonic option)High-order accuracy & High parallel efficiency“Local” method & AMR capable

Potential: Application in climate and atmosphericchemistry modeling, and NH modeling.

↑ DGAM – p.3/47

Page 9: Discontinuous Galerkin Method for Atmospheric Modeling

DGM: Motivation

DGM may be considered as a hybrid approachcombining the finite-volume and finite-elementmethods.

Advantage:Inherently conservative (Monotonic option)High-order accuracy & High parallel efficiency“Local” method & AMR capable

Potential: Application in climate and atmosphericchemistry modeling, and NH modeling.

Popular in CFD and other engineering applications(Cockburn and Shu 1989-98).

↑ DGAM – p.3/47

Page 10: Discontinuous Galerkin Method for Atmospheric Modeling

DGM: Motivation

DGM may be considered as a hybrid approachcombining the finite-volume and finite-elementmethods.

Advantage:Inherently conservative (Monotonic option)High-order accuracy & High parallel efficiency“Local” method & AMR capable

Potential: Application in climate and atmosphericchemistry modeling, and NH modeling.

Popular in CFD and other engineering applications(Cockburn and Shu 1989-98).

Global SW model: Giraldo et al. (JCP, 2002);Nair, Thomas & Loft (MWR, 2005).

↑ DGAM – p.3/47

Page 11: Discontinuous Galerkin Method for Atmospheric Modeling

DGM in 1D

1D scalar conservation law:

∂U

∂t+∂F (U)

∂x= 0 in Ω × (0, T ),

with initial condition U0(x) = U(x, t = 0), ∀x ∈ Ω

The domain Ω (periodic) is partitioned into Nx

non-overlapping elements (intervals)Ij = [xj−1/2, xj+1/2], j = 1, . . . , Nx, and∆xj = (xj+1/2 − xj−1/2)

j−1

x x x xj+1/2j−1/2 j+3/2j−3/2

j+1IjII

DGAM – p.4/47

Page 12: Discontinuous Galerkin Method for Atmospheric Modeling

DGM-1D: Weak Formulation

A weak formulation of the problem is obtained bymultiplying the PDE by a test function ϕ(x) andintegrating over an element Ij :

Ij

[∂U

∂t+∂F (U)

∂x

]ϕ(x)dx = 0.

Integrating the second term by parts =⇒∫

Ij

∂U(x, t)

∂tϕ(x)dx−

Ij

F (U(x, t))∂ϕ(x)

∂xdx+

F (U(xj+1/2, t))ϕ(x−j+1/2

) − F (U(xj−1/2, t))ϕ(x+j−1/2

) = 0,

where ϕ(x−) and ϕ(x+) denote "left" and "right" limits

DGAM – p.5/47

Page 13: Discontinuous Galerkin Method for Atmospheric Modeling

DGM-1D: Flux term

R

xj−1/2

xj+1/2

Ij

+ +_ ( )( )( ) _( )

L L R

Flux function F (U) is not uniquely defined at xj±1/2

F (U) is replaced by a numerical flux function F (U),dependent on the left and right limits of thediscontinuous function U . At the interface xj+1/2,

F (U)j+1/2(t) = F (U(x−j+1/2

, t), U(x+j+1/2

, t))

Typical flux formulae: Gudunov, Lax-Friedrichs, Roe,HLLC, etc.

DGAM – p.6/47

Page 14: Discontinuous Galerkin Method for Atmospheric Modeling

DGM-1D: LF Flux

For the present study, Lax-Friedrichs numerical flux isused:

F (a, b) =1

2[F (a) + F (b) − α(b− a)] ,

where α is the upper bound on |F ′(U)|.Space discretization:

Let V kh be a finite dimensional space such that

V kh = p : p|Ij

∈ Pk(Ij) where Pk(Ij) is the space ofpolynomials in Ij of degree at most k, ∀ j = 1, . . . , Nx.

The approximate solution Uh(x, t) ≈ U(x, t) and the testfunction ϕh = ϕ are in V k

h .

DGAM – p.7/47

Page 15: Discontinuous Galerkin Method for Atmospheric Modeling

DGM-1D: Space Discretization

Ij

∂Uh(x, t)

∂tϕh(x)dx =

Ij

F (Uh(x, t))∂ϕh(x)

∂xdx−

[F (Uh)j+1/2(t)ϕh(x−

j+1/2) + F (Uh)j−1/2(t)ϕh(x+

j−1/2)],

Choose an orthogonal basis set spanning the spaceV k

h . A set of Legendre polynomials,B = P`(ξ), ` = 0, 1, . . . , k is a good compramisebetween accuracy and efficiency.

Use a high-order Gaussian quadrature rule to evaluatethe integrals, and that defines the computational grid.

For the present study, the Gauss-Lobatto-Legendre(GLL) quadrature rule is employed.

DGAM – p.8/47

Page 16: Discontinuous Galerkin Method for Atmospheric Modeling

DGM-1D: Space Discretization

Map every element Ij onto the reference element[−1,+1].

Introduce a local coordinate ξ ∈ [−1,+1] s.t.,

ξ =2 (x− xj)

∆xj, xj = (xj−1/2+xj+1/2)/2 ⇒ ∂

∂x=

2

∆xj

∂ξ.

Regular

x j−1/2 xj+1/2

jI

+1− 1

ξ

GLL Grid

Reference ElementElement

DGAM – p.9/47

Page 17: Discontinuous Galerkin Method for Atmospheric Modeling

DGM-1D: Discretization (Modal)

For every element Ij , the approximate solution Uj(ξ, t),can be expressed in terms of the variable ξ:

Uj(ξ, t) =k∑

`=0

U `j (t)P`(ξ) for ξ ∈ [−1, 1], where

U `j (t) =

2`+ 1

2

∫ 1

−1Uj(ξ, t)P`(ξ) dξ ` = 0, 1, . . . , k.

By using the properties of the Legendre polynomials

∫ 1

−1P`(ξ)Pm(ξ) dξ =

2

2`+ 1δ`m, and

P`(1) = 1, P`(−1) = (−1)`

DGAM – p.10/47

Page 18: Discontinuous Galerkin Method for Atmospheric Modeling

DGM-1D: ODE (Modal)

Semi-discretized form =⇒

d

dtU `

j (t) =2 `+ 1

∆xj

[∫ 1

−1F (Uj(ξ, t))

∂P`(ξ)

∂ξdξ −

(F (Uj(1))(t) − (−1)`F (Uj(−1))(t)

)]

Map from spectral to physical space (U `j (t) ⇒ Uj(t))

The final approximation can be expressed as

d

dtUj = L(Uj) in (0, T )

DGAM – p.11/47

Page 19: Discontinuous Galerkin Method for Atmospheric Modeling

DGM-1D: Modal Vs Nodal

The nodal basis set is constructed usingLagrange-Legendre polynomials (hi(ξ)) with roots atGauss-Lobatto quadrature points.

Uj(ξ) =k∑

j=0

Uj hj(ξ) for − 1 ≤ ξ ≤ 1,

hj(ξ) =(ξ2 − 1)P ′

k(ξ)

k(k + 1)Pk(ξj) (ξ − ξj).

Semi-discretized form =⇒d

dtUj = L(Uj) in (0, T )

DGAM – p.12/47

Page 20: Discontinuous Galerkin Method for Atmospheric Modeling

Modal vs Nodal

1D basis function for an expansion of order N = 4

−1 −0.65 0 0.65 1

0

1

−1 −0.65 0 0.65 1

0

1

Modal Basis Nodal Basis

DGAM – p.13/47

Page 21: Discontinuous Galerkin Method for Atmospheric Modeling

Time Integration

Total variation diminishing third-order Runge-Kutta(TVD-RK) scheme (Gottlieb et al., 2001)

U (1) = Un + ∆tL(Un)

U (2) =3

4Un +

1

4U (1) +

1

4∆tL(U (1))

Un+1 =1

3Un +

2

3U (2) +

2

3∆tL(U (2)).

where the superscripts n and n+ 1 denote time levels tand t+ ∆t, respectively

Note: The Courant number for the DG scheme isestimated to be 1/(2k + 1), where k is the degree of thepolynomial, however, no theoretical proof exists whenk > 1 (Cockburn and Shu, 1989).

DGAM – p.14/47

Page 22: Discontinuous Galerkin Method for Atmospheric Modeling

DG-1D: Numerical Examples

Ut + Fx(U) = 0, Ω ≡ [−1, 1], periodic domain. For linear advection (Gaussian-hill)

F (U) = U , and for the Burgers Eqn. F (U) = U2/2.

Numerical & Exact Solution Numerical solution

DGAM – p.15/47

Page 23: Discontinuous Galerkin Method for Atmospheric Modeling

DGM in 2D2D scalar conservation law

∂U

∂t+ ∇ · ~F(U) = S(U), in Ω × (0, T ); ∀ (x, y) ∈ Ω

where U = U(x, y, t), ∇ ≡ (∂/∂x, ∂/∂y), ~F = (F,G) isthe flux function, and S is the source term.

Domain: The domain Ω is partitioned into Nx ×Ny

rectangular non-overlapping elements Ωij such that

Ωij = (x, y) |x ∈ [xi−1/2, xi+1/2], y ∈ [yj−1/2, yj+1/2],for i = 1, 2, . . . , Nx; j = 1, 2, . . . , Ny.

DGAM – p.16/47

Page 24: Discontinuous Galerkin Method for Atmospheric Modeling

Weak Galerkin FormulationConsider an element Ωij and an approximate solutionUh in the finite dimensional vector space Vh(Ω).

Multiplication of the basic equation by a test functionϕh ∈ Vh and integration over the element Ωij by parts,results in a weak Galerkin formulation of the problem:

∂t

Ωij

Uh ϕh dΩ −∫

Ωij

~F(Uh) · ∇ϕh dΩ

+

∂Ωij

~F(Uh) · ~nϕh ds =

Ωij

S(Uh)ϕhdΩ

where ~F(Uh) · ~n is analytic flux and ~n is the outward-facing

unit normal vector on the element boundary ∂Ωij.

DGAM – p.17/47

Page 25: Discontinuous Galerkin Method for Atmospheric Modeling

DGM: Flux termAlong the boundaries of an element ∂Ωij, the functionUh is discontinuous.

Therefore, the analytic flux F(Uh) · ~n must be replacedby a numerical flux F (U−

h , U+h )

U−

h and U+h are the left and right limits of the

discontinuous function Uh

U +hU_

Uh Uhh

After Num. Flux Operation

Element (Left) Element (Right)Element (Right)Element (Left)

DGAM – p.18/47

Page 26: Discontinuous Galerkin Method for Atmospheric Modeling

DGM: Numerical FluxNumerical flux resolves the discontinuity of theelement edges and provides only mechanism by whichadjacent element interact.

A variety of numerical flux schemes are available forthe Reimann problem (Cockburn & Shu, 2001).

For simplicity, the Lax-Friedrichs numerical flux is used:

F(U−

h , U+h ) =

1

2

[(F(U−

h ) + F(U+h )) · ~n− α(U+

h − U−

h )],

For a system, α is the upper bound for the absolutevalue of eigenvalues of the flux Jacobian F ′(U).

DGAM – p.19/47

Page 27: Discontinuous Galerkin Method for Atmospheric Modeling

Discretization (Modal)Choose a modal (orthogonal) basis as a set ofLegendre polynomials, B = P`(ξ), ` = 0, 1, . . . , NMap (x, y) ⇒ (ξ, η) ∈ [−1, 1] ⊗ [−1, 1], reference elementsuch that ξ = 2(x− xi)/∆xi, η = 2(y − yj)/∆yj.

Expand approximate solution Uij and test function interms of tensor-product functions from the basis set.

Uij(ξ, η, t) =N∑

`=0

N∑

m=0

Uij`m(t)P`(ξ)Pm(η), where

Uij`m(t) =(2 `+ 1)(2m+ 1)

4

∫ 1

−1

∫ 1

−1U(ξ, η, t)P`(ξ)Pm(η) dξ dη.

DGAM – p.20/47

Page 28: Discontinuous Galerkin Method for Atmospheric Modeling

Discretization (Nodal)The nodal basis set is constructed using atensor-product of Lagrange-Legendre polynomials(hi(ξ)) with roots at Gauss-Lobatto quadrature points.

Uij(ξ, η) =N∑

i=0

N∑

j=0

Uij hi(ξ)hj(η) for − 1 ≤ ξ, η ≤ 1,

hi(ξ) =(ξ2 − 1)P ′

N (ξ)

N(N + 1)PN (ξi) (ξ − ξi).

Final form for the modal discretization

d

dtUij`m(t) =

(2 `+ 1)(2m+ 1)

2 ∆xi ∆yj[IGrad + IFlux + ISource] ,

DGAM – p.21/47

Page 29: Discontinuous Galerkin Method for Atmospheric Modeling

Time integrationEvaluate the integrals (RHS) using GLL quadraturerule.

Solve the ODE

d

dtU = L(U) in (0, T )

A third-order total variation diminishing (TVD)Runge-Kutta scheme (same as in the case of 1D)without a filter or limiter.

DGAM – p.22/47

Page 30: Discontinuous Galerkin Method for Atmospheric Modeling

2D Cartesian: Solid-body rotation test

Gaussian-Hill: U(x, y) = a0 exp(−r2), r2 = (x− π/2)2 + y2,Ω ≡ [−π, π]2 (400 elements, k = 3)

Initial solution Numerical solution after one rotation

DGAM – p.23/47

Page 31: Discontinuous Galerkin Method for Atmospheric Modeling

2D Cartesian: Convergence

400 1600 6400 2560010

−10

10−8

10−6

10−4

10−2

100

2D h−error (rotation)

Err

or (

log

scal

e)

N

k=1k=2k=3k=4

1 2 3 4 5 6 7 810

−14

10−12

10−10

10−8

10−6

10−4

10−2

100

2D p−error (rotation)

Err

or (

log

scal

e)

Degree of Legendre polynomial

40 x 40 grid160 x 160 grid

Solid-body rotation of a Gaussian-Hill

DGAM – p.24/47

Page 32: Discontinuous Galerkin Method for Atmospheric Modeling

2D: Limiter OptionMontonic option for DGM: WENO limiter

2040

6080

100120

140160 20

4060

80100

120140

160

−1

−0.5

0

0.5

1

2040

6080

100120

140160 20

4060

80100

120140

−1

−0.5

0

0.5

1

Non-smooth Vortex on a (1600 × 4 × 4) grid. Exact vs Numerical solutions, after 3 time units

DGAM – p.25/47

Page 33: Discontinuous Galerkin Method for Atmospheric Modeling

DGM: Spherical GeometryThe sphere is decomposed into 6 identical regions,using the central (gnomonic) projection:x = a tanλ, y = a tan θ secλ, 2a is the cube side.

Local coordinate systems are free of singularitieshave identical metric termscreates a non-orthogonal curvilinear coordinatesystem

Metric tensor of the transformation is defined asGij ≡ ai · aj , i, j ∈ 1, 2.

The components of the covariant vectors (ui) and thecontravariant vectors (ui) are related through:

ui = Gijuj , ui = Gijuj , Gij = (Gij)

−1

DGAM – p.26/47

Page 34: Discontinuous Galerkin Method for Atmospheric Modeling

Equiangular ProjectionCentral angles x1, x2 ∈ [−π/4, π/4] are the independentvariables. Let ρ2 = 1 + tan2 x1 + tan2 x2, metric tensor

Gij =R2

ρ4 cos2 x1 cos2 x2

[1 + tan2 x1 − tanx1 tanx2

− tanx1 tanx2 1 + tan2 x2

]

Z

P

P P P P

P

1 2 34

5

6

X

Y

P1

(Bottom)

(Top)

DGAM – p.27/47

Page 35: Discontinuous Galerkin Method for Atmospheric Modeling

Transform: Cube ⇔ SphereThe spherical velocity vector v(λ, θ) = (u, v), can beexpressed in terms of covariant vector u1 = v · a1,u2 = v · a2, ⇒ v = u1

a1 + u2a2.

Metric tensor of the transformation is defined by

Gij = ATA; A =

[R cos θ ∂λ/∂x1 R cos θ ∂λ/∂x2

R∂θ/∂x1 R∂θ/∂x2

]

The matrix A can be used for transforming sphericalvelocity (u, v) to the cubed-sphere velocity vectors.

A

[u1

u2

]=

[u

v

]

DGAM – p.28/47

Page 36: Discontinuous Galerkin Method for Atmospheric Modeling

SWE on the Cubed-SphereIn curvilinear coordinates, the continuity and momentumequations for the flux form shallow water system can bewritten as follows (Sadourny 1972; Rancic et al. 1996;Nair et al. 2005 (MWR)) :

∂t(√Gh) +

∂x1(√Gu1h) +

∂x2(√Gu2h) = 0,

∂u1

∂t+

∂x1E =

√Gu2(f + ζ),

∂u2

∂t+

∂x2E = −

√Gu1(f + ζ),

where

G = det(Gij), E = Φ+1

2(u1 u

1 +u2 u2), ζ =

1√G

[∂u2

∂x1− ∂u1

∂x2

]

DGAM – p.29/47

Page 37: Discontinuous Galerkin Method for Atmospheric Modeling

Flux form SWE∂

∂tU +

∂x1F1(U) +

∂x2F2(U) = S(U)

where U =[√

Gh, u1, u2

]T, F1 =

[√Ghu1, E, 0

]T

F2 =[√

Ghu2, 0, E]T

, S =[0,√Gu2(f + ζ),−

√Gu1(f + ζ)

]T.

Each face of the cubed-sphere is partitioned intoNe ×Ne rectangular non-overlapping elements Ωij

Each element is mapped onto the reference element[−1, 1] ⊗ [−1, 1]

Total number of elements on the cubed sphere is6 ×Ne ×Ne.

DGAM – p.30/47

Page 38: Discontinuous Galerkin Method for Atmospheric Modeling

Computational Domain

Cubed-Sphere (Ne = 5) with 8 × 8 GLL points

ξ

(−1, 1)

ξ(−1, −1) (1, −1)

(1, 1)

1

2

SWE test suite by Williamson et al. (1992, JCP).

DGAM – p.31/47

Page 39: Discontinuous Galerkin Method for Atmospheric Modeling

Flux computation at cube edges

Face − A

x

yx

y

Face − B

To compute the flux on the edge of the cubed-sphere, Pn,both the left and right components F−

n and F+n are required.

Al

2

4

F+

l

G+

l

3

5 =

2

4

F+s

G+s

3

5 , A−1n

2

4

F+s

G+s

3

5 =

2

4

F+n

G+n

3

5 ⇒ A−1n Al

2

4

F+

l

G+

l

3

5 .

DGAM – p.32/47

Page 40: Discontinuous Galerkin Method for Atmospheric Modeling

SW Test-1

Numerical Flux: Lax-Friedrichs; eigenvalues of F ′(U)

α1 = max(|u1| +

√ΦG11

), α2 = max

(|u2| +

√ΦG22

)

SW Test case-1: Solid-body rotation of a cosine-bell (α = π/4)

DGAM – p.33/47

Page 41: Discontinuous Galerkin Method for Atmospheric Modeling

SW Test-1: Modal & Nodal

Modal vs Nodal DGM vs SEM

DGAM – p.34/47

Page 42: Discontinuous Galerkin Method for Atmospheric Modeling

SW Test-1: MovieSW1 Movie

DGAM – p.35/47

Page 43: Discontinuous Galerkin Method for Atmospheric Modeling

Deformational FlowIdealized Cyclogenisis: (Doswell 1985; Nair et al. 1999).

ψ(λ′, θ′, t) = 1 − tanh

[ρ′(θ′)

γsin(λ′ − ω′t)

]

Max error is O(10−6).

DGAM – p.36/47

Page 44: Discontinuous Galerkin Method for Atmospheric Modeling

Deformational FlowVoretx Movie

DGAM – p.37/47

Page 45: Discontinuous Galerkin Method for Atmospheric Modeling

SW Test-2: Geostrophic Flow

Steady state geostrophic flow (α = π/4). Max height error is O(10−6) m.

DGAM – p.38/47

Page 46: Discontinuous Galerkin Method for Atmospheric Modeling

SW Test-5: Flow over a mountain

Zonal flow over a mountain: (864 × 4 × 4) grid, after 5 and 15 days of integration

DGAM – p.39/47

Page 47: Discontinuous Galerkin Method for Atmospheric Modeling

SW5 MovieSW5 Movie

DGAM – p.40/47

Page 48: Discontinuous Galerkin Method for Atmospheric Modeling

SW Test-6: Rossby-Haurwitz Wave

(864 × 4 × 4) Grid.

DGAM – p.41/47

Page 49: Discontinuous Galerkin Method for Atmospheric Modeling

SW6 MovieSW6 Movie

DGAM – p.42/47

Page 50: Discontinuous Galerkin Method for Atmospheric Modeling

Parallel PerformanceStrong Scaling: Hold total work constant, increasenumber of processes.

Expect to cut runtime in half by doubling processcount.In reality, computation time decreases butcommunication time remains approx. constant.

Weak Scaling: Hold work per process constant,regardless of process count.

Expect runtime to remain constant, regardless ofprocess count.Since computation time remains constant,communication time has similar effect at allprocess counts.

Primarily interested in strong scaling.

DGAM – p.43/47

Page 51: Discontinuous Galerkin Method for Atmospheric Modeling

Performance - HemisphereLinux cluster with 64 DP nodes, Intel Xenon 2.4 GHz,8 × 8 Dolphin torus

0

100

200

300

400

500

128 32 8 2

Sustained MFLOP/sec/processor

Processors

150 ( 5 x 5 x 6) elements, strong scaling, 1/2384 ( 8 x 8 x 6) elements, strong scaling, 1/2var (ne x ne x 6) / P =150, weak scaling, 1/2384 ( 8 x 8 x 6) elements, strong scaling, 1/2 (optimized)

Note: 350 Mflop/Sec ≈ 14.5% peak

DGAM – p.44/47

Page 52: Discontinuous Galerkin Method for Atmospheric Modeling

Performance - FrostIBM BG/L, 1024 DP nodes, 700 MHz PPC 440s,8 × 8 × 16 torus and tree

0

50

100

150

200

250

300

350

400

2048 1024 512 128 32 8 2

Sustained MFLOP/sec/processor

Processors

1536 (16 x 16 x 6) elements, strong scaling, 1/21536 (16 x 16 x 6) elements, strong scaling, 2/2

Note: 225 Mflop/Sec ≈ 8.0% peak

DGAM – p.45/47

Page 53: Discontinuous Galerkin Method for Atmospheric Modeling

SummaryDiscontinuous Galerkin Method (DGM) based flux formshallow water model has been developed on thecubed-sphere (Nair et al. 2005 (MWR))

Both modal and nodal versions give almost identicalresults

The DG model has been implemented in NCARhigh-order method modeling (HOMME) frame work.

Numerical results either comparable or better than astandard spectral element method and DG schemeexhibits exponential convergence for SW test case-2

DG solutions of the SW test cases are much betterthan those of a spectral model (Jacob-Chien et al.1995) for a given spatial resolution.

DGAM – p.46/47

Page 54: Discontinuous Galerkin Method for Atmospheric Modeling

SummaryFor high-order spatial discretization, the solution do notexhibit spurious oscillation for the flow over a mountaintest case.

DG model conserves mass to machine precision.Conservation of total energy and enstrophy is betterpreserved than the existing finite-volume models.

Initial scaling results are promising.

Future work: Development of a 3D DGAM dynamicalcore, efficient time integration scheme, limiters,performance study on BG/L.

DGAM – p.47/47