Open access peer-reviewed chapter

Numerical Analysis of the Incompressible Fluid Flow and Heat Transfer

Written By

Toshio Tagawa

Submitted: 12 May 2017 Reviewed: 07 November 2017 Published: 20 December 2017

DOI: 10.5772/intechopen.72263

From the Edited Volume

Finite Element Method - Simulation, Numerical Analysis and Solution Techniques

Edited by Răzvan Păcurar

Chapter metrics overview

1,400 Chapter Downloads

View Full Metrics

Abstract

The present chapter introduces incompressible Newtonian fluid flow and heat transfer by using the finite difference method. Since the solution of the Navier-Stokes equation is not simple because of its unsteady and multi-dimensional characteristic, the present chapter focuses on the simplified flows owing to the similarity or periodicity. As a first section, the first Stoke problem is considered numerically by introducing the finite difference method. In the second section, natural convection heat transfer heated from a vertical plate with uniform heat flux is introduced together with the method how to obtain the system of ordinary differential equations. In the third example, linear stability analysis for the onset of secondary flow during the Taylor-Couette flow is numerically treated using the HSMAC method.

Keywords

  • finite difference method
  • similar solution
  • boundary layer
  • linear stability analysis
  • HSMAC method

1. Introduction

The governing equation for the fluid flow is known as Navier-Stokes equation, which is however difficult to solve analytically; and therefore, a lot of numerical techniques have been proposed and developed. Nevertheless various complex flow phenomena such as turbulent flow, multi-phase flow, compressible flow, combustion, and phase change encountered in the fields of engineering would have still difficulties to circumvent even using both present computational resources and numerical techniques. The present chapter devotes not to elucidate such complex phenomena, but to introduce rather simplified fluid flow by using the finite difference method.

One focuses on incompressible flows, in which physical properties such as the viscosity, the thermal conductivity, the specific heat are constant and even the fluid density is not a thermodynamic variable. This simplified assumption makes the fluid flow phenomena much easier to be handled and it is valid when the flow velocity is much slower than the sound velocity and/or the temperature difference in the fluid is small enough to consider the thermal expansion coefficient is independent to the temperature. The former situation is known the low Mach number approximation, while the latter one the Boussinesq approximation.

Another simplification on the incompressible flows is the reduction of dimension due to the characteristic of similarity and periodicity. For the boundary layer flows such as the Blasius flow, the stagnation-point flow, and the von Kármán rotating disk flow have the similar solution where the flow transition from laminar to turbulence does not occur. In those cases, a combined dimensionless variable (similar variable) η is introduced and the velocity distribution can be only a function of η. While for the onset of instability such as the Rayleigh-Bénard convection, the Bénard-Marangoni convection, and the Taylor-Couette flow, the periodic characteristic of flow structure is observed. At the stage of onset of instability, the non-linear term is negligible and therefore the function of flow field is separated into the amplitude part and periodic part, respectively. This makes the effort on numerical analysis to reduce significantly and also to contribute the augmentation of accuracy of the results.

This chapter consists of three main bodies. First, a numerical technique for solving the boundary value problem called the first Stokes problem or the Rayleigh problem [1] is introduced. The differential equation is transferred into an ordinary equation and it is solved by a finite difference method using the Jacobi method. Second, similar solution of natural convection heat transfer heated from a vertical plate with uniform heat flux is introduced together with the method how to obtain the system of ordinary differential equations. The obtained Nusselt numbers are compared with some previous studies. Third, for example, of the linear stability analysis, one shows that the HSMAC method can be applied to obtain the critical values for the onset of secondary flow such as the Taylor-Couette flow. The Eigen functions of flow and pressure fields are visualized.

Advertisement

2. Unsteady flow due to sudden movement of the plate

2.1. Governing equations

An infinite length plate is set in a stationary fluid as an initial condition. Let us consider the situation that the infinite length plate suddenly moves along its parallel direction at a constant speed uw. This problem was first solved by Stokes [2] in his famous treatment of the pendulum. Since Lord Rayleigh [3] also treated this flow, it is often called the Rayleigh problem in the literature. One takes that x is the plate movement direction and y is distance from the plate. Since the velocity component perpendicular to the plate v is zero, the momentum equation is simplified and is shown as a diffusion equation

u t = ν 2 u y 2 E1

Here, u is the velocity component parallel to the plate direction, t is the time, and ν is the kinematic viscosity. The boundary conditions for this partial differential equation are as follows:

y = 0 : u = u w y : u 0 E2

In order to reduce the partial differential equation to an ordinary equation, the following dimensionless velocity U and the similar variable η are introduced

u = u w U η , η = y 2 νt E3

Then, the following ordinary differential equation can be obtained

d 2 U d η 2 + 2 η dU = 0 E4

The boundary condition for the ordinary differential equation is as follows using the similar variable η instead of y:

η = 0 : U = 1 η : U 0 E5

As a consequence, one needs to solve this boundary value problem. The theoretical solution can be easily obtained and expressed using the error function

U = u u w = 1 erf η = 1 2 π 0 η exp ξ 2 E6

The velocity profile is shown in Figure 1.

Figure 1.

Velocity profile.

2.2. Numerical method for solving the ordinary differential equation using finite difference method

For numerical solution, it is necessary to define the range of η, as recognized from Figure 1, η = 4 is enough. Hence, the boundary condition shown below is used instead of Eq. (5)

η = 0 : U = 1 η = 4 : U = 0 E7

As illustrated in Figure 2, in which vertical and horizontal axes are exchanged from Figure 1, one needs to obtain each value of dimensionless velocity numerically. The approximated velocity profile is expressed by connecting these values smoothly. For simplicity, the intervals between neighboring two points are the same and it is noted as Δη . When the second-order central difference method is used, Eq. (4) is as follows:

U i + 1 2 U i + U i 1 Δ η 2 + 2 η i U i + 1 U i 1 2 Δ η = 0 , i = 2 3 N 1

Figure 2.

Equidistant grids discretized.

Here, N is total number of grids and in this chapter, the first grid point starts from 1 as its definition. The above equation becomes

1 η i Δ η α i U i 1 2 U i + 1 + η i Δ η β i U i + 1 = 0 , i = 2 3 N 1 . E8

Here, η i = i 1 Δη and αi and βi are coefficients determined by the number of grids. The boundary condition (7) is modified

η = 0 : U 1 = 1 η = 4 : U N = 0 E9

In the following, the case of N = 7 is considered, for example. By substituting i = 2–6 into Eq. (8), the following simultaneous equation is obtained:

2 β 2 0 0 0 α 3 2 β 3 0 0 0 α 4 2 β 4 0 0 0 α 5 2 β 5 0 0 0 α 6 2 U 2 U 3 U 4 U 5 U 6 = α 2 U 1 0 0 0 β 6 U 7 E10

This kind of tridiagonal matrix is often seen and can be solved by a direct numerical method, such as Tomas method. However, the rank of the matrix is usually extremely large and one introduces an iterative method for solving the king-size matrix.

2.3. Iterative method for matrix solver

In general, the rank of the matrix appearing in computational fluid dynamics (CFD) is large and iterative methods such as Jacobi, Gauss-Seidel, or successive over relaxation (SOR) methodare employed. In this subsection, the Jacobi method is explained. The matrix can be divided into three parts of lower, diagonal, and upper as follows:

0 0 0 0 0 α 3 0 0 0 0 0 α 4 0 0 0 0 0 α 5 0 0 0 0 0 α 6 0 U 2 U 3 U 4 U 5 U 6 + 2 0 0 0 0 0 2 0 0 0 0 0 2 0 0 0 0 0 2 0 0 0 0 0 2 U 2 U 3 U 4 U 5 U 6 + 0 β 2 0 0 0 0 0 β 3 0 0 0 0 0 β 4 0 0 0 0 0 β 5 0 0 0 0 0 U 2 U 3 U 4 U 5 U 6 = α 2 U 1 0 0 0 β N 1 U N E11

In the Jacobi method, only the diagonal part is put in the left-hand side (n + 1 step), while the lower and upper parts are moved to the right-hand side (n step)

2 0 0 0 0 0 2 0 0 0 0 0 2 0 0 0 0 0 2 0 0 0 0 0 2 D U 2 U 3 U 4 U 5 U 6 n + 1 U n + 1 = α 2 U 1 0 0 0 β N 1 U N b 0 0 0 0 0 α 3 0 0 0 0 0 α 4 0 0 0 0 0 α 5 0 0 0 0 0 α 6 0 L U 2 U 3 U 4 U 5 U 6 n U n 0 β 2 0 0 0 0 0 β 3 0 0 0 0 0 β 4 0 0 0 0 0 β 5 0 0 0 0 0 U U 2 U 3 U 4 U 5 U 6 n U n E12

Here, n is the old iteration step and n + 1 is the new iteration step. Hence, the following equation is repeatedly used:

U n + 1 = D 1 b L + U U n E13

This is equivalent to the following equation:

U i n + 1 = 1 2 α i U i 1 n + β i U i + 1 n , i = 2 3 4 5 6 E14

By using Eq. (9), Eq. (14) is computed repeatedly and then the value of each grid gradually converges to a certain solution. The Gauss-Seidel and SOR methods are known as the faster convergence method.

Advertisement

3. Similarity solution for natural convection heated from a vertical plate

3.1. Introduction

In this section, let us consider the natural convection heat transfer for a vertical plate heated with uniform heat flux in the wide range of Prandtl number from zero to infinity. In order to explain the numerical method as how to solve the governing equations, one assumes that the flow and temperature fields formed in the vicinity of the heated plate have a similarity and then one introduces the finite difference method to obtain numerical results.

3.2. Governing equations

One assumes that the flow is incompressible laminar and boundary layer equations are used in this analysis. The governing equations with presuming the Boussinesq approximation are shown in Eqs. (15)(17) together with the boundary condition (18). Here, one defines that x axis is in the vertical direction and its velocity component is u , and y axis is in the direction perpendicular to the vertical plate and its velocity component is v .

Continuity of mass

u x + v y = 0 E15

Momentum equation

u u x + v u y = ν 2 u y 2 + T T E16

Energy equation

u T x + v T y = α 2 T y 2 E17

Boundary equation

y = 0 : u = v = 0 , q = k T / y y : u 0 , T T E18

Here, β is the thermal expansion coefficient, g is the acceleration due to gravity, α is the thermal diffusivity, k is the thermal conductivity, and T is the temperature.

3.3. Non-dimensionalization

First, dimensionless variables, such as velocity and temperature, are set as follows using the unknown reference value denoted with subscripts a and b:

X = x x a , Y = y y a , U = u u a , V = v v a , θ = T T b T a E19

Equation (19) is substituted into Eqs. (15)(18), and one gets

U X + v a x a y a u a 1 V Y = 0
U U X + v a x a y a u a 1 V U Y = ν x a y a 2 u a 2 2 U Y 2 + T b T x a u a 2 3 + T a x a u a 2 4 θ
U θ X + v a x a y a u a 1 V θ Y = α x a y a 2 u a 5 2 θ Y 2
Y = 0 : U = V = 0 , qy a / kT a 6 = θ / Y Y : U = 0 , θ = T T b / T a 7

At the moment stage, x a is recognized as the height of the vertical plate.

Putting [3] = 0, and one obtains T b = T .Hence [7] becomes θ = 0 .

Putting [6] = 1, and one gets qy a kT a = 1 T a = qy a k

Putting [5] = 1, and one gets α x a y a 2 u a = 1 y a = α x a u a 1 / 2

Putting [1] = 1, v a x a y a u a = 1 v a = y a u a x a

Putting [4] = 1, T a x a u a 2 = 1 u a = T a x a 1 / 2 = qy a k x a 1 / 2 = q k α x a u a 1 / 2 x a 1 / 2

u a = q k 2 α x a 3 1 / 5 = qx a 4 k α 2 2 / 5 α x a = Ra Pr 2 / 5 α x a , Ra = qx a 4 kαν E20
y a = α x a u a 1 / 2 = α x a Ra Pr 2 / 5 α x a 1 / 2 = x a 2 Ra Pr 2 / 5 1 / 2 = x a Ra Pr 1 / 5 E21
T a = qy a k = q k x a Ra Pr 1 / 5 = qx a k Ra Pr 1 / 5 E22
v a = y a u a x a = x a Ra Pr 1 / 5 Ra Pr 2 / 5 α x a x a = Ra Pr 1 / 5 α x a E23

In the above process, finally one obtains the dimensionless equations as follows:

U X + V Y = 0 E24
U U X + V U Y = Pr 2 U Y 2 + θ E25
U θ X + V θ Y = 2 θ Y 2 E26
Y = 0 : U = V = 0 , θ / Y = 1 Y : U = 0 , θ = 0 E27

The dimensionless variables are summarized as follows:

X = x x a , Y = y x a Ra Pr 1 / 5 , U = u α x a Ra Pr 2 / 5 , V = v α x a Ra Pr 1 / 5 , θ = T T qx a k Ra Pr 1 / 5 E28

Furthermore, one assumes that the velocity and temperature fields has a similarity along the direction of vertical plate, so one puts X = 1. These equations are useful for analyzing low Prandtl number cases and summarized as follows:

Low Prandtl number

Continuity of mass

dV = 1 5 η dU 3 U E29

Momentum equation

U dV V dU + Pr d 2 U d η 2 + θ = 0 E30

Energy equation

U 5 η θ V + d 2 θ d η 2 = 0 E31

Boundary conditions

η = 0 : U = V = 0 , / = 1 η : U = θ = 0 E32

The dimensionless variables and non-dimensional numbers are defined as follows:

η = y x Ra x Pr 1 5 , U = u α x Ra x Pr 2 5 , V = v α x Ra x Pr 1 5 , θ = T T qx k Ra x Pr 1 5 , Ra x = qx 4 ανk , Pr = ν α E33

The local Nusselt number can be obtained by the following derivation:

Nu x = h x x k = qx T w T k = qx T a θ w k = gβq α 2 k 1 / 5 k qx 1 / 5 T a 1 qx θ w k = gβq α 2 k 1 / 5 x 4 / 5 θ w = qx 4 α 2 k 1 / 5 1 θ w = Ra x Pr 1 / 5 1 θ w E34
Nu x = Ra x Pr 1 5 θ η = 0 1 = Ra x Nu x Pr 1 5 θ η = 0 1 E35

Therefore, the local Nusselt number can be obtained just from the dimensionless temperature at the wall using Eq. (36)

Nu x Ra x Pr 1 4 = θ η = 0 5 4 E36

High Prandtl number

If the Prandtl number is higher than unity, the following equations are useful:

Continuity of mass

dV = 1 5 η dU 3 U E37

Momentum equation

U dV V dU + Pr d 2 U d η 2 + Prθ = 0 E38

Energy equation

U 5 η θ V + d 2 θ d η 2 = 0 E39

Boundary conditions

η = 0 : U = V = 0 , / = 1 η : U = θ = 0 E40

The dimensionless variables and non-dimensional numbers are defined as follows:

η = y x Ra x 1 5 , U = u α x Ra x 2 5 , V = v α x Ra x 1 5 , θ = T T qx k Ra x 1 5 , Ra x = qx 4 ανk , Pr = ν α E41

Nu x Ra x 1 4 = θ η = 0 5 4 E42

3.4. Numerical results

Figure 3 shows the numerical result for the various Prandtl number cases. The upper figures indicate the vertical velocity and lower ones the temperature. The left-hand side figures show the cases of Pr ≥ 1, while the right-hand side ones the cases of Pr ≤ 1

Figure 3.

Vertical velocity and temperature distributions for various Prandtl numbers. The left-hand side indicates high Prandtl number cases while the right-hand side low Prandtl number cases.

Table 1 shows the summary of the local Nusselt number for various Prandtl number cases together with the reference of Churchill and Ozoe for comparison [4]. The agreement is quite good except for the extreme cases such as Pr → 0 and ∞. In such extreme cases, a small amount of discrepancy exists. In this study, the boundary condition for Pr → 0

η = 0 : dU / = V = 0 , / = 1 η : U = θ = 0

and that for Pr → ∞

η = 0 : U = V = 0 , / = 1 η : dU / = θ = 0 .

are used. Owing to this kind of special treatments for the boundary condition of such extreme cases, one can obtain accurate numerical results for the system of ordinary equations. The results between the solution of the present method and that of Le Fevre [5] for the case of constant temperature of heated wall are identical to each other. The value for Pr → ∞ is 0.5027 and that for Pr = 0 is 0.6004.

Pr 0 0.01 0.1 1 10 100
Nu x Ra x 1 4 N/A 0.4564
0.456
0.5234
0.524
0.5495
0.550
0.5631
0.5627
Nu x Ra x Pr 1 4 0.7107
0.6922
0.6694
0.670
0.5970
0.597
0.4564
0.456
N/A

Table 1.

Local Nusselt number for various values of Prandtl number (the upper: present results, the lower: Churchill and Ozoe [4]).

Advertisement

4. Linear stability of Taylor-Couette flow

4.1. Governing equations

In the text book of Chandrasekar [6], various examples of the linear stability analysis such as the Rayleigh-Bénard convection, the Taylor-Couette flow, and the Rayleigh-Taylor instability were studied extensively. More recently, Koschmieder [7] described the research focusing on the Bénard cells and the Taylor vortices. In this section, only the Taylor-Coette flow is considered. Figure 4 shows the schematic model considered for the Taylor-Couette flow. In this section, the fluid flow inside of the co-axial double cylindrical enclosure is assumed to be incompressible Newtonian, isothermal and axisymmetric. The gray part represents the computational domain. It is known that the stationary secondary flow is generated at a certain condition under the influence of centrifugal force due to the rotation of primary basic flow which is in azimuthal direction. The continuity of mass and momentum equations are shown in the cylindrical coordinate system as follows:

u r r + u r r + u z z = 0 E43
u r t + u r u r r + u z u r z u θ 2 r = 1 ρ p r + ν 2 u r r 2 + 1 r u r r u r r 2 + 2 u r z 2 E44
u θ t + u r u θ r + u z u θ z + u r u θ r = ν 2 u θ r 2 + 1 r u θ r u θ r 2 + 2 u θ z 2 E45
u z t + u r u z r + u z u z z = 1 ρ p z + ν 2 u z r 2 + 1 r u z r + 2 u z z 2 g E46

Figure 4.

Schematic model for the Taylor-Couette flow.

Here, it is indicated that r is the radial, θ is the azimuthal, and z is the axial components.

4.2. Basic state and linearization

The cylindrical enclosure is long enough to neglect the top and bottom ends. In that situation, the basic states for the azimuthal component of velocity and pressure are as follows:

Azimuthal velocity

u ¯ θ r = r 2 2 Ω 2 r 1 2 Ω 1 r 1 2 r 2 2 r + r 1 2 r 2 2 Ω 2 Ω 1 r 1 2 r 2 2 1 r E47

Pressure

p ¯ r z = ρ u ¯ θ r 2 r dr ρgz + p 0 E48

Here, Ω1 is the angular velocity at the inner cylinder, Ω2 is the angular velocity at the outer cylinder, p is the pressure, ρ is the density, and g is the acceleration due to gravity. In order to derive disturbance equations for the linear stability, the three components of velocity and pressure are represented as a summation of basic state and infinitesimal disturbance as follows:

u θ r z t = u ¯ θ r + v ' r z t , u r r z t = u ' r z t , u z r z t = w ' r z t , p r z t = p ¯ r z + p ' r z t E49

After neglecting the second-order disturbance, the following linearized equations are obtained:

u ' r + u ' r + w ' z = 0 E50
u ' t = 1 ρ p ' r + ν 2 u ' r 2 + 1 r u ' r u ' r 2 + 2 u ' z 2 + 2 u ¯ θ v ' r E51
v ' t = ν 2 v ' r 2 + 1 r v ' r v ' r 2 + 2 v ' z 2 d u ¯ θ dr + u ¯ θ r u ' E52
w ' t = 1 ρ p ' z + ν 2 w ' r 2 + 1 r w ' r + 2 w ' z 2 E53

By considering the periodicity of the secondary flow which could be happened, each component of infinitesimal disturbance is assumed to be given in the following form. Here, a is the axial wavenumber (real number) and s is angular frequency (complex number)

u ' u ˜ r = v ' v ˜ r = w ' w ˜ r = p ' p ˜ r = exp iaz + st E54

4.3. Linear stability analysis

The dimensionless simultaneous ordinary equations are summarized as follows:

Basic velocity

U ¯ θ R = μ η 2 1 η 2 R + η 2 1 μ 1 η 2 1 R E55

Disturbance equations for amplitude functions

D U ˜ + ik W ˜ = 0 E56
S U ˜ = D P ˜ + DD k 2 U ˜ + Re Ω 2 U ¯ θ R V ˜ E57
S V ˜ = DD k 2 V ˜ Re Ω D U ¯ θ U ˜ E58
S W ˜ = ik P ˜ + D D k 2 W ˜ E59

Here, the dimensionless variables and non-dimensional numbers are as follows. The outer radius r 2 is taken as the characteristic length

R = r r 2 , U ¯ θ = u ¯ θ Ω 1 r 2 , U ˜ V ˜ W ˜ = u ˜ v ˜ w ˜ Ω 1 r 2 , P ˜ = p ˜ ρν Ω 1 , Re Ω = Ω 1 r 2 2 ν , k = r 2 a , η = r 1 r 2 , μ = Ω 2 Ω 1 , S = s ν / r 2 2 , D = d dR , D = d dR + 1 R E60

The boundary conditions are as follows:

R = η : U ˜ = V ˜ = W ˜ = 0 Inner wall R = 1 : U ˜ = V ˜ = W ˜ = 0 Outer wall E61

After Chandrasekar [6], the following two non-dimensional numbers are introduced to verify the computational results:

Ta = 4 Ω 1 2 r 1 4 ν 2 1 μ 1 4 μ 1 η 2 2 = 4 Re Ω 2 η 4 1 μ 1 4 μ 1 η 2 2 , κ = 1 μ / η 2 1 μ E62

In this section, it is assumed that S = 0. This indicates that the secondary flow caused by the centrifugal instability is stationary and it contains toroidal vortices. To deal with the simultaneous ordinary differential equations for the boundary value problem, a one-dimensional staggered grid system is employed as shown in Figure 5. All the equations are discretized by the fourth order central difference method with a given wavenumber k using the HSMAC method [8] during which Re Ω is obtained by the Newton method. The following equations are used for correction of the pressure and velocity simultaneously. Here, the subscript i indicates grid location, while the superscripts m and n indicate the iteration of the corrections for the convergence of Eq. (56) and the time step, respectively. The more detailed explanation can be found in the recent papers published by the present author [9, 10]

P ˜ m + 1 i n + 1 = P ˜ m i n + 1 + ( δ P ˜ ) m i n + 1 = P ˜ m i n + 1 U ˜ m i + 1 n + 1 + 27 U ˜ m i n + 1 27 U ˜ m i 1 n + 1 + U ˜ m i 2 n + 1 24 ( Δ R ) + U ˜ m i + 1 n + 1 + 9 U ˜ m i n + 1 + 9 U ˜ m i 1 n + 1 U ˜ m i 2 n + 1 16 R P i + i k W ˜ m i n + 1 Δ τ { 2 / ( Δ R ) 2 + k 2 } E63
U ˜ m + 1 i n + 1 = U ˜ m i n + 1 + Δτ ΔR δ P ˜ m i n + 1 , U ˜ m + 1 i 1 n + 1 = U ˜ m i 1 n + 1 Δτ ΔR δ P ˜ m i n + 1 E64
W ˜ m + 1 i n + 1 = W ˜ m i n + 1 ik Δτ δ P ˜ m i n + 1 E65

Figure 5.

The staggered grids in the radius direction together with the points of each variable definition.

Table 2 shows the computational results for various rotation speeds at η = 0.5. When μ > 0.25, the basic flow is always stable due to the Rayleigh’s criterion. The present results exhibit slightly smaller values of Taylor number than those of Chandrasekar. Figures 6 and 7 show the amplitude functions and Eigen functions, respectively, for the case of μ = 0 (the outer cylinder is stationary), and Figures 8 and 9 show the case of μ = −0.5 (the outer cylinder rotates with half angular velocity in opposite direction to the inside rotation).

Present (201 grids) Chandrasekar [6]
κ μ Critical wave number Critical Ta number Wavenumber Ta number
0 1/4 6.286 15316 6.4 15332
0.4 1/6 6.293 19518 6.4 19542
0.6 2/17 6.299 22617 6.4 22644
1.0 0 6.325 33062 6.4 33100
4/3 −1/8 6.403 53210 6.4 53280
1.6 −1/4 6.715 98520 6.4 99072
1.8 −4/11 7.819 197715 7.8 199540
1.9 −9/21 8.733 288761 8.6 293630
2.0 −1/2 9.602 417734 9.6 428650

Table 2.

Computational results and comparison with Chandrasekar (η = 0.5).

Figure 6.

Amplitude functions (η = 0.5, μ = 0, k = 6.325).

Figure 7.

Visualization of Eigen functions for two wavelengths (η = 0.5, μ = 0, k = 6.325). From left to right, Stokes stream function, azimuthal velocity, and pressure.

Figure 8.

Amplitude functions (η = 0.5, μ = −0.5, k = 9.602).

Figure 9.

Visualization of Eigen functions for two wavelengths (η = 0.5, μ = −0.5, k = 9.602). From left to right, Stokes stream function, azimuthal velocity, and pressure.

The simultaneous ordinary equations from (56) to (59) were divided into the real and imaginary parts. However, only four equations among the eight equations are necessary to solve in this problem because of the symmetricity and anti-symmetricity of the complex variables. In Figures 6 and 8, the real part of U ˜ , V ˜ , P ˜ and the imaginary part of W ˜ are shown. For the visualization shown in Figures 7 and 9, the Stokes stream function Ψ is defined as follows:

U ˜ cos kZ = 1 R ∂Ψ Z , W ˜ sin kZ = 1 R ∂Ψ R E66

Here, the subscripts and represent the real part and the imaginary part, respectively. The visualization of other variables, such as the azimuthal velocity and the pressure, are treated in the similar manner using the trigonometric functions.

References

  1. 1. Schlichting H, Gersten K. Boundary Layer Theory. 8th Revised and Enlarged ed. Berlin: Springer; 1999
  2. 2. Stokes GG. On the effect of the internal friction of fluids on the motion of pendulums. Transactions of the Cambridge Philosophical Society. 1856;9(Part II):8-106 or Collected Papers III
  3. 3. Rayleigh L. On the motion of solid bodies through viscous liquids. Philosophical Magazine. 1911;21:697-711
  4. 4. Churchill SW, Ozoe H. A correlation for laminar free convection from a vertical plate. Journal of Heat Transfer. 1973;95(4):540-541
  5. 5. Le Fevre EJ. Laminar free convection from a vertical plane surface. In: Proceedings of the 9th International Congress of Applied Mechanics; Brussels; Vol. 4; 1956. pp. 168-174
  6. 6. Chandrasekar S. Hydrodynamic and Hydromagnetic Stability. Oxford: Clarendon Press; 1961
  7. 7. Koschmieder EL. Bénard cells and Taylor vortices. In: Cambridge Monographs on Mechanics and Applied Mathematics. United State of America: Cambridge University Press; 1993
  8. 8. Hirt CW, Nichols BD, Romero NC. SOLA: A Numerical Solution Algorithm for Transient Fluid Flows. Los Alamos, New Mexico, United State of America: Los Alamos Scientific Laboratory of University of California. 1975. p. LA-5852
  9. 9. Tagawa T, Egashira R. Fluid flow of a liquid metal in a cylinder driven by a rotating magnetic field. Transactions of the Japan Society of Mechanical Engineers, Part B. 2012;78(794):1680-1695
  10. 10. Tagawa T. Numerical investigation of Bénard-Marangoni convection of paramagnetic liquid in annular layers. In: The 15th International Heat Transfer Conference; Kyoto, Japan; August 2014

Written By

Toshio Tagawa

Submitted: 12 May 2017 Reviewed: 07 November 2017 Published: 20 December 2017