Rotation & nonlinear effects in shallow water: the Rossby adjustment problem

Size: px
Start display at page:

Download "Rotation & nonlinear effects in shallow water: the Rossby adjustment problem"

Transcription

1 Rotation & nonlinear effects in shallow water: the Rossby adjustment problem Ross Tulloch April 29,

2 1 Shallow water equations Consider, as in [6], a homogeneous incompressible 2D fluid in a channel with negligible vertical velocity, roughly constant horizontal velocity for each vertical column and height h(x, t) shallow relative to typical wavelengths. The total mass in [x 1, x 2 ] at time t is total mass in [x 1, x 2 ] = x2 x 1 ρh(x, t)dx, where ρ is constant. The momentum at (x, t) is ρu(x, t), so integrating vertically gives the mass flux ρu(x, t)h(x, t) and therefore conservation of mass gives: t x2 x 1 ρhdx = ρuh(x 1, t) ρuh(x 2, t) h t + (uh) x = 0. (1) Conservation of momentum is the same as in the Euler equations (ρhu) t + (ρhu 2 + p) x = 0 (2) and the pressure can be eliminated using the hydrostatic balance approximation, integrating vertically from z = 0 (flat bottom) to z = h(x, t) gives p(z) = ρgz p = 1 2 ρgh2, (3) so the momentum equation becomes (hu) t + (hu ) ( ) u 2 gh2 = 0 u t gh x x = 0 (4) when equation (1) is used to cancel the h t term. If we now allow for flow v in the ŷ direction (into the plane), but enforce no y dependence we have the following nonlinear shallow water PDE system h t + uh x + hu x = 0 u t + uu x + gh x = 0 v t + uv x = 0. (5) The shallow water equations describe the motion of a barotropic fluid with free surface and depth much smaller than the horizontal length scale. This 2

3 system of equations is a simplified and tractable version of the primitive equations (Navier-Stokes with rotation and stratification) and is a very useful model in geophysical fluid dynamics. One reason the shallow water model is so important is because there is an analogy between it and descriptions using isopycnal or isentropic co-ordinates, see [11] for more details. 1.1 Adding rotation Now if the channel is also rotating, Coriolis forcing adds important source terms to (5) as follows: h t + uh x + hu x = 0 u t + uu x + gh x = where f is twice the angular velocity. fv v t + uv x = fu, (6) 1.2 Linear shallow water: gravity wave equations One always gains insight into a nonlinear problem by first linearizing about a base state and solving the linearized version of the problem. In this case, the velocity and height fields are linearized about (u, v) = (U, 0) and h = H. So decompose the fields into base and perturbed variables u(x, t) = U + u (x, t), v(x, t) = v (x, t), h(x, t) = H + h (x, t), (7) then substitute these into (6) and cancel all quadratic terms h t + (U + u )h x + (H + h )u x = 0 h t + Uh x + Hu x = 0 u t + (U + u )u x + gh x = fv u t + Uu x + gh x = fv v t + (U + u )v x = fu v t + Uv x = fu. (8) Finally, setting U = 0 (no mean wind) and dropping primes gives the equation set for the Rossby adjustment problem described in [2] and [3], called the gravity wave equations : u t fv + g h x = 0, v t + fu = 0, h t + H u x = 0. (9) 3

4 1.3 Project objectives and outline The goal of this project will be to numerically analyze the time dependent evolution of shallow water equations in various regimes given a particular initial condition. Specifically, the effects of rotation and nonlinearity on geostrophic adjustment (described in the next section) are examined as in [5]. The four regimes are: (a) nonrotating-linear, (b) rotating-linear, (c) nonrotating-nonlinear and (d) rotating-nonlinear. Case (a) is just the wave equation (u tt = ghu xx ), which we can write down the solution for immediately using d Alembert s formula. Case (b) is solved using the stencils shown in Problem 12 of Chapter 3 in [2], ie. using leapfrog on an unstaggered mesh as well as using forward-backward time-differencing on a staggered mesh. An attempt is made to reproduce the cover art on Durran s textbook, which shows the emission of gravity waves during the adjustment process. Case (c) is the classic dam break problem which is solved using conservation law methods, as described in [6], [7]. Case (d) is the most difficult because it involves a nonlinear system with source terms (coriolis forces). In [5] the emphasis is on analyzing the transient behaviour and not numerical method, so they used Leveque s CLAWPACK conservation law package (amath.washington.edu/ claw) to solve (d). While CLAWPACK would be a useful tool to learn in its own right, it is not clear to me that it will handle the source terms properly. In the steady-state, the source terms should be exactly balanced by the flux gradients. To achieve this I will experiment with a central-upwind scheme adapted from [4], which examined the shallow water system with bottom topography as the source term (instead of rotation). 2 The Rossby adjustment problem Rossby was the first to completely discuss the question of how a rotating fluid with an initial perturbation adjusts under gravity. The geostrophic equilibrium that is achieved cannot be found by solving the steady-state equations because they are degenerate in that any solution of the momentum equations satisfies the continuity equation exactly [3]. So the equilibrium state depends on the initial state. 4

5 2.1 Initial conditions The problem discussed by Gill involves the linear evolution of an initial step in the height field, with the rotating fluid initially at rest, so at t = 0 u(x, t = 0) = 0, v(x, t = 0) = 0, { hl η h(x, t = 0) = 0, x < 0 h r η 0, x > 0 (10) 2.2 Steady-state analytical solution of the linear problem The analytical solution of (9) is found by first noting that the potential vorticity is conserved, which in this case means Q t = ( vx t f h ) = 0 (11) H and (10) gives Q(t = 0) = (η 0 /H) sgn(x). Manipulating (9) gives a single second order equation h tt + Hfv x ghh xx = 0 (12) which in steady state, after substituting Q(t = 0) and h for v, becomes and the solution is ghh xx + f 2 h = f 2 η 0 sgn(x) (13) { h 1 + e x/a for x > 0 = η 0 1 e x/a for x < 0, v = gη 0 fa e x /a (14) where a = gh/f is called the Rossby radius of deformation. Figure 1, as in [3], illustrates the initial and steady states. 5

6 Figure 1: Initial height field (top) and geostrophic equilibrium height and meridional velocity (below). The horizontal is scaled by the Rossby radius a = gh/f and the vertical is scaled by the magnitude of the initial height perturbation η 0. Parameter values are g = 10m/s 2, H = 10m and f = 10 4 s Transients in the linear problem The homogenous problem for the height field, upon substituting Q as in (11) for v x in (40), is h tt ghh xx + f 2 h = 0 (15) with initial condition h(t = 0) = η 0 sgn(x) h steady = η 0 e x /a sgn(x) = 2η 0 π 0 ksinkx dk, k 2 + a 2 where k is the horizontal wave number assuming wavelike solutions of the form h e i(kx ωt). Preserving antisymmetry in h, the transient height and 6

7 zonal (u) velocity field are h = 2η 0 π 0 u x = 1 h H t u = 2η 0 g π H v t = fu v = 2fη 0 πh ksinkxcosωt dk, k 2 + a sinωtcoskx dk, k2 + a 2 cosωtcoskx dk (16) k 2 + a 2 where the dispersion relation from (15) is given by ω 2 = f 2 + k 2 gh. An equivalent expression for u in terms of Bessel functions is { η 0 ( ) g u = J π H 0 f t 2 x2 for x < ght gh 0 for x >, (17) ght, and is plotted for various times in Figure 2. Notice the emission of gravity waves from the initial discontinuity. In this study, the nature of gravity wave emission will be analyzed by comparing transients in the zonal velocity u and height h for the 4 regimes discussed in Section 1.3. Also, the adjusted (steady state) height h and meridional velocity v profiles will be compared for the four regimes. Note that the final value of u will be uniformly zero when there s not dependence in the meridional (y) direction. The best possible approximation to the initial conditions in (10) for each numerical scheme will be used. That is, standard finite difference approximations to the linear equations linear equations may require smoothing of the discontinuity over a few grid cells because features of order 2 and smaller are poorly resolved [2]. In Section 4.1 smoothed-out step is used as described in [2] and in Section 4.4 the initial height field has an arctangent profile in order to mimic the cover art of [2]. To compare transients no boundary conditions need be specified, a large periodic domain is sufficient. Nonreflecting (also known as open, radiating, or outflow ) boundary conditions are applied in order to run to steady state. 7

8 Figure 2: Transient profiles of u scaled by 1/η 0 for the initial conditions in equation (10). Parameters are g = 10m/s 2, H = 10m, f = 10 4 s 1. 3 Case (a): Solution of the nonrotating-linear problem In the nonrotating-nonlinear problem there is no meridional velocity (v) and equations (9) reduce to and decouple as u t + g h x = 0, 2 u t gh 2 u 2 x = 0, 2 h t + H u x = 0 (18) 2 h t gh 2 h 2 x = 0 (19) 2 8

9 With initial conditions in (10), the solution is which is plotted in Figure 3. h(x, t) = h(x ght, 0) + h(x + ght, 0), 2 u(x, t) = 1 x+ ght 2 h(s, 0)ds gh s x ght = h(x ght) h(x + ght) 2, (20) gh Figure 3: Transient profiles of h (left) and u (right) for nonrotating-linear adjustment, both scaled by 1/η 0 and plotted against x/a. Parameters are g = 10m/s 2, H = 10m, f = 10 4 s 1. 9

10 4 Case (b): Numerical Solution of the rotatinglinear problem 4.1 Problem 12, Chapter 3: Durran s textbook The inspiration for this project comes from an exercise in [2] which asks to compare solutions of the linearized one-dimensional Rossby adjustment problem obtained using leapfrog on an unstaggered grid versus forward-backward time differencing on a staggered grid. The problem is posed with typical parameter values (f = 10 4 s 1, g = 10m/s 2, H = 10m) and initial conditions (step function as in Figure 1). Note that the initial conditions are smoothed out with three iterative applications of the filter φ f j = 1 4 (φ j+1 + 2φ j + φ j 1 ). (21) Two common schemes are used to solve this problem, the first is leapfrog on an unstaggered mesh δ 2t u fv + gδ 2x h = 0, δ 2t v + fu = 0, δ 2t h + Hδ 2x u = 0. (22) and the second is forward-backward time-differencing on a staggered mesh δ t u n+1/2 j fv n j + gδ x h n j = 0, δ t v n+1/2 j + fu n+1 j = 0, δ t h n+1/2 j+1/2 + Hδ xu n+1 j+1/2 = 0. (23) The results of the two schemes are shown in Figure 4, forward-backward differencing appears to do better than leapfrog for both large and small Courant numbers (see Section 4.3 for explanation of the relevance of Courant numbers for these schemes). The plots show nondimensionalized height and both velocity fields at t = 2 in nondimensional time as question 12 in [2] asks for. See Section 4.5 for transient and steady state plots. Note that both schemes exhibit dispersion due to the sharp gradient ( 3) in the initial condition. 10

11 (a) Leapfrog, CFL=0.9 (b) Leapfrog, CFL=0.1 (c) FBS, CFL=0.9 (d) FBS, CFL=0.1 Figure 4: Plots of h, u, and v fields for leapfrog (top) and forward-backward differencing (bottom) with Courant numbers 0.9 (left) and 0.1 (right) at time t = 21000s ft = 2 on domain x = 600km to x = 1400km. Parameters are g = 10m/s 2, H = 10m, f = 10 4 s 1, = 10 3 km. 4.2 Consistency Consistency is quite easy to show for the above schemes but stability is somewhat more difficult. The unstaggered leapfrog is second order accurate 11

12 and therefore pointwise consistent u n+1 j u n 1 j 2 t h n+1 j fu n j + g hn j+1 h n j 1 2 v n+1 j v n 1 j 2 t h n 1 j 2 t + H un j+1 u n j 1 2 = t2 6 + fu n j = t2 6 = t2 6 3 u t + g v t h t + H h x u x 3 +. (24) The forward-backward staggered time differencing is first order accurate in time and second order accurate in space u n+1 j u n j t fu n j + g hn j+1/2 hn j 1/2 v n+1 j vj n t h n+1 j+1/2 hn j+1/2 t 4.3 Stability = t 2 u 2 2 v + fu n j = t 2 + H un+1 j+1 un+1 j = t 2 t + g t h t + H h x u x 3 +. (25) Since this is a system of equations stability is ensured (sufficient) when the norm of the amplification matrix ( v n k = An k v0 n) is A k 1. (26) A necessary condition for stability is that the spectral radius is less or equal to unity, that is ρ(a k ) 1 (which is sufficient in the case that A is diagonalizable. My attempt to show stability in this way was somewhat unsuccessful. Defining φ, ψ, and χ as past values of u, v, and h respectively gives the amplification matrix for the leapfrog scheme u v h φ ψ χ n+1 j = i2g t sin k 0 2 tf tf i2h t sin k u v h φ ψ χ n j (27) 12

13 To find the norm A k, take the square root of the largest eigenvalue of B = A k A k. After a lengthy hand calculation that Maple appeared unwilling to perform, the characteristic equation of B appears to be (1 λ) 2 [ (1 λ) 2 λ(g 2 α 2 + F 2 ) ] [ (1 λ) 2 λ(h 2 α 2 + F 2 ) ] = 0 λ 2 (2 + g 2 α 2 + F 2 )λ + 1 = 0, λ 2 (2 + H 2 α 2 + F 2 )λ + 1 = 0 (28) where α = (2 t/) sin k and F = 2 tf. Apparently ρ(b) > 1 so this condition is not satisfied, but that does not mean the scheme is necessarily unstable. Progress can be made by taking a dispersion relation approach to derive a necessary condition for stability. Seek wave like solutions of the form u n j = u 0 e i(kj ωn t), v n j = v 0 e i(kj ωn t), h n j = h 0 e i(kj ωn t). (29) In matrix form the unstaggered leapfrog equations become sin ω t g sin k if u t 0 sin ω t if 0 v t 0 = 0 (30) H sin k sin ω t 0 h t 0 which have nontrivial solutions when the determinant is zero, so the dispersion relation is [ ( ) ] 2 1/2 sin ω t sin k = ± f 2 + gh (31) t and ω = 0 is another solution. So a necessary condition for stability in the unstaggered leapfrog scheme is t f 2 + gh 1. (32) 2 Similar analysis on the forward-backward staggered scheme gives the dispersion relation [ ( ) ] 2 1/2 sin ω t sin k/2 t/2 = ± f 2 + gh (33) /2 13

14 so a necessary condition for stability is then f t gh 1. (34) 2 Given the parameters used by Durran in [2] (gh = 100, f = 10 4, = 10 4 /3) it is easy to see that rotation has almost no effect on this condition, which is approximately the same as the condition from the one way wave equation, that is require gh t/ Durran s cover art A side objective of this project is to reproduce, as exactly as possible, the cover art on [2] which shows the emission of gravity waves in the transient profile of the zonal velocity u, see Figure 5. After some tuning, I obtained a Figure 5: Cover art of Dale Durran s textbook: Numerical Methods for Wave Equations in Geophysical Fluid Dynamics [2] showing the time evolution of u(x, t) at t = 943s, t = 1222s, and t = 1501s with initial condition h(x, t = 0) =arctan(x/20km). Parameters are g = 10m/s 2, H = 10m, f = 10 4 s 1, = 10 3 km. very similar plot (Figure 6) using forward-backward time-differencing. The preface of [2] specifies all the parameters used to obtain the plots in Figure 5 14

15 Figure 6: Transient profiles of u for rotating-linear adjustment at times t = 1062 t, t = 1375 t, and t = 1689 t where t = 200s. Parameters are g = 10m/s 2, H = 10m, f = 10 4 s 1, = 3km. except for the time step t. Apparently the times quoted in [2] to produce Figure 5 are actually time step numbers n (unless the parameters of the problem are different), in which case the time step was t 224s. 4.5 Transient and steady-state solutions Adding rotation to the linear equations causes gravity waves to disperse outwards as in Figure 7 and allows for a nonzero steady state to develop, which is shown in Figure 9. The agreement between the analytical solution described in Section 2.3 and the numerical solution is shown in Figure 8. The numerical scheme does a poor job capturing the front as expected because it is a small scale O() feature. Also notice that some dispersion is near the front. Otherwise the numerical scheme matches the analytical prediction quite well. To evolve the system to steady state, outflow boundary 15

16 Figure 7: Transient profiles, using forward-backward time-differencing, of h (left) and u (right) for rotating-linear adjustment, both scaled by 1/η 0 and plotted against x/a. Parameters are g = 10m/s 2, H = 10m, f = 10 4 s 1, = 3km, t = 200s. conditions were applied to the forward-backward scheme u n+1 N = un N t gh un N un N 1 u n+1 1 = u n 1 + t gh un 2 u n 1 h n+1 N 1/2 = hn N 1/2 t gh hn N 1/2 hn N 3/2 h n+1 1/2 = hn 1/2 + t gh hn 3/2 hn 1/2. (35) 16

17 Figure 8: Numerical (solid) versus theoretical transient (dashed) profiles of u at t = 12/f for rotating-linear adjustment. The initial height perturbation was smoothed with 10 iterations of equation (21). The steady height profile is identical to the predicted height profile in Figure 1 while the velocity v has a slightly rounded vertex at x = 0 because the initial conditions were smoothed. 5 Case (c): Solution of the nonrotating-nonlinear problem 5.1 Dam break problem The nonrotating-nonlinear shallow water equations (5) with initial conditions u(x, t = 0) = 0, v(x, t = 0) = 0, { hl η h(x, t = 0) = 0 + H, x < 0 h r η 0 + H, x > 0 (36) 17

18 Figure 9: Initial height field (top) and geostrophic equilibrium height and meridional velocity (below) for the rotating-linear equations. is known as the dam break problem, which is solved semi-analytically in [9] using conservation law theory. In this configuration, a 1-rarefaction wave and a 2-shock form, as illustrated in Figure 10. One can solve for the intermediate state (numerically) by connecting the rightward Riemann invariant with the intermediate state (u, h ) ( u u l = 2 ghl ) gh (37) and using the Rankine-Hugoniot jump conditions on the shock ( ) g h + h r u u r = (h h r ). (38) 2 h h r 18

19 One can solve for the rarefaction state (u(x, t ), h(x, t ) by matching the rightward Riemann invariant with the rarefaction state u l + 2 gh l = u(x, t ) + 2 gh(x, t ) (39) and noting that the leftwards characteristic is valid in the rarefaction giving the solution u(x, t ) gh(x, t ) = x t, (40) ( ) ghl + x u(x, t ) = 2 3 h(x, t ) = 1 9g The total solution is h l, ( 1 h(x, t) = 9g 2 ghl x t h, h r, u(x, t) = 2 3 t (2 ) 2 gh l x. (41) t x < gh l t ) 2, ghl t < x < ( u ) gh t ( u ) gh t < x < ct x > ct u l, x < ( ) gh l t ghl + x t, ghl t < x < ( u ) ( gh t u, u ) gh t < x < ct u r, x > ct (42) (43) where c = (h r u r h u )/(u r u ) is the speed of the shock. With initial conditions (36), u l = u r = 0 so c = h. The solution for h l = 11 and h r = 9 corresponding to η 0 = 1 and H = 10 is plotted in Figure 10. The intermediate state is (u, h ) = ( , ), obtained from equations (37) and (38). 5.2 Finite volume methods Typically, as in [5] and [7], the dam break problem is solved numerically using finite volume methods. Specifically, equation (5) is integrated using Godunov s method with Roe linearization to solve approximate Riemann 19

20 Figure 10: Transient profiles of h (left) and u (right) for nonrotatingnonlinear adjustment, with η 0 = 1 and H = 10. Other parameters are g = 10m/s 2, f = 10 4 s 1. problems. Then to improve accuracy flux (or slope ) limiters are added to the flux term based on local slopes and an entropy fix is applied because the linear equations cannot capture rarefaction waves. The idea behind Godunov s method is to solve piecewise constant local Riemann problems exactly. The exact solution q n (x, t) can be determined by piecing together the solutions of the Riemann problems at each cell interface if the time step t is sufficiently small. The new solution is then defined as the average of the exact solutions over each cell Q n+1 j = 1 xj+1/2 x j 1/2 q n (x, t n+1 )dx (44) which does not need to be explicitly integrated since the conservation law 20

21 Q t + F (Q) x = 0 implies where Q n+1 j = Q n j t (F n j+1/2 F n j 1/2) (45) F n j 1/2 = f(q (Q n j 1, Q n j ) (46) and q (q l, q r ) is the solution to the Riemann problem between states q l and q r. Solving the Riemann problems exactly at each cell is numerically expensive so typically the nonlinear problem q t + f(q) x = 0 is replaced by a locally defined linear problem ˆq + Âj 1/2ˆq x = 0 where  is diagonalizable with real eigenvalues and is consistent with the original conservation law:  j 1/2 f ( q)asq j 1, Q j q. For  to be Roe approximate then it must also satisfy Âj 1/2(Q j Q j 1 ) = f(q j ) = f(q j 1 ). The details of the Roe solver, entropy fix, and flux limiters become quite technical. Since we already have the solution to the dam break problem in Figure 10 let us proceed to the nonlinear-rotating problem and take a look at central upwind schemes. 6 Case (d): Solution of the rotating-nonlinear problem 6.1 Central upwind schemes The idea to solve the rotating-nonlinear problem using a central upwind scheme comes from [4], which analyzed the nonrotating-nonlinear problem with bottom topography h t + (hu) x = 0 (hu) t + (hu ) gh2 = ghb x, (47) where B(x) represents the bottom elevation (topography). The right hand side of (47) acts as a source term analogously to the coriolis terms in (6). taken for such terms to ensure that they exactly the balance the appropriate flux gradients to ensure the correct steady state develops. The authors of [4] claim that standard numerical schemes typically fail to preserve the balance between the fluxes and the source terms. 21 x

22 Central upwind schemes are supposed to be simple, efficient and robust. They are based on Godunov s method in that they are based on an exact evolution of a approximate piecewise polynomial reconstruction and do not require any Riemann solvers. However the major drawback to of central schemes is the large numerical dissipation (O( t) 2r 1 ) where r is a formal order of accuracy [4]. Apparently this dissipation also affects long time simulations such as steady-state computations (as Figure 12 attests). The central upwind scheme for a one dimensional problem given in [5] is as follows. Evolve the cell averaged conservation law with source term S(u(x, t), x, t): d dtūj(t) + f ( u(xj+1/2, t) ) f ( u(x j 1/2, t) ) and the cell average ū is defined as ū j (t) = 1 xj+1/2 Substituting numerical fluxes in (48) gives = 1 xj+1/2 Sdx (48) x j 1/2 x j 1/2 u(x, t)dx. (49) d dtūj(t) = H j+1/2(t) H j 1/2 (t) + S j (t), (50) where the fluxes H j+1/2 are given by H j+1/2 (t) = a+ j+1/2 f(u j+1/2 ) a j+1/2 f(u+ j+1/2 ) a + j+1/2 + a+ j+1/2 a [ ] j+1/2 a j+1/2 a + j+1/2 u + a j+1/2 u j+1/2. j+1/2 Note that u + j+1/2 = p j+1(x j+1/2, t) is the right value of a (conservative, nonoscillatory) piecewise polynomial interpolant at x = x j+1/2 and u j+1/2 = p j+1 (x j+1/2, t) is the corresponding left value at x = x j+1/2. The details of non-oscillatory piecewise quadratic reconstructions are given in the appendix of [4]. Also, the local speeds of propagation a ± j+1/2 eigenvalues of the system { ( ( f f a + j+1/2 = max λ N, λ N ) u (u j+1/2 ) ) a j+1/2 = min { λ 1 ( f u (u j+1/2 ) 22 are determined by the ) u (u+ j+1/2 ) ), λ 1 ( f u (u+ j+1/2 ) }, 0, }, 0, (51)

23 given λ 1 < < λ N. In the Rossby adjustment problem (6) the system eigenvalues are u and u ± gh, obtained from the Jacobian in conservation form p t + f( p) x = 0 (ignoring source terms) p = h hu hv = h r s J = f i p j = f = gh u 2 2u 0 uv v u r r 2 /h + gh 2 /2 rs/h (52). (53) In steady state of the Rossby adjustment problem must support geostrophic balance, which in the one dimensional system (6) with no y-dependence is u = 0, v = g f h x. (54) The conservation form of (6) is h t + (uh) x = 0 (hu) t + (hu ) gh2 = fvh x (hv) t + (huv) x = fuh, (55) so in the numerical discretization we want to balance g 2 (h2 ) x g h 2 j+1/2 h2 j 1/2 2 fv j h j+1/2 + h j 1/2 2 fvh (56) let v j = g f 6.2 Transient and steady state solutions h j+1/2 h j 1/2. (57) Nonlinearity has a few obvious effects on geostrophic adjustment as illustrated in the transient profiles of h and u in Figure 11. First note that the right-left symmetry of the rotating-linear problem in Figure 7 is broken. One would expect this considering the rarefaction wave that developed in 23

24 Figure 11: Transient profiles of h (left) and u (right) for rotating-nonlinear adjustment, with η 0 = 1 and H = 10. Other parameters are g = 10m/s 2, f = 10 4 s 1. the break problem (Figure 10). Notice also that the initial leftward rarefaction wave is overtaken by dispersive wave, which should form a shock but apparently my code is quite dissipative. Numerical dissipation is even more evident in Figure 12 which shows the steady profiles of h and v (after a long simulation time). Part of the dissipation could be because I had trouble with quadratic polynomial interpolants and am currently using only linear interpolants. For more complicated theoretical considerations of the Rossby adjustment problem see [1], [10], and [12]. Also see [5] for a proper numerical study and [8] for a recent experimental study which claims to have quantitatively measured potential vorticity and the flow balance after a geostrophic adjustment for 24

25 Figure 12: Initial height field (top) and geostrophic equilibrium height and meridional velocity (below) for the rotating-nonlinear equations. the first time by taking simultaneous measurements the horizontal velocity field and the vertical density field. 25

26 References [1] Bouchet, F., Submitted 2003: Frontal geostrophic adjustment and nonlinear wave phenomena in one dimensional rotating shallow water. Part 2: high-resolution numerical solutions. Journal of Fluid Mechanics, Cambridge. [2] Durran, D., 1998: Numerical Methods for Wave Equations in Geophysical Fluid Dynamics. Spring-Verglag, New York. [3] Gill, A., 1982: Atmosphere-Ocean Dynamics. International geophysics series, Academic Press, San Diego. [4] Kurganov, A., D. Levy, 2002: Central-Upwind Schemes for the Saint- Venant System. Mathematical Modelling and Numerical Analysis, 36, [5] Kuo, A., L. Polvani: Time-Dependent Fully Nonlinear Geostrophic Adjustment. Journal of Physical Oceanography, 27, [6] LeVeque, R., 1990: Numerical Methods for Conservation Laws. Birkhäuser, Boston. [7] LeVeque, R., 2002: Finite Volume Methods for Hyperbolic Problems. Cambridge University Press, New York. [8] Stegner, A., P. Bouruet-Aubertot, T. Pichon, 2004: Nonlinear adjustment of density fronts. Part 1. The Rossby scenario and the experimental reality. Journal of Fluid Mechanics, 502, [9] Stoker, J., 1958: Water Waves. John Wiley, New York. [10] Reznik, G., V. Zeitlin, M. Ben Jelloul, 2001: Nonlinear theory of geostrophic adjustment. Part I : Rotating shallow water model. Journal of Fluid Mechanics, 481, [11] Vallis, G., 2003: Atmospheric and Ocean Fluid Dynamics. Online text: gkv/aofd. [12] Zeitlin, V., S. Medvedev, R. Plougonven, 2003: Frontal geostrophic adjustment, slow manifold and nonlinear wave phenomena in 1d rotating shallow water. Part 1. Theory. Journal of Fluid Mechanics, 445,

Well-balanced central finite volume methods for the Ripa system

Well-balanced central finite volume methods for the Ripa system Well-balanced central finite volume methods for the Ripa system R. Touma a C. Klingenberg b a Lebanese American University, Beirut, Lebanon b Würzburg University, Würzburg, Germany This paper is dedicated

More information

10 Shallow Water Models

10 Shallow Water Models 10 Shallow Water Models So far, we have studied the effects due to rotation and stratification in isolation. We then looked at the effects of rotation in a barotropic model, but what about if we add stratification

More information

A simple model of topographic Rossby waves in the ocean

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

More information

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

Stable Semi-Discrete Schemes for the 2D Incompressible Euler Equations

Stable Semi-Discrete Schemes for the 2D Incompressible Euler Equations Stable Semi-Discrete Schemes for the D Incompressible Euler Equations Doron Levy Department of Mathematics Stanford University dlevy@math.stanford.edu http://math.stanford.edu/ dlevy Maryland, May 004

More information

High-resolution finite volume methods for hyperbolic PDEs on manifolds

High-resolution finite volume methods for hyperbolic PDEs on manifolds High-resolution finite volume methods for hyperbolic PDEs on manifolds Randall J. LeVeque Department of Applied Mathematics University of Washington Supported in part by NSF, DOE Overview High-resolution

More information

Understanding inertial instability on the f-plane with complete Coriolis force

Understanding inertial instability on the f-plane with complete Coriolis force Understanding inertial instability on the f-plane with complete Coriolis force Abstract Vladimir Zeitlin Laboratory of Dynamical Meteorology, University P. and M. Curie and Ecole Normale Supérieure, Paris,

More information

The shallow water equations Lecture 8. (photo due to Clark Little /SWNS)

The shallow water equations Lecture 8. (photo due to Clark Little /SWNS) The shallow water equations Lecture 8 (photo due to Clark Little /SWNS) The shallow water equations This lecture: 1) Derive the shallow water equations 2) Their mathematical structure 3) Some consequences

More information

Finite Volume Schemes: an introduction

Finite Volume Schemes: an introduction Finite Volume Schemes: an introduction First lecture Annamaria Mazzia Dipartimento di Metodi e Modelli Matematici per le Scienze Applicate Università di Padova mazzia@dmsa.unipd.it Scuola di dottorato

More information

A New Fourth-Order Non-Oscillatory Central Scheme For Hyperbolic Conservation Laws

A New Fourth-Order Non-Oscillatory Central Scheme For Hyperbolic Conservation Laws A New Fourth-Order Non-Oscillatory Central Scheme For Hyperbolic Conservation Laws A. A. I. Peer a,, A. Gopaul a, M. Z. Dauhoo a, M. Bhuruth a, a Department of Mathematics, University of Mauritius, Reduit,

More information

Numerical Methods for Conservation Laws WPI, January 2006 C. Ringhofer C2 b 2

Numerical Methods for Conservation Laws WPI, January 2006 C. Ringhofer C2 b 2 Numerical Methods for Conservation Laws WPI, January 2006 C. Ringhofer ringhofer@asu.edu, C2 b 2 2 h2 x u http://math.la.asu.edu/ chris Last update: Jan 24, 2006 1 LITERATURE 1. Numerical Methods for Conservation

More information

Chapter 5. Shallow Water Equations. 5.1 Derivation of shallow water equations

Chapter 5. Shallow Water Equations. 5.1 Derivation of shallow water equations Chapter 5 Shallow Water Equations So far we have concentrated on the dynamics of small-scale disturbances in the atmosphere and ocean with relatively simple background flows. In these analyses we have

More information

Waves in a Shock Tube

Waves in a Shock Tube Waves in a Shock Tube Ivan Christov c February 5, 005 Abstract. This paper discusses linear-wave solutions and simple-wave solutions to the Navier Stokes equations for an inviscid and compressible fluid

More information

SAMPLE CHAPTERS UNESCO EOLSS WAVES IN THE OCEANS. Wolfgang Fennel Institut für Ostseeforschung Warnemünde (IOW) an der Universität Rostock,Germany

SAMPLE CHAPTERS UNESCO EOLSS WAVES IN THE OCEANS. Wolfgang Fennel Institut für Ostseeforschung Warnemünde (IOW) an der Universität Rostock,Germany WAVES IN THE OCEANS Wolfgang Fennel Institut für Ostseeforschung Warnemünde (IOW) an der Universität Rostock,Germany Keywords: Wind waves, dispersion, internal waves, inertial oscillations, inertial waves,

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

Numerical Methods for Modern Traffic Flow Models. Alexander Kurganov

Numerical Methods for Modern Traffic Flow Models. Alexander Kurganov Numerical Methods for Modern Traffic Flow Models Alexander Kurganov Tulane University Mathematics Department www.math.tulane.edu/ kurganov joint work with Pierre Degond, Université Paul Sabatier, Toulouse

More information

Finite-Volume-Particle Methods for Models of Transport of Pollutant in Shallow Water

Finite-Volume-Particle Methods for Models of Transport of Pollutant in Shallow Water Journal of Scientific Computing ( 006) DOI: 0.007/s095-005-9060-x Finite-Volume-Particle Methods for Models of Transport of Pollutant in Shallow Water Alina Chertock, Alexander Kurganov, and Guergana Petrova

More information

Notes: Outline. Shallow water equations. Notes: Shallow water equations. Notes:

Notes: Outline. Shallow water equations. Notes: Shallow water equations. Notes: Outline Nonlinear hyperbolic systems Shallow water equations Shock waves and Hugoniot loci Integral curves in phase plane Compression and rarefaction R.J. LeVeque, University of Washington IPDE 2011, July

More information

Internal boundary layers in the ocean circulation

Internal boundary layers in the ocean circulation Internal boundary layers in the ocean circulation Lecture 9 by Andrew Wells We have so far considered boundary layers adjacent to physical boundaries. However, it is also possible to find boundary layers

More information

Finite volumes for complex applications In this paper, we study finite-volume methods for balance laws. In particular, we focus on Godunov-type centra

Finite volumes for complex applications In this paper, we study finite-volume methods for balance laws. In particular, we focus on Godunov-type centra Semi-discrete central schemes for balance laws. Application to the Broadwell model. Alexander Kurganov * *Department of Mathematics, Tulane University, 683 St. Charles Ave., New Orleans, LA 708, USA kurganov@math.tulane.edu

More information

Integrodifferential Hyperbolic Equations and its Application for 2-D Rotational Fluid Flows

Integrodifferential Hyperbolic Equations and its Application for 2-D Rotational Fluid Flows Integrodifferential Hyperbolic Equations and its Application for 2-D Rotational Fluid Flows Alexander Chesnokov Lavrentyev Institute of Hydrodynamics Novosibirsk, Russia chesnokov@hydro.nsc.ru July 14,

More information

Numerical Solutions to Partial Differential Equations

Numerical Solutions to Partial Differential Equations Numerical Solutions to Partial Differential Equations Zhiping Li LMAM and School of Mathematical Sciences Peking University Introduction to Hyperbolic Equations The Hyperbolic Equations n-d 1st Order Linear

More information

A Hamiltonian Numerical Scheme for Large Scale Geophysical Fluid Systems

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

More information

PAPER 333 FLUID DYNAMICS OF CLIMATE

PAPER 333 FLUID DYNAMICS OF CLIMATE MATHEMATICAL TRIPOS Part III Wednesday, 1 June, 2016 1:30 pm to 4:30 pm Draft 21 June, 2016 PAPER 333 FLUID DYNAMICS OF CLIMATE Attempt no more than THREE questions. There are FOUR questions in total.

More information

Numerical Solutions for Hyperbolic Systems of Conservation Laws: from Godunov Method to Adaptive Mesh Refinement

Numerical Solutions for Hyperbolic Systems of Conservation Laws: from Godunov Method to Adaptive Mesh Refinement Numerical Solutions for Hyperbolic Systems of Conservation Laws: from Godunov Method to Adaptive Mesh Refinement Romain Teyssier CEA Saclay Romain Teyssier 1 Outline - Euler equations, MHD, waves, hyperbolic

More information

Comparison of cell-centered and node-centered formulations of a high-resolution well-balanced finite volume scheme: application to shallow water flows

Comparison of cell-centered and node-centered formulations of a high-resolution well-balanced finite volume scheme: application to shallow water flows Comparison of cell-centered and node-centered formulations of a high-resolution well-balanced finite volume scheme: application to shallow water flows Dr Argiris I. Delis Dr Ioannis K. Nikolos (TUC) Maria

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

Advanced numerical methods for nonlinear advectiondiffusion-reaction. Peter Frolkovič, University of Heidelberg

Advanced numerical methods for nonlinear advectiondiffusion-reaction. Peter Frolkovič, University of Heidelberg Advanced numerical methods for nonlinear advectiondiffusion-reaction equations Peter Frolkovič, University of Heidelberg Content Motivation and background R 3 T Numerical modelling advection advection

More information

Advection / Hyperbolic PDEs. PHY 604: Computational Methods in Physics and Astrophysics II

Advection / Hyperbolic PDEs. PHY 604: Computational Methods in Physics and Astrophysics II Advection / Hyperbolic PDEs Notes In addition to the slides and code examples, my notes on PDEs with the finite-volume method are up online: https://github.com/open-astrophysics-bookshelf/numerical_exercises

More information

Riemann Solvers and Numerical Methods for Fluid Dynamics

Riemann Solvers and Numerical Methods for Fluid Dynamics Eleuterio R Toro Riemann Solvers and Numerical Methods for Fluid Dynamics A Practical Introduction With 223 Figures Springer Table of Contents Preface V 1. The Equations of Fluid Dynamics 1 1.1 The Euler

More information

Dedicated to the 70th birthday of Professor Lin Qun

Dedicated to the 70th birthday of Professor Lin Qun Journal of Computational Mathematics, Vol.4, No.3, 6, 39 5. ANTI-DIFFUSIVE FINITE DIFFERENCE WENO METHODS FOR SHALLOW WATER WITH TRANSPORT OF POLLUTANT ) Zhengfu Xu (Department of Mathematics, Pennsylvania

More information

2 A: The Shallow Water Equations

2 A: The Shallow Water Equations 2 A: The Shallow Water Equations 2.1 Surface motions on shallow water Consider two-dimensional (x-z) motions on a nonrotating, shallow body of water, of uniform density, as shown in Fig. 1 below. The ow

More information

Lecture Notes on Numerical Schemes for Flow and Transport Problems

Lecture Notes on Numerical Schemes for Flow and Transport Problems Lecture Notes on Numerical Schemes for Flow and Transport Problems by Sri Redeki Pudaprasetya sr pudap@math.itb.ac.id Department of Mathematics Faculty of Mathematics and Natural Sciences Bandung Institute

More information

Lecture Notes on Numerical Schemes for Flow and Transport Problems

Lecture Notes on Numerical Schemes for Flow and Transport Problems Lecture Notes on Numerical Schemes for Flow and Transport Problems by Sri Redeki Pudaprasetya sr pudap@math.itb.ac.id Department of Mathematics Faculty of Mathematics and Natural Sciences Bandung Institute

More information

Spectral element schemes for the. Korteweg-de Vries and Saint-Venant equations

Spectral element schemes for the. Korteweg-de Vries and Saint-Venant equations Spectral element schemes for the Korteweg-de Vries and Saint-Venant equations R. PASQUETTI a a. Université Côte d Azur, CNRS, Inria, LJAD, France, richard.pasquetti@unice.fr... Résumé : Les sytèmes hyperboliques

More information

The RAMSES code and related techniques I. Hydro solvers

The RAMSES code and related techniques I. Hydro solvers The RAMSES code and related techniques I. Hydro solvers Outline - The Euler equations - Systems of conservation laws - The Riemann problem - The Godunov Method - Riemann solvers - 2D Godunov schemes -

More information

6 Two-layer shallow water theory.

6 Two-layer shallow water theory. 6 Two-layer shallow water theory. Wewillnowgoontolookatashallowwatersystemthathastwolayersofdifferent density. This is the next level of complexity and a simple starting point for understanding the behaviour

More information

Introduction to the Finite Volumes Method. Application to the Shallow Water Equations. Jaime Miguel Fe Marqués

Introduction to the Finite Volumes Method. Application to the Shallow Water Equations. Jaime Miguel Fe Marqués Introduction to the Finite Volumes Method. Application to the Shallow Water Equations. Jaime Miguel Fe Marqués Contents Preliminary considerations 3. Study of the movement of a fluid................ 3.

More information

GFD 2013 Lecture 4: Shallow Water Theory

GFD 2013 Lecture 4: Shallow Water Theory GFD 213 Lecture 4: Shallow Water Theory Paul Linden; notes by Kate Snow and Yuki Yasuda June 2, 214 1 Validity of the hydrostatic approximation In this lecture, we extend the theory of gravity currents

More information

Hydraulic Modelling for Drilling Automation

Hydraulic Modelling for Drilling Automation Hydraulic Modelling for Drilling Automation CASA Day Harshit Bansal April 19, 2017 Where innovation starts Team: Supervisors at TU/e : W.H.A. Schilders, N. van de Wouw, B. Koren, L. Iapichino Collaborators:

More information

5. Two-layer Flows in Rotating Channels.

5. Two-layer Flows in Rotating Channels. 5. Two-layer Flows in Rotating Channels. The exchange flow between a marginal sea or estuary and the open ocean is often approximated using two-layer stratification. Two-layer models are most valid when

More information

Scientific Computing I

Scientific Computing I Scientific Computing I Module 10: Case Study Computational Fluid Dynamics Michael Bader Winter 2012/2013 Module 10: Case Study Computational Fluid Dynamics, Winter 2012/2013 1 Fluid mechanics as a Discipline

More information

Instability of a coastal jet in a two-layer model ; application to the Ushant front

Instability of a coastal jet in a two-layer model ; application to the Ushant front Instability of a coastal jet in a two-layer model ; application to the Ushant front Marc Pavec (1,2), Xavier Carton (1), Steven Herbette (1), Guillaume Roullet (1), Vincent Mariette (2) (1) UBO/LPO, 6

More information

Block-Structured Adaptive Mesh Refinement

Block-Structured Adaptive Mesh Refinement Block-Structured Adaptive Mesh Refinement Lecture 2 Incompressible Navier-Stokes Equations Fractional Step Scheme 1-D AMR for classical PDE s hyperbolic elliptic parabolic Accuracy considerations Bell

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

ENO and WENO schemes. Further topics and time Integration

ENO and WENO schemes. Further topics and time Integration ENO and WENO schemes. Further topics and time Integration Tefa Kaisara CASA Seminar 29 November, 2006 Outline 1 Short review ENO/WENO 2 Further topics Subcell resolution Other building blocks 3 Time Integration

More information

Projection Dynamics in Godunov-Type Schemes

Projection Dynamics in Godunov-Type Schemes JOURNAL OF COMPUTATIONAL PHYSICS 142, 412 427 (1998) ARTICLE NO. CP985923 Projection Dynamics in Godunov-Type Schemes Kun Xu and Jishan Hu Department of Mathematics, Hong Kong University of Science and

More information

Exact solutions for shoaling waves in shallow water

Exact solutions for shoaling waves in shallow water Exact solutions for shoaling waves in shallow water Master thesis in Applied and Computational Mathematics Maria Bjørnestad Department of Mathematics University of Bergen February 23, 2017 Acknowledgements

More information

A Central Compact-Reconstruction WENO Method for Hyperbolic Conservation Laws

A Central Compact-Reconstruction WENO Method for Hyperbolic Conservation Laws A Central Compact-Reconstruction WENO Method for Hyperbolic Conservation Laws Kilian Cooley 1 Prof. James Baeder 2 1 Department of Mathematics, University of Maryland - College Park 2 Department of Aerospace

More information

CHAPTER 7 SEVERAL FORMS OF THE EQUATIONS OF MOTION

CHAPTER 7 SEVERAL FORMS OF THE EQUATIONS OF MOTION CHAPTER 7 SEVERAL FORMS OF THE EQUATIONS OF MOTION 7.1 THE NAVIER-STOKES EQUATIONS Under the assumption of a Newtonian stress-rate-of-strain constitutive equation and a linear, thermally conductive medium,

More information

Eigenmode Analysis of Boundary Conditions for the One-dimensional Preconditioned Euler Equations

Eigenmode Analysis of Boundary Conditions for the One-dimensional Preconditioned Euler Equations NASA/CR-1998-208741 ICASE Report No. 98-51 Eigenmode Analysis of Boundary Conditions for the One-dimensional Preconditioned Euler Equations David L. Darmofal Massachusetts Institute of Technology, Cambridge,

More information

Spatial discretization scheme for incompressible viscous flows

Spatial discretization scheme for incompressible viscous flows Spatial discretization scheme for incompressible viscous flows N. Kumar Supervisors: J.H.M. ten Thije Boonkkamp and B. Koren CASA-day 2015 1/29 Challenges in CFD Accuracy a primary concern with all CFD

More information

Sung-Ik Sohn and Jun Yong Shin

Sung-Ik Sohn and Jun Yong Shin Commun. Korean Math. Soc. 17 (2002), No. 1, pp. 103 120 A SECOND ORDER UPWIND METHOD FOR LINEAR HYPERBOLIC SYSTEMS Sung-Ik Sohn and Jun Yong Shin Abstract. A second order upwind method for linear hyperbolic

More information

Modeling Large-Scale Atmospheric and Oceanic Flows 2

Modeling Large-Scale Atmospheric and Oceanic Flows 2 Modeling Large-Scale Atmospheric and Oceanic Flows V. Zeitlin known s of the Laboratoire de Météorologie Dynamique, Univ. P. and M. Curie, Paris Mathematics of the Oceans, Fields Institute, Toronto, 3

More information

Numerical schemes for short wave long wave interaction equations

Numerical schemes for short wave long wave interaction equations Numerical schemes for short wave long wave interaction equations Paulo Amorim Mário Figueira CMAF - Université de Lisbonne LJLL - Séminaire Fluides Compréssibles, 29 novembre 21 Paulo Amorim (CMAF - U.

More information

FDM for wave equations

FDM for wave equations FDM for wave equations Consider the second order wave equation Some properties Existence & Uniqueness Wave speed finite!!! Dependence region Analytical solution in 1D Finite difference discretization Finite

More information

Goals of this Chapter

Goals of this Chapter Waves in the Atmosphere and Oceans Restoring Force Conservation of potential temperature in the presence of positive static stability internal gravity waves Conservation of potential vorticity in the presence

More information

Application of the Kurganov Levy semi-discrete numerical scheme to hyperbolic problems with nonlinear source terms

Application of the Kurganov Levy semi-discrete numerical scheme to hyperbolic problems with nonlinear source terms Future Generation Computer Systems () 65 7 Application of the Kurganov Levy semi-discrete numerical scheme to hyperbolic problems with nonlinear source terms R. Naidoo a,b, S. Baboolal b, a Department

More information

Anti-diffusive finite difference WENO methods for shallow water with. transport of pollutant

Anti-diffusive finite difference WENO methods for shallow water with. transport of pollutant Anti-diffusive finite difference WENO methods for shallow water with transport of pollutant Zhengfu Xu 1 and Chi-Wang Shu 2 Dedicated to Professor Qun Lin on the occasion of his 70th birthday Abstract

More information

Central-Upwind Schemes for Shallow Water Models. Alexander Kurganov. Tulane University Mathematics Department

Central-Upwind Schemes for Shallow Water Models. Alexander Kurganov. Tulane University Mathematics Department Central-Upwind Schemes for Shallow Water Models Alexander Kurganov Tulane University Mathematics Department www.math.tulane.edu/ kurganov Supported by NSF and ONR Shallow Water Equations Shallow water

More information

Finite Volume Method

Finite Volume Method Finite Volume Method An Introduction Praveen. C CTFD Division National Aerospace Laboratories Bangalore 560 037 email: praveen@cfdlab.net April 7, 2006 Praveen. C (CTFD, NAL) FVM CMMACS 1 / 65 Outline

More information

Chapter 3. Stability theory for zonal flows :formulation

Chapter 3. Stability theory for zonal flows :formulation Chapter 3. Stability theory for zonal flows :formulation 3.1 Introduction Although flows in the atmosphere and ocean are never strictly zonal major currents are nearly so and the simplifications springing

More information

Resonant excitation of trapped coastal waves by free inertia-gravity waves

Resonant excitation of trapped coastal waves by free inertia-gravity waves Resonant excitation of trapped coastal waves by free inertia-gravity waves V. Zeitlin 1 Institut Universitaire de France 2 Laboratory of Dynamical Meteorology, University P. and M. Curie, Paris, France

More information

Comparison of Approximate Riemann Solvers

Comparison of Approximate Riemann Solvers Comparison of Approximate Riemann Solvers Charlotte Kong May 0 Department of Mathematics University of Reading Supervisor: Dr P Sweby A dissertation submitted in partial fulfilment of the requirement for

More information

The RAMSES code and related techniques 2- MHD solvers

The RAMSES code and related techniques 2- MHD solvers The RAMSES code and related techniques 2- MHD solvers Outline - The ideal MHD equations - Godunov method for 1D MHD equations - Ideal MHD in multiple dimensions - Cell-centered variables: divergence B

More information

Contents. Parti Fundamentals. 1. Introduction. 2. The Coriolis Force. Preface Preface of the First Edition

Contents. Parti Fundamentals. 1. Introduction. 2. The Coriolis Force. Preface Preface of the First Edition Foreword Preface Preface of the First Edition xiii xv xvii Parti Fundamentals 1. Introduction 1.1 Objective 3 1.2 Importance of Geophysical Fluid Dynamics 4 1.3 Distinguishing Attributes of Geophysical

More information

Notes: Outline. Shock formation. Notes: Notes: Shocks in traffic flow

Notes: Outline. Shock formation. Notes: Notes: Shocks in traffic flow Outline Scalar nonlinear conservation laws Traffic flow Shocks and rarefaction waves Burgers equation Rankine-Hugoniot conditions Importance of conservation form Weak solutions Reading: Chapter, 2 R.J.

More information

Two-layer shallow water system and its applications

Two-layer shallow water system and its applications Proceedings of Symposia in Applied Mathematics Two-layer shallow water system and its applications Jihwan Kim and Randall J. LeVeque Abstract. The multi-layer shallow water system is derived by depth averaging

More information

The Shallow Water Equations

The Shallow Water Equations The Shallow Water Equations Clint Dawson and Christopher M. Mirabito Institute for Computational Engineering and Sciences University of Texas at Austin clint@ices.utexas.edu September 29, 2008 The Shallow

More information

AA214B: NUMERICAL METHODS FOR COMPRESSIBLE FLOWS

AA214B: NUMERICAL METHODS FOR COMPRESSIBLE FLOWS AA214B: NUMERICAL METHODS FOR COMPRESSIBLE FLOWS 1 / 31 AA214B: NUMERICAL METHODS FOR COMPRESSIBLE FLOWS Linearization and Characteristic Relations 1 / 31 AA214B: NUMERICAL METHODS FOR COMPRESSIBLE FLOWS

More information

Flows Induced by 1D, 2D and 3D Internal Gravity Wavepackets

Flows Induced by 1D, 2D and 3D Internal Gravity Wavepackets Abstract Flows Induced by 1D, 2D and 3D Internal Gravity Wavepackets Bruce R. Sutherland 1 and Ton S. van den Bremer 2 1 Departments of Physics and of Earth & Atmospheric Sciences, University of Alberta

More information

AMath 574 February 11, 2011

AMath 574 February 11, 2011 AMath 574 February 11, 2011 Today: Entropy conditions and functions Lax-Wendroff theorem Wednesday February 23: Nonlinear systems Reading: Chapter 13 R.J. LeVeque, University of Washington AMath 574, February

More information

A Fourth-Order Central Runge-Kutta Scheme for Hyperbolic Conservation Laws

A Fourth-Order Central Runge-Kutta Scheme for Hyperbolic Conservation Laws A Fourth-Order Central Runge-Kutta Scheme for Hyperbolic Conservation Laws Mehdi Dehghan, Rooholah Jazlanian Department of Applied Mathematics, Faculty of Mathematics and Computer Science, Amirkabir University

More information

Barotropic geophysical flows and two-dimensional fluid flows: Conserved Quantities

Barotropic geophysical flows and two-dimensional fluid flows: Conserved Quantities Barotropic geophysical flows and two-dimensional fluid flows: Conserved Quantities Di Qi, and Andrew J. Majda Courant Institute of Mathematical Sciences Fall 2016 Advanced Topics in Applied Math Di Qi,

More information

The one-dimensional equations for the fluid dynamics of a gas can be written in conservation form as follows:

The one-dimensional equations for the fluid dynamics of a gas can be written in conservation form as follows: Topic 7 Fluid Dynamics Lecture The Riemann Problem and Shock Tube Problem A simple one dimensional model of a gas was introduced by G.A. Sod, J. Computational Physics 7, 1 (1978), to test various algorithms

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

Chapter 1. Introduction

Chapter 1. Introduction Chapter 1 Introduction Many astrophysical scenarios are modeled using the field equations of fluid dynamics. Fluids are generally challenging systems to describe analytically, as they form a nonlinear

More information

Dispersion in Shallow Water

Dispersion in Shallow Water Seattle University in collaboration with Harvey Segur University of Colorado at Boulder David George U.S. Geological Survey Diane Henderson Penn State University Outline I. Experiments II. St. Venant equations

More information

Weighted Essentially Non-Oscillatory limiters for Runge-Kutta Discontinuous Galerkin Methods

Weighted Essentially Non-Oscillatory limiters for Runge-Kutta Discontinuous Galerkin Methods Weighted Essentially Non-Oscillatory limiters for Runge-Kutta Discontinuous Galerkin Methods Jianxian Qiu School of Mathematical Science Xiamen University jxqiu@xmu.edu.cn http://ccam.xmu.edu.cn/teacher/jxqiu

More information

Calculating Storm Surge and Other Coastal Hazards Using Geoclaw

Calculating Storm Surge and Other Coastal Hazards Using Geoclaw Calculating Storm Surge and Other Coastal Hazards Using Geoclaw Kyle T. Mandli Department of Applied Mathematics University of Washington Seattle, WA, USA Modeling and Computations of Shallow-Water Coastal

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

A general well-balanced finite volume scheme for Euler equations with gravity

A general well-balanced finite volume scheme for Euler equations with gravity A general well-balanced finite volume scheme for Euler equations with gravity Jonas P. Berberich, Praveen Chandrashekar, Christian Klingenberg Abstract We present a second order well-balanced Godunov-type

More information

A numerical study of SSP time integration methods for hyperbolic conservation laws

A numerical study of SSP time integration methods for hyperbolic conservation laws MATHEMATICAL COMMUNICATIONS 613 Math. Commun., Vol. 15, No., pp. 613-633 (010) A numerical study of SSP time integration methods for hyperbolic conservation laws Nelida Črnjarić Žic1,, Bojan Crnković 1

More information

A Two-Level Time-Stepping Method for Layered Ocean Circulation Models: Further Development and Testing

A Two-Level Time-Stepping Method for Layered Ocean Circulation Models: Further Development and Testing A Two-Level Time-Stepping Method for Layered Ocean Circulation Models: Further Development and Testing Robert L. Higdon Department of Mathematics Oregon State University Corvallis, Oregon 97331-4605 This

More information

Chapter 1. Governing Equations of GFD. 1.1 Mass continuity

Chapter 1. Governing Equations of GFD. 1.1 Mass continuity Chapter 1 Governing Equations of GFD The fluid dynamical governing equations consist of an equation for mass continuity, one for the momentum budget, and one or more additional equations to account for

More information

Numerical dispersion and Linearized Saint-Venant Equations

Numerical dispersion and Linearized Saint-Venant Equations Numerical dispersion and Linearized Saint-Venant Equations M. Ersoy Basque Center for Applied Mathematics 11 November 2010 Outline of the talk Outline of the talk 1 Introduction 2 The Saint-Venant equations

More information

Some approximate Godunov schemes to compute. shallow-water equations with topography. Universite de Provence. 39 rue Joliot Curie.

Some approximate Godunov schemes to compute. shallow-water equations with topography. Universite de Provence. 39 rue Joliot Curie. Some approximate Godunov schemes to compute shallow-water equations with topography Thierry Gallouet, Jean-Marc Herard ;, Nicolas Seguin ; Laboratoire d'analyse Topologie et Probabilites - UMR 663 Centre

More information

Chapter 2. The continuous equations

Chapter 2. The continuous equations Chapter. The continuous equations Fig. 1.: Schematic of a forecast with slowly varying weather-related variations and superimposed high frequency Lamb waves. Note that even though the forecast of the slow

More information

A Characteristic-Based Semi-Lagrangian Method for Hyperbolic Systems of Conservation Laws

A Characteristic-Based Semi-Lagrangian Method for Hyperbolic Systems of Conservation Laws 2005 Chinese Journal of Atmospheric Sciences Volume 29, No.1, pp. 21 42 A Characteristic-Based Semi-Lagrangian Method for Hyperbolic Systems of Conservation Laws Houjun Wang and Gour-Tsyh Yeh (Department

More information

Positivity-preserving high order schemes for convection dominated equations

Positivity-preserving high order schemes for convection dominated equations Positivity-preserving high order schemes for convection dominated equations Chi-Wang Shu Division of Applied Mathematics Brown University Joint work with Xiangxiong Zhang; Yinhua Xia; Yulong Xing; Cheng

More information

LEAST-SQUARES FINITE ELEMENT MODELS

LEAST-SQUARES FINITE ELEMENT MODELS LEAST-SQUARES FINITE ELEMENT MODELS General idea of the least-squares formulation applied to an abstract boundary-value problem Works of our group Application to Poisson s equation Application to flows

More information

A Very Brief Introduction to Conservation Laws

A Very Brief Introduction to Conservation Laws A Very Brief Introduction to Wen Shen Department of Mathematics, Penn State University Summer REU Tutorial, May 2013 Summer REU Tutorial, May 2013 1 / The derivation of conservation laws A conservation

More information

Stabilized Spectral Element Approximation of the Saint Venant System Using the Entropy Viscosity Technique

Stabilized Spectral Element Approximation of the Saint Venant System Using the Entropy Viscosity Technique Stabilized Spectral Element Approximation of the Saint Venant System Using the Entropy Viscosity Technique R. Pasquetti, J.L. Guermond, and B. Popov Abstract We consider the Saint Venant system (shallow

More information

Nonlinear Balance on an Equatorial Beta Plane

Nonlinear Balance on an Equatorial Beta Plane Nonlinear Balance on an Equatorial Beta Plane David J. Raymond Physics Department and Geophysical Research Center New Mexico Tech Socorro, NM 87801 April 26, 2009 Summary Extension of the nonlinear balance

More information

Chapter 9. Barotropic Instability. 9.1 Linearized governing equations

Chapter 9. Barotropic Instability. 9.1 Linearized governing equations Chapter 9 Barotropic Instability The ossby wave is the building block of low ossby number geophysical fluid dynamics. In this chapter we learn how ossby waves can interact with each other to produce a

More information

Well-Balanced Schemes for the Euler Equations with Gravity

Well-Balanced Schemes for the Euler Equations with Gravity Well-Balanced Schemes for the Euler Equations with Gravity Alina Chertock North Carolina State University chertock@math.ncsu.edu joint work with S. Cui, A. Kurganov, S.N. Özcan and E. Tadmor supported

More information

CHAPTER 10: Numerical Methods for DAEs

CHAPTER 10: Numerical Methods for DAEs CHAPTER 10: Numerical Methods for DAEs Numerical approaches for the solution of DAEs divide roughly into two classes: 1. direct discretization 2. reformulation (index reduction) plus discretization Direct

More information

arxiv: v2 [math.ap] 1 Jul 2011

arxiv: v2 [math.ap] 1 Jul 2011 A Godunov-type method for the shallow water equations with discontinuous topography in the resonant regime arxiv:1105.3074v2 [math.ap] 1 Jul 2011 Abstract Philippe G. efloch 1 and Mai Duc Thanh 2 1 aboratoire

More information

A Bound-Preserving Fourth Order Compact Finite Difference Scheme for Scalar Convection Diffusion Equations

A Bound-Preserving Fourth Order Compact Finite Difference Scheme for Scalar Convection Diffusion Equations A Bound-Preserving Fourth Order Compact Finite Difference Scheme for Scalar Convection Diffusion Equations Hao Li Math Dept, Purdue Univeristy Ocean University of China, December, 2017 Joint work with

More information

International Engineering Research Journal

International Engineering Research Journal Special Edition PGCON-MECH-7 Development of high resolution methods for solving D Euler equation Ms.Dipti A. Bendale, Dr.Prof. Jayant H. Bhangale and Dr.Prof. Milind P. Ray ϯ Mechanical Department, SavitribaiPhule

More information