• No results found

Continuation of a single layer flow over an obstacle

N/A
N/A
Protected

Academic year: 2021

Share "Continuation of a single layer flow over an obstacle"

Copied!
26
0
0

Bezig met laden.... (Bekijk nu de volledige tekst)

Hele tekst

(1)

Continuation of a single

layer flow over an obstacle

Jan Willem Greidanus

0 1 2 3 4 5 6 7 8 9 10

0 1 2 3 4 5 6 7 8 9 10

Bachelor Thesis in Applied Mathematics

Supervisor(s): F.W. Wubs October 2008

(2)
(3)

Continuation of a single

layer flow over an obstacle

Jan Willem Greidanus

Supervisor(s):

F.W. Wubs

Institute of Mathematics and Computing Science P.O. Box 407

9700 AK Groningen

The Netherlands

(4)
(5)

Contents

1 Introduction 1

2 Basic Equations 3

2.1 Derivation of the Shallow Water Equations . . . 3

2.2 The Conservative Form . . . 4

2.3 Froude Number . . . 5

2.4 Solution to the Linear Hydrostatic Flow Problem . . . 6

2.5 Eigenvalue Problem . . . 7

3 Numerical Model 9 3.1 Space Discretization . . . 9

3.2 Solution Method . . . 10

3.3 Matlab Program . . . 11

3.4 Generalized Eigenvalue Problem . . . 11

4 Numerical Results 13 4.1 Numerical Eigenvalue Spectra for the Linear Hydrostatic Flow Problem . . . 13

4.2 Solutions Of The Model . . . 14

4.3 Subcritical To Supercritical . . . 15

5 Conclusions 17

iii

(6)

iv CONTENTS

(7)

Contents

0

(8)

Chapter 1

Introduction

In this text I will investigate steady single layer flow over an obstacle of which the height will be increased slowly to see what this does to the solutions and eigenvalues of the model. If the obstacle is not too high we will have completely subcritical flow. However, at a certain height the flow may become supercritical.

First I will introduce the basic equations for this problem. These will be derived from the Navier-Stokes equations. Using some assumptions and simplifications we arrive at the equations for our specific problem. After that I will derive the analytical solution to the linearized equations and look at what this solution can learn us about the transition from sub- to supercritical flow. This means we will look at the eigenvalue problem for a perturbation of the linear equations.

Furthermore we take a look at the model that we need for the numerical analysis and what methods are used. We can come up with an eigenvalue problem related to the discretized equations and this is important for the numerical research. After that I will investigate numerical solutions of the equations and look what happens with the eigenvalues when we go from sub- to supercritical flow

1

(9)

2 CHAPTER 1. INTRODUCTION

(10)

Chapter 2

Basic Equations

2.1 Derivation of the Shallow Water Equations

For research in fluid dynamics one usually starts with the Navier-Stokes equations. For a Newtonian fluid these equations are given by: The momentum equation

ρDu

Dt = −∇p + ρF + µ∆u (2.1)

and the continuity equation:

∂ρ

∂t + ∇ · (ρu) (2.2)

Here u = (u, v, w) is the velocity in Cartesian directions (x, y, z). Throughout this text incompressible flow will be considered, hence ∂ρ∂t = 0 and the continuity equation can be simplified to

∇u = 0

When working with an incompressible homogeneous inviscid fluid we get:

Du Dt = −1

ρ∇p + F where F will be given by gravity, so

Du Dt = −1

ρ∇p − gz (2.3)

Here DuDt is the material derivative:

Du Dt = ∂u

∂t + (u · ∇)u

z is in the vertical upward direction, furthermore a bottom topography is considered to be given by z = h(x, y). Because this topography or bottom profile has a considerable influence on the flow properties we will make different choices for the maximum of h. The boundary condition on this bottom for inviscid fluid, is that the velocity normal to h is zero, this can be written as

u ·

 1 hx hy

 = 0 (2.4)

3

(11)

4 CHAPTER 2. BASIC EQUATIONS on z = h(x, y). On the free surface η = d−d0+h which is the displacement from the mean level z = d0 of the free surface, we need two boundary conditions. Because the mass of any fluid above this surface is negligible, we can take the pressure at the surface to be constant, so p = p0(hydrostatic pressure). We can now use Bernoulli’s Law and state the dynamic free surface boundary condition

· u v

¸

t

+1

2(u2+ v2) + gη = 0 (2.5)

The second boundary condition on the free surface is the kinematic free surface condition, it guarantees that there will be no fluid above the free surface. In mathematical terms this is

ηt+ uηx+ vηy = w (2.6)

In any flow it is possible to write the equations in terms of vorticity rather then velocity, this is done by taking the curl of the equation. (may have to apply the 2nd Fundamental Theorem of Calculus to do this rigorously ) in our case this gives

Dt = ω · ∇u

In our case the flow is initially rotation free (ω = 0) and that means it will be so throughout.

If everywhere the vertical accelerations DDt2w2 are much less then gravity the flow can be called hydrostatic, so we have −ρ1

0

∂p

∂z−g = 0. We call the scale of the horizontal fluid motions L, this means that the above approximation holds if (dL0)2 << 1. The pressure within the fluid will then be given by p = p0+ ρ0g(d0+ η − z) and so the horizontal pressure gradient is independent of z, so if u and v are initially independent of z, this will be the case throughout.

We can now state that the following set of equations describe the motion of the flow:

ut+ uux+ vuy = −gηx (2.7)

vt+ uvx+ vvy = −gηy (2.8)

ηt+ (du)x+ (dv)y = 0 (2.9)

Where d = d0+ η − h is the thickness of the fluid layer.

2.2 The Conservative Form

In this text I will consider a flow of a layer of fluid of thickness d(x, t) with velocity u(x, t).

The bottom will be given by h(x) in which the flow will encounter an (long) obstacle, in the middle of the region of interest, with given height and shape. The Width of the channel is considered equal at every point in the flow. η Is the displacement from the equilibrium depth d0. These assumptions lead to the following differential equations:

ut+ uux= −gηx (2.10)

dt+ (du)x= 0 (2.11)

(12)

2.3. FROUDE NUMBER 5 The second is already in conservative form. To get the first equations into conservative form, we multiply (2.10), (2.11) by d and u respectively, so we have

dut+ (du)ux+ gdηx = 0 (2.12)

dtu + u(du)x= 0 (2.13)

The reason to use this conservative form [WIKI] is that they can deal with phenomena that normally break down the assumptions essential for the usage of the shallow water equations, like hydraulic jumps which are possible in this setting [BAI03]. when we add (2.12) and (2.13) and use (du)t= dut+ udtand (du2)x = (du)ux+ u(du)x= (du)ux+ udux+ u2dx. We end up with

(du)t+ (du2)x+ gdηx= 0 (2.14)

or using η = d − d0+ h and making the equation time independent (du2)x+ (1

2gd2)x+ gdhx = 0 (2.15)

For the time independent case equation 2.11 is simply equal to

∂du

∂x = 0 (2.16)

or

urdr= uldl

Where ur and dr are the velocity and depth at a point right and ul and dl are the velocity and depth at a point to the left. Those points can be any points in the x direction, because of the steady flow we consider. This means we can easily choose the left and right points exactly at our mesh points. This equation guarantees that the same amount of fluid passes through every point all the time.

2.3 Froude Number

The so-called Froude Number F , named after William Froude (1810-1879), is an important dimensionless parameter, for shallow flow over an obstacle. It has the form F = Ugl with U the fluid speed, g the gravitational acceleration and l is a length. There are different choices for the length l. It may be the length or the height of the obstacle. Another possibility is to take the depth of the stream. These different choices for l lead to different dynamical interpretations of the Froude Number. This is in contradiction to the Reynolds number in which also different lengths can be used, but the interpretations are the same, namely viscous flow for small Reynolds number and turbulent for large Reynolds numbers analogous to sub- and supercritical flow for the Froude Number.

In this study I will use the local depth of the stream d for the length in the Froud Number, however it was never used in this way by William Froude, it is the most common choice in hydraulics of streams. In our single-layer flow it then represents the local fluid speed divided by the local significant wave speed. Hence the Froude number depends on the position in the computational domain. The Froude number thus gives a measure to what extend long linear gravity waves will propagate against the stream(First derived by Lagrange).

In general flow with a Froude number F below one is called subcritical, F equal to one critical and F larger then one supercritical.

(13)

6 CHAPTER 2. BASIC EQUATIONS

2.4 Solution to the Linear Hydrostatic Flow Problem

We consider a uniform stream of magnitude U in the x-direction. In this flow we insert a long obstacle with small height, with topography given by z = h(x, y). We linearize the equations about the initial state (u = U + u0) and get:

u0t+ U u0x = −gηx vt+ U vx = −gηy ηt+ U ηx+ d0(u0x+ vy) = U hx

For the one-dimensional problem we can drop the second equation and take vy = 0 thus for an even bottom we have

ut= −U ux− gηx (2.17)

dt= −(du)x= −U dx− d0Ux (2.18) We can write this system of differential equations in matrix vector notation

· u d

¸

t

= −

· U g d0 U

¸ · u d

¸

x

(2.19)

This system is diagonizable, but by symmetrizing the matrix we can easily find the resulting scalar equations.

"

1 0

0 qg

d0

# · U g d0 U

¸ " 1 0 0

qd0

g

#

=

· U

gd0

√gd0 U

¸

(2.20)

Thus the system can be written as

"

qu

g d0d

#

t

= −

· U

gd0

√gd0 U

¸ " qu

g d0d

#

x

(2.21)

hence

(u + r g

d0d)t= −(U +p

gd0)(u + r g

d0d)x (2.22)

(u − r g

d0d)t= −(U −p

gd0)(u − r g

d0d)x (2.23)

so

(u + r g

d0d) = f (x − (U +p

gd0)t) (2.24)

(u − r g

d0d) = g(x − (U −p

gd0)t) (2.25)

(14)

2.5. EIGENVALUE PROBLEM 7

2.5 Eigenvalue Problem

Because we are interested in the perturbation of steady states we will now take a look at the eigenvalue problem related to (2.17) and (2.18). In matrix vector notation this is

· −λ + U∂x g∂x d0∂x −λ + U∂x

¸ · u0 η0

¸

=

· 0 0

¸

(2.26) with u0 and η0 the perturbations to the steady state. We now have a system of differential equations for these perturbations, with boundary conditions:

u0(0) = 0 (2.27)

η0(L) = 0 (2.28)

Eliminating u0 we obtain

[(−λ + U

∂x)2− gd0(

∂x)2]η = 0 (2.29)

and now we try solutions of the form η = eγx

(−λ + U γ)2− gd0γ2= 0 ⇔ (U γ − λ)2= gd0γ2 (2.30)

⇔ U γ − λ = ±p

gd0γ ⇔ γ = λ U ±√

gd0 ⇔ U ±p

gd0 = λ

γ (2.31)

The latter equality we can use to write down a general solution for η, we have η(x) = Ae

λ U +

gd0x

+ Be

λ U −

gd0x

(2.32)

and ∂η(x)

∂x = A λ U +√

gd0e

λ U +

gd0x

+ B λ

U −√ gd0e

λ U −

gd0x

(2.33) from now on we will substitute

α1 = λ U +√

gd0 (2.34)

α2 = λ U −√

gd0 (2.35)

A and B are unknown up to here. Now we can use the second equation of the system (2.26) to get a system of equations for A and B. We have

d0∂u0

∂x − λη0+ U∂η0

∂x = 0 (2.36)

or equivalent

d0∂u0

∂x = λη0− U∂η0

∂x (2.37)

we can now use (2.32) and (2.33) in the last equation, hence

∂u0

∂x = λ

d0(Aeα1x+ Beα2x) −λU

d0 (Aα1eα1x+ Bα2eα2x) (2.38)

(15)

8 CHAPTER 2. BASIC EQUATIONS Since this is a first order differential equation we can solve by separation of variables:

Z du0=

Z λ

d0(Aeα1x+ Beα2x) (2.39)

−λU

d0 (Aα1eα1x+ Bα2eα2x)dx After integration we have two equations

u0 = λ d0(A 1

α1eα1x+ B 1

α2eα2x) (2.40)

−λU

d0 (Aα1 1

α1eα1x+ Bα2 1

α2eα2x) + constant u0=

r g

d0(Aeα1x− Beα2x) + constant (2.41) Because u0(0) = 0 we have

A − B = 0 (2.42)

Also we fill in the boundary condition for η0(L) = 0 and we have Ae

λL U +

gd0 + Be

λL U −

gd0 = 0 (2.43)

Combining the last two equations we have a system of the equations for the unknowns A and

B "

1 −1

e

λL U +

gd0 e

λL U −

gd0

# · A B

¸

=

· 0 0

¸

(2.44) The determinant of this system is

eα1L+ eα2L (2.45)

and a non-trivial solution is found when the determinant is zero, so

eα2L= −eα1L (2.46)

or

e2−α1)L= −1 = e−i(π+2kπ) ∀k ∈ Z (2.47) Since

α2− α1 = 2λ√ gd0

U2− gd0 (2.48)

hence

2λ√ gd0

U2− gd0 = i(π + 2kπ)

L (2.49)

Now we rewrite the last equation for λ p

gd0 = i(π + 2kπ)(U2− gd0)

L (2.50)

λ = i(π + 2kπ)(U2− gd0) 2L√

gd0 (2.51)

Hence the Eigenvalues are purely imaginary, for both sub- and supercritical flow. In the numerical analysis we will take a look at values for u and d, for which U2− gd0 almost, since this means we have eigenvalues almost zero.

(16)

Chapter 3

Numerical Model

3.1 Space Discretization

We discretize equations 2.14 and 2.16 in space in the middle of two successive grid points, i and i + 1. The situation is visualised in 3.1. In the point i, ui and di are given. The middle point i +12 is where fi and fi+n are calculated and in i + 1, ui+1 and di+1 are the variables.

We can write the equation as an integral from xi to xi+1.

Figure 3.1: the computational grid

Z xi+1

xi

((du)t+ (du2+1

2gd2)x+ dhx)dx = 0 (3.1) after integration this is

(du)t∆x + (du2+1

2gd2)i+1− (du2+ 1

2gd2)i+ dhx∆x = 0 (3.2) ((du)t)i+1

2∆x + (du2+1

2gd2)i+1− (du2+1

2gd2)i+ dhx∆x = 0 (3.3) Time independent we have

fi = di+1· u2i+1+1

2gi+1d2i+1− di· u2i 1

2gid2i +1

2g(di+1+ di)hx∆x (3.4) We can treat the second equation in a similar way:

0.5∆x∂

∂t(di+1+ di) = −ui+1di+1+ uidi (3.5) or without the time derivative

fi+n= uidi− ui+1di+1 (3.6)

9

(17)

10 CHAPTER 3. NUMERICAL MODEL Of course we need to use boundary conditions in order to be able to work with this discretiza- tion. On the left side of the grid the velocity is prescribed and on the right the depth. This states that in the first, n-th (n + 1)-th and 2n-th equation we can simply substitute the given value for the either u or d.

The bottom profile h also appears in the equations and we have taken this to be zero everywhere except for the obstacle. The obstacle has a the form of a cosine. The obstacle is placed in the middle of the grid and covers halve of the grid length L. The mathematical shape is defined as:

h(x) = 1 − cos(2π(x − 0.25L)

0.5L ) (3.7)

3.2 Solution Method

At this point we have obtained a system of linear equations.

F (x) =



 f1 f2 ... f2n



= 0

In order to solve the system of equations we are going to use a n-dimensional Newton Method [BUFA05]. This means we are looking for a fixed point of a multiple valued function G(x).

Where G is defined as:

G(x) = x − J(x)−1F (x) (3.8)

The matrix J is the Jacobian matrix as defined in equation 3.9:

J(x) =





∂f1

∂x1

∂f1

∂x2 · · · ∂x∂f2n1

∂f2

∂x1

∂f2

∂x2 · · · ∂x∂f2n2 ... ... . .. ...

∂f2n

∂x1

∂f2n

∂x2 · · · ∂f∂x2n2n





 (3.9)

Here x contains both the velocity in x-direction and the depth at every point on the grid, so xT = [u, d] = [u1, u2, . . . un, d1, d2, . . . , dn]

hence the Jacobian matrix in our case is







∂f1

∂u1

∂f1

∂u2 · · · ∂d∂fn1

∂f2

∂u1

∂f2

∂u2 · · · ∂d∂fn2 ... ... . .. ...

∂f2n

∂u1

∂f2n

∂u2 · · · ∂f∂d2nn







If we now calculate all the partial derivatives in this Jacobian we can program a working Newton method. These derivatives for the equations will be:

∂fi

∂uj = (−1)i+j+12djuj (3.10)

(18)

3.3. MATLAB PROGRAM 11 fori = 1, 2, . . . , n, j = i, i + 1.

∂fi

∂dj = (−1)i+j+1dj (3.11)

for i = 1, 2, . . . , n, j = i, i + 1.

∂fi

∂uj = (−1)i+j+1(u2j + gdj+ 1

2g∆xhxj) (3.12)

for i = n + 1, n + 2, . . . , 2n, j = i, i + 1.

∂fi

∂dj = (−1)i+j+1uj (3.13)

for i = n + 1, n + 2, . . . , 2n, j = i, i + 1.

In most cases the derivatives are zero, because fiwhich is defined between every two successive grid points only depends on the depth, fluid velocity and bottom profile in these points. To find the fixed point we iterate in x and we have the following iteration scheme

x(k)= G(x(k−1)) = x(k−1)− J(x(k−1))−1F (x(k−1))

Here k is the iteration number. When the starting values are chosen accurate enough and if J−1 exists then this method gives quadratic convergence. We do not want to calculate the inverse of the Jacobian matrix explicitly, because this is a quite expansive operation. To do this we divide the method in two steps. First the system J(x(k−1))dx = −F (x(k−1)). Second this new solution is added to the existing one: x(k) = x(k+1)+ dx The stopping criterion is when the norm of dx is small enough.

3.3 Matlab Program

The program consists of five functions next to the main. One of those creates the bottom gradient. This is done in a way that guarantees we have obstacle with the shape of half a period of a sine. Then we have a function that creates the right hand side. Furthermore we have the a function for the Newton method that uses another to create the Jacobian matrix.

3.4 Generalized Eigenvalue Problem

When we take a look at the generalized eigenvalues of the problem we need to take into account the space discretization of the time dependent part. This is because when there is a perturbation we have to take into account the time dependent part of the equations again. We split d and u in a steady and an unsteady part. For the time derivative in the first equation (3.3) we have,

∂t(M (du))i+1

2 (3.14)

M is the matrix that takes the mean value from the surrounding grid points, so we can rewrite

as

∂t(M (du))i+1

2 =

∂t

((du)i+1+ (du)i)

2 (3.15)

(19)

12 CHAPTER 3. NUMERICAL MODEL Now we use the fact that

ab + cd = (a + c)(b + d)

2 + (a − c)(b − d) 2 so

∂t

((du)i+1+ (du)i)

2 =

∂t((di+1+ di)(ui+1+ ui)

4 +(di+1− di)(ui+1− ui)

4 ) (3.16)

and in matrix notation we have

∂t(M dM u + DdDu) (3.17)

D is the matrix of the difference operator ((Dd)i+1

2 = di+12−di). The time derivative in de second equation 3.5 gives

∂tM d (3.18)

After applying the product rule, the discretization of the time dependent parts will be re- spectively

M uM∂d

∂t + M dM∂u

∂t + DuD∂d

∂t + DdD∂u

∂t (3.19)

M∂d

∂t (3.20)

so the matrix A is defined as A = ∆x

· M dM + DdD M uM + DuD

0 M

¸

(3.21) Herewith we can write the discretized problem as

A(x)∂x

∂t = F (x) (3.22)

with x = [u, d] and A a matrix consisting of the difference and mean operator as mentioned before. F is given by equations 3.4 and 3.6. We take x = xs+ v, with xs the steady solution and v a small perturbation, because xs is independent of t we have

A(xs+ v)∂(xs+ v)

∂t = (A(xs) + A(v))∂v

∂t (3.23)

A(xs+ v)∂v

∂t = F (xs+ v) = F (xs) + Jv = Jv (3.24) Because v is small, with respect to xs we simplify to,

A(xs)∂v

∂t = Jv (3.25)

We take

v = ˜veλt (3.26)

To find the eigenpair (˜v, λ), where ˜v = [˜u, ˜d]T only depends on the space variables. Thus the generalized eigenvalue problem is

λA(xsv = J ˜v (3.27)

(20)

Chapter 4

Numerical Results

4.1 Numerical Eigenvalue Spectra for the Linear Hydrostatic Flow Problem

We will now try to find out what happens when parameters have critical values. First we look at the solutions and eigenvalues where U2− gd0 is close to zero, because this is the case where the eigenvalue λ of the eigenvalue problem from section 2.5 is passing through zero. In this experiment we are not working with the obstacle. In our model we have taken g = 10 and for this experiment we keep the depth at the right side d0 = 1, meaning we have a problem for U =√

10.

In the figure below one can see the eigenvalue spectra for U =√

10 − 0.0001 + 0.00011p for p ∈ 0, 1, 2 (4.1)

−1500 −1000 −500 0 500 1000 1500

−1500

−1000

−500 0 500 1000 1500

Re eigenvalues

10− 0.0001

10 + 0.00001

√10 + 0.00012

−0.01 −0.008 −0.006 −0.004 −0.002 0 0.002 0.004 0.006 0.008 0.01

−0.01

−0.008

−0.006

−0.004

−0.002 0 0.002 0.004 0.006 0.008 0.01

Re eigenvalues

10− 0.0001

10 + 0.00001

√10 + 0.00012

Figure 4.1: Eigenvalues of the generalized eigenvalue problem, the right picture gives a more detailed image of the siutation

In this figure there does not seem to be much of a difference for the different values of U , however if we take a closer look at the part around zero we get figure 4.1. What we in the right figure is that for values of U smaller then

10 the eigenvalues in this part are in the shape of an arrow to the right and for U larger then√

10 this points in the opposite direction.

The eigenvalues go through the imaginary axis in this experiment, and this means the real parts go through zero, which indicates the solutions to be unstable.

In fact the continuous equation would give a whole bunch of eigenfunctions with eigenvalue zero. Here we see a clustering near zero because U is not precisely

10. Moreover, in contrast 13

(21)

14 CHAPTER 4. NUMERICAL RESULTS to continuous equations there is some dissipation in the numerical model which becomes negative for some components if U >√

10.

4.2 Solutions Of The Model

If we run our program with some prescribed parameters we get solutions for u and d. These solutions are plotted and solutions for the depth d can be displayed as follows. In this figure

0 1 2 3 4 5 6 7 8 9 10

0 1 2 3 4 5 6 7 8 9 10

Figure 4.2: solution

the blue line represent the water level and the black one the bottom topography. For all experiments the length of the interval has length 10 and we choose an odd number of grid points, so the top of the obstacle is really one point and has the wanted height.

(22)

4.3. SUBCRITICAL TO SUPERCRITICAL 15

4.3 Subcritical To Supercritical

As stated in section 2.2 the Froude Number is an important quantity in our flow problem.

We will now look at the situation where we add an obstacle in the flow and slowly raise the height of this object, until we have a Froude Number larger than one for the first time on our interval of interest. The interval is divided in 31 grid points all at equal distances. When we start the solutions and local Froude number are as visible in the figures below.

0 1 2 3 4 5 6 7 8 9 10

0 1 2 3 4 5 6 7 8 9 10

0 1 2 3 4 5 6 7 8 9 10

0 0.2 0.4 0.6 0.8 1

F

Figure 4.3:

If we continue using our previous solution every time as the starting vector for the Newton method it slowly changes. The depth d gets higher in the first part of the interval and the Froude number F gets close to one at the end of the interval.

0 1 2 3 4 5 6 7 8 9 10

0 1 2 3 4 5 6 7 8 9 10

0 1 2 3 4 5 6 7 8 9 10

0 0.2 0.4 0.6 0.8 1

F

Figure 4.4:

From here on the steps with which the obstacle is raised are kept ten times smaller, so we can get a closer look at what’s the matter.

0 1 2 3 4 5 6 7 8 9 10

0 1 2 3 4 5 6 7 8 9 10

0 1 2 3 4 5 6 7 8 9 10

0 0.2 0.4 0.6 0.8 1

F

Figure 4.5:

(23)

16 CHAPTER 4. NUMERICAL RESULTS Now if we go on one more step in raising the obstacle height we have the following situation:

0 1 2 3 4 5 6 7 8 9 10

0 1 2 3 4 5 6 7 8 9 10

0 1 2 3 4 5 6 7 8 9 10

0.2 0.3 0.4 0.5 0.6 0.7 0.8 0.9 1 1.1 1.2

F

Figure 4.6:

In the figure below one can see eigenvalues for four solutions just before and after super- critical flow occurs. Blue are the eigenvalues corresponding to the solution in figure 4.5 and red for figure 4.6. We can see in (4.7) that for F > 1 some eigenvalues get a positive real part.

−3500 −3000 −2500 −2000 −1500 −1000 −500 0 500

−3000

−2000

−1000 0 1000 2000 3000

Re eigenvalues

subcritical subcritical subcritical supercritical

−500 −400 −300 −200 −100 0 100 200 300 400 500

−500

−400

−300

−200

−100 0 100 200 300 400 500

Re eigenvalues

subcritical subcritical subcritical supercritical

−2 −1.5 −1 −0.5 0 0.5 1 1.5 2

x 10−3

−2

−1.5

−1

−0.5 0 0.5 1 1.5 2x 10−3

Re eigenvalues

subcritical subcritical subcritical supercritical

Figure 4.7: Eigenvalues

First the tend to zero and when for F = 1 there is clustering near zero, and when the obstacle is raised again the spread out to the right of the imaginary axis. The number of eigenvalues that cluster to zero and get a positive real part is equal to the number of grid points where F > 1. If we repeat this research with 61 grid points (double the amount of before more or less) we can see from the figure 4.8 that the number of grid points where F > 1 is equal to (plus or minus one) the number of eigenvalues with positive real part. One can see that if we go on continuing after we already have F > 1 the eigenvalues to the right of the imaginary axis are spreading out, e.a. the are getting larger in norm.

−14000 −12000 −10000 −8000 −6000 −4000 −2000 0 2000

−1.5

−1

−0.5 0 0.5 1 1.5x 104

Re eigenvalues

subcritical subcritical supercritical supercritical

−0.1 −0.08 −0.06 −0.04 −0.02 0 0.02 0.04 0.06 0.08 0.1

−0.1

−0.08

−0.06

−0.04

−0.02 0 0.02 0.04 0.06 0.08 0.1

Re eigenvalues

subcritical subcritical supercritical supercritical

Figure 4.8: Eigenvalues

(24)

Chapter 5

Conclusions

We started with the Navier-Stokes equations and derived the shallow water equations from them. This involves a number of assumptions, like incompressibility. Because it has usefulness in numerical computations we have written the equations for the one dimensional case in conservative form. The Froude Number is an important dimensionless quantity, because its value indicates whether we are dealing with a sub- or supercritical flow. In our interpretation the Froude number is defined locally, and its value is: the local fluid velocity divided by the local significant wave velocity. It is possible to come up with an analytical solution for the equations if we linearize them first.

We have also taken a look at the eigenvalue problem related to a perturbed system. We discovered the eigenvalues should be purely imaginary for sub- and supercritical flow. And the critical point is when U2 = gd0, because then we have eigenvalues zero, i.e. Froude number 1.

For the discretization we have used the equations in conservative form and we discretized in the middle of two successive grid points. From this we got the discretized equations. Because we want to take a look at the eigenvalues of our numerical model we came up with the generalized eigenvalue problem. Therefore we need to isolate the discretized time dependent parts. This eigenvalue problem is solved in the Matlab program.

Now we take a look at our numerical results. First we considered the situation without obstacle, and looked at the situation we came up with in section 2.5 where U2− gd0 passes through zero. Some eigenvalues cluster to zero and after U2− gd0 changes sign they spread out again. Furthermore we observe that the eigenvalues are not purely imaginary as expected from section 2.5, this is attributed to numerical dissipation.

If the obstacle is introduced we can do a same kind of analysis, by raising it slowly.

Initially all eigenvalues are in the left half plane. If we have F close to one somewhere on the interval then part of the eigenvalues of the generalized eigenvalue problem cluster and tend to zero. If we raise the obstacle further F becomes greater than one and the eigenvalues spread out again in the same shape, but now with positive real part. The number of eigenvalues for which this happens is equal to the number of grid points where we have F > 1 plus or minus one. It might be that also here the real part of the eigenvalues is caused by artificial diffusion. This is something left for future study. The main conclusion is that for both the even and uneven bottom case something similar occurs: part or all of the eigenvalues tend to zero. In conventional continuation we have that only 1 or a pair of eigenvalues pass the imaginary axis and standard techniques from bifurcation theory are known for handling that.

17

(25)

18 CHAPTER 5. CONCLUSIONS Here an infinite number of eigenvalues becomes zero and the textbooks do not say how to handle that. This is something for further research.

(26)

Bibliography

[BAI95] Baines, Peter G. Topographic effects in stratified flows. Cambridge University Press. 1995

[BAI03] Baines, Peter G./Whitehead J.A. On multiple states in single layer flows. in:

Physics Of Fluids volume 15, number 2, February 2003. American Institute of Physics

[BUFA05] Richard L. Burden, J. Douglas Faires Numerical Analysis 8th edition. Thomson Brooks/Cole. 2005

[HOO97] H.W. Hoogstraten Stromingsleer. Rijksuniversiteit Groningen, vakgroep Wiskunde, Oktober 1997

[WIKI] http://en.wikipedia.org/wiki/Shallow_water_equations

19

Referenties

GERELATEERDE DOCUMENTEN

The conversations with team leaders, volunteers and management do not provide grounds to assume that victims are not referred to specialised services often enough.. However,

Upper graph: market prices (APX, PowerMatcher price), Middle graph: PowerMatcher-MC controlled (Total = total demand, HP = demand of heat pumps, CHP = supply of micro CHPs (negative

De meeste effectgerichte maatregelen, zoals een verlaging van de grondwaterstand of een verhoging van de pH in de bodem, verminderen de huidige uitspoeling, maar houden de

Tabel 13 Gemiddelde ammoniakdepositie in mol ha-1 jr-1 uit 10 km zone rondom Natura 2000-gebieden en beschermde natuurmonumenten in heel Gelderland voor het jaar 2006, na

Lemma 7.3 implies that there is a polynomial time algorithm that decides whether a planar graph G is small-boat or large-boat: In case G has a vertex cover of size at most 4 we

In contrast to Dalvit and de Klerk’s (2005) findings, the majority of the students of the Rhodes University did not only hold positive attitudes towards Xhosa in personal

It is shown that by exploiting the space and frequency-selective nature of crosstalk channels this crosstalk cancellation scheme can achieve the majority of the performance gains

Now that we have found both a lower and an upper bound for the maximum possible number of ordinary double points on surfaces of a given degree, we will turn to the specific