Turbulence in wall-bounded flows

Size: px
Start display at page:

Download "Turbulence in wall-bounded flows"

Transcription

1 Turbulence in wall-bounded flows Sergio Pirozzoli Matteo Bernardini Paolo Orlandi Dipartimento di Ingegneria Meccanica ed Aerospaziale Sapienza Universita di Roma HPC methods for Computational Fluid Dynamics and Astrophysics November , Bologna

2 Acknowledgments All simulations carried out using PRACE resources PRACE 3rd call PRACE 5th call PRACE 7th call PRACE 10th call PRACE 12th call Thanks to CINECA staff!

3 Why wall turbulence? Flow over solid surfaces most often turbulent Turbulent flow large increase of drag and heat transfer as compared to laminar state Drag and heat transfer prediction critical for efficient design of aircraft, cars, pipelines,... Practical impact: 1% drag reduction of A340 would result in fuel savings of about 100,000 Euros per aircraft per year Robust physical insight definitely needed

4 Wall turbulence: how it looks like Side view of turbulent flow over smooth horizontal surface (Re τ 4000)

5 Wall turbulence: how it looks like Wall-parallel view of turbulent flow over smooth horizontal surface (Re τ 4000)

6 Wall turbulence: a cartoon U 0 δ δ v Two velocity scales 1. U 0 (outer scale) 2. u τ = (τ w /ρ) 1/2 (inner scale) Two length scales 1. δ (outer scale) 2. δ v = ν/u τ (inner scale) Ratio of outer to inner length scales is an important parameter Re τ = δu τ /ν = δ/δ v

7 Wall turbulence: what we know (Approximately) universal near-wall behavior in inner scales, i.e. u + := u/u τ = f(y + ), y + := y/δ v Logarithmic meso-layer of mean velocity (Prandtl 25) u + = 1/k log y + + C, k = 0.41, C 5 Logarithmic layer of wall-parallel velocity variances (Townsend 76) u 2 /u 2 τ = A log y/δ + B The latter implies that peak velocity variances grow as log Re τ

8 Wall turbulence: what we don t know High Re τ outer eddies become more energetic Inner-outer layer interactions become more important Corrections to classical representation Asymptotic limit as Re τ? u + = f(y +, Re τ ) Subject of several recent reviews (Jimenez 2013, Smits et al. 2011, Marusic et al. 2010)

9 Why use supercomputers? Experiments limited in near-wall resolution, and difficulty to get clean data (e.g. derivatives of flow statistics) Revert to Direct Numerical Simulation (DNS), i.e. solve full Navier-Stokes equations in 3D unsteady version by resolving all scales of motion However, DNS of wall turbulence hampered by stringent computational requirements As δ v, simulating flows at high Re τ requires about (δ/ ) 3 = Re 3 τ points (in fact, N pts Re 11/4 τ ) Some effects (e.g. logarithmic scaling) only manifest themselves as Re τ O( ) points are required

10 DNS of wall turbulence State-of-the-art 10 4 Boundary layer Poiseuille Couette Pipe Reτ Year

11 DNS of wall turbulence Projection 10 4 Boundary layer Poiseuille Couette Pipe Reτ Re τ 10 4 likely to yield asymptotic wall turbulence (Jimenez 2012) Year

12 Outline DNS of incompressible wall-bounded flows (M = 0) Poiseuille flow up to Reτ 4000 Couette flow up to Reτ 1000 Passive scalars in Poiseuille flow Channel flow with unstable stratification DNS of compressible wall-bounded flows: see next talk

13 Governing equations Navier-Stokes-Boussinesq model u j x j = 0, u i t + u iu j x j = p x i + βgθδ i2 + Πδ i1 + ν 2 u i x j x j θ t + θu j x j = α 2 θ x j x j Controlling parameters Convection: bulk Reynolds number Re b = 2hu b /ν Buoyancy: bulk Rayleigh number Ra = βg θ(2h) 3 /(αν) Buoyancy/convection: bulk Richardson number Ri b = Ra/Re 2 b = 2βg θh/u 2 b Pr = ν/α 1

14 Numerical method Orlandi 2000 Projection method with direct Poisson solver based on Fourier expansions (Kim & Moin 87) Second-order approximation of space derivatives on staggered mesh (Harlow & Welch 65) Discrete conservation of total kinetic energy and scalar variance Implicit treatment of wall-normal viscous terms Third-order low-storage Runge-Kutta time stepping by A. Wray Pencil decomposition for efficient parallel implementation

15 Numerical discretization Incompressible NS equations u j x j = 0, u i t + u iu j x j = p x i + ν 2 u i x j x j Projection method to satisfy divergence-free constraint Semi-implicit discretization in time v v n = N n+1/2 + 1 t 2 (L(v ) + L(v n )) Gp n (1) In general, v is not divergence-free For that purpose, a correction step is implemented with ϕ TBD v n+1 v t = Gϕ (2)

16 Numerical discretization Take discrete divergence of previous equations Discrete Poisson equation G Gϕ = G (v n+1 v ) t = G v t Relation between ϕ and pressure can be derived by combining steps (1) and (2) p n+1 = p n + ϕ Lϕ The latter relation is used to feed step (1)

17 Numerical discretization Computational issues Inviscid 1D case Assume D = C2 v n+1 j v j t = Dϕ j D Dϕ = Dv t ϕ j 2 2ϕ j + ϕ j+2 = h v j+1 v j 1 2 t The stencil (j 2, j, j + 2) only contains odd or even indices decoupling of discrete pressure field

18 Numerical discretization Avoiding odd-even decoupling Staggered grid arrangement (MAC method, Harlow & Welch 65) v i,j+1/2 u i 1/2,j p i,j u i+1/2,j y v i,j 1/2 [ ] u 2 x i+1/2,j [ ] uv y i+1/2,j [ ] 2 u 2 x 2 i+1/2,j [ ] p x i+1/2,j x = u2 i+1,j u2 i,j + O( x 2 ) x [ ] (uv)i+1/2,j+1/2 (uv) i+1/2,j 1/2 = y + O( y 2 ) = u i+3/2,j 2u i+1/2,j + u i 1/2,j x 2 + O( x 2 ) = p i+1,j p i,j x + O( x 2 )

19 Numerical discretization Avoiding odd-even decoupling v i,j+1/2 Interpolations are needed u i+1,j = 0.5 ( u i+1/2,j + u i+3/2,j ) u i 1/2,j p i,j u i+1/2,j y (uv) i+1/2,j+1/2 = [ u i+1/2,j + u i+1/2,j+1 ] [v i+1,j+1/2 + v i,j+1/2 ] /4 v i,j 1/2 x Connection with skew-symmetric form discrete energy conservation [ ] u 2 x i+1/2,j ( ui+1/2,j + u i+3/2,j ) 2 ( ui 1/2,j + u i+1/2,j ) 2 u 2 j+3/2 u2 j 1/2 = 4 x 1 u 2 2 x + u u x 4 x + u i+1/2 u i+3/2,j u i 1/2,j 2 x

20 Numerical discretization Solution of Poisson equation for ϕ G Gϕ = G v / t In general requires iterative solvers impractical for DNS Direct solvers available in the presence of two periodic/symmetric directions (Kim & Moin 87) Fourier expansion in homogeneous directions (say x, z) ϕ(x, y, z) = ˆϕ l,m (y)e iklx e ikmz k l = 2πl/L x, k m = 2πm/L z Set f = G v / t l,m ˆϕ l,m ( kx2 + k z2 ) + Dy2 ˆϕ l,m = ˆf l,m kx2, k z2 are MWN for the second space derivative, e.g. k x2 = 2(1 cos(k l x))/ x 2, k z2 = 2(1 cos(k m z))/ z 2 Standard tridiagonal system in y direction must be solved l, m

21 Accuracy Linear analysis not necessarily the ultimate word Simple exercise: consider Burgers vortex model Representative for small-scale vortex tubes (Jimenez 93) u θ (x) 1 ξ (1 e ξ2) ξ = x/r b, r b = 3.94η We evaluate a single derivative as in MAC method u 2 j+3/2 u2 j 1/2 4 x + u i+1/2 u i+3/2,j u i 1/2,j 2 x 1 u 2 2 x + u u x

22 Accuracy Error analysis L 2 error norm E nd order 4th order 6th order 8th order C nd order 4th order 6th order 8th order h/η Practical DNS of wall turbulence use typical grid spacings in the wall-parallel direction x/η 5, z/η 3 FD formulas still far from reaching the asymptotic convergence limit The additional computational cost may not be justified MAC scheme successfully used for DNS of many wall-bounded flows E 2

23 Accuracy FD vs. spectral Plane channel at Re τ = 2000 Lines: second-order finite differences (Bernardini et al. 14); symbols: pseudo-spectral method (Hoyas & Jimenez 06) u/uτ u 2 i /u2 τ y Max difference about < 2% in turbulence intensity y +

24 Parallel implementation Slab vs. pencil decomposition Operations in x z plane can be carried out locally Operations in y (e.g. tridiagonal matrix inversion in Poisson solver) are global, requiring data transposition Main limitation: given N 3 mesh, max N processors can be used E.g points can be (inefficiently) handled on 1000 MPI processes Number of halo cells gets higher as # of cores increases

25 Parallel implementation Pencil decomposition The limit on the number of processes is now N p = N 2 Size of the halo cells on every core decreases with increasing # cores Example of work flow: solution of Poisson equation 1. transpose (a) (b), then take real FT in z 2. transpose (b) (c), then take complex FT in x 3. transpose (c) (a), then solve tridiagonal system in y Fourier coefficients 4. Transpose (a) (c), then take inverse FT in x 5. Transpose (c) (b), then take inverse FT in z to get physical solution 6. Transpose (b) (a) to have solution in original arrangement

26 Parallel scalability Weak scaling

27 DNS of Poiseuille flow DNS setup Flow case Line style Re b Re τ N x N y N z x + z + T u τ /h CH1 Dashed CH2 Dash-dot CH3 Dash-dot-dot CH4 Solid Computational box L x = 6πh, L z = 2πh dp/dx 2 h

28 DNS of Poiseuille flow DNS at Re τ = 4000: contour lines of u low-speed and high-speed

29 DNS of Poiseuille flow Mean velocity u/uτ CH1 CH2 CH3 CH y +

30 DNS of Poiseuille flow Mean velocity Comparison with experiments u/uτ CH1 CH2 CH3 CH4 Shultz & Flack y +

31 DNS of Poiseuille flow Mean velocity Overlap layer u/uτ y + Log-law fit u + = log y + /0.386 Recent estimates yield k 0.37, C = 3.7 (Nagib PoF 2008)

32 DNS of Poiseuille flow Diagnostic function Ξ = y + du + /dy + 3 Ξ 2 1 CH2 CH3 CH4 No range with flat behavior y +

33 DNS of Poiseuille flow Diagnostic function Ξ = y + du + /dy + Generalized log law 3 Ξ 2 1 CH2 CH3 CH4 Modified log law y + Refined overlap arguments (Afzal 1976) suggest Ξ = 1 k + αy h + β Re τ We get k = 0.41, α = 1.15, β = 180 (close to Jimenez & Moser 2007)

34 DNS of Poiseuille flow Velocity variances Horizontal components u 2 /u 2 τ 6 4 w 2 /u 2 τ y y +

35 DNS of Poiseuille flow Velocity variances Horizontal components u 2 /u 2 τ 6 4 w 2 /u 2 τ y + Experiments by Shultz & Flack (2013) y +

36 DNS of Poiseuille flow Velocity variances Horizontal components u 2 /u 2 τ 6 4 w 2 /u 2 τ y y + Townsend attached-eddy hypothesis: u 2 i /u2 τ B i A i log(y/h) Typically quoted values A , B We find A , B

37 DNS of Poiseuille flow Reynolds stress peaks Trend with Re τ u 2 pk/u 2 pk(ch1) U V W UV Re τ Clear logarithmic growth of u and w Sub-logarithmic growth of v

38 DNS of Poiseuille flow Spectral densities (pre-multiplied) u, inner scaling CH1 CH2 CH3 CH4

39 DNS of Poiseuille flow Production excess over dissipation y + (P + ε + ) Equilibrium hypothesis clearly violated at sufficiently high Re τ y +

40 DNS of Couette flow DNS setup Flow case Line style Re c Re τ N x N y N z x + z + T u τ /h C1 Dashed C2 Dash-dot C3 Dash-dot-dot C4 Solid Computational box L x = 18πh, L z = 6πh U 2 h

41 DNS of Couette flow DNS at Re τ = 1000: contour lines of u low-speed and high-speed

42 DNS of Couette flow DNS at Re τ = 1000: contour lines of u low-speedand high-speed

43 DNS of Couette flow Mean velocity u/uτ y +

44 DNS of Couette flow Mean velocity u/uτ y + Log-law fit u + = log y + /0.41

45 DNS of Couette flow Diagnostic function Ξ = y + du + /dy Ξ 2.5 k = No apparent tendency to log law! y +

46 DNS of Couette flow Velocity variances Horizontal components u 2 /u 2 τ w 2 /u 2 τ y y + Logarithmic decrease of w Emergence of outer peak of u

47 DNS of Couette flow Reynolds stress peaks Trend with Re τ 1.4 ui 2 pk /u i 2 pk (C1) Re τ Clear logarithmic growth of u and w No growth of v

48 DNS of Couette flow Spectral densities (pre-multiplied) Inner scaling C1 C2 C3 C4

49 DNS of Couette flow Production excess over dissipation y + (P + ε + ) Equilibrium hypothesis clearly violated at sufficiently high Re τ y +

50 DNS of Couette flow Coherent part of stresses (< u > u) 2 /u 2 τ < w > 2 /u 2 τ < v > 2 /u 2 τ y + < u >< v >/u 2 τ y/h Rollers responsible for significant fraction of Reynolds stresses

51 DNS of unstably stratified flows Computational set-up θ 2 y Π θ Q 2h L x u θ 1 > θ 2 Q L z Channel boundary layer Confined domain No rotation No roughness Imposed θ

52 Effects of unstable stratification Streets of cumulus clouds 2 4 km

53 Flow cases Reb Ra

54 Selection of computational mesh Grid selected so as to simultaneously satisfy Spacing restriction for Rayleigh-Bénard convection (Shishkina et al. 2010) Grid spacing restrictions for forced convection x + z For all simulations, /η 3 throughout Box size is a sensitive issue (reminiscent of Couette flow)... We eventually went for L x = 16h, L z = 8h

55 Flow cases Flow case Re b Ra Ri b h/l Re τ Nu C f N x N y N z RUN Ra9 Re NA RUN Ra9 Re E RUN Ra8 Re NA RUN Ra8 Re E RUN Ra8 Re E RUN Ra8 Re E RUN Ra8 Re E RUN Ra7 Re NA RUN Ra7 Re E RUN Ra7 Re E RUN Ra7 Re E RUN Ra7 Re3.5 LA E RUN Ra7 Re3.5 SM E RUN Ra7 Re3.5 NA E RUN Ra7 Re E RUN Ra7 Re E RUN Ra6 Re NA RUN Ra6 Re E RUN Ra6 Re E RUN Ra6 Re E RUN Ra6 Re E RUN Ra6 Re E RUN Ra6 Re E RUN Ra5 Re E RUN Ra5 Re E RUN Ra4 Re E RUN Ra4 Re E RUN Ra0 Re E RUN Ra0 Re E RUN Ra0 Re E

56 Flow cases DNS at Ri = 1: contour lines of θ cold and hot

57 Spectra Channel centerplane v Ez(v)(εν 5 ) 1/ k z 5/3 u Êz(u) v k zη θ λ z/h Êz(v) Êz(θ) Ri= Ri=100 Ri=10 Ri=1 Ri=0.1 Ri=0.01 Ri= λ z/h λ v = λ w = 2λ u λ z/h

58 Spectra Near-wall plane (y = y P ) u 10 0 v 10 0 kzêz(u) Ri b kzêz(v) h w λ z/h θ λ z/h kzêz(w) kzêz(θ) Ri b = Ri b =100 Ri b =10 Ri b =1 Ri b =0.1 Ri b =0.01 Ri b = λ z/h λ z/h

59 Free convection (Ri b ) Expectations Prandtl (32): the typical vertical velocity scale of buoyant plumes is vp = (βgqy) 1/3 the associated temperature scale is θp = Q 2/3 (βgy) 1/3 Prt const. Consequences Scaling of mean velocity and temperature θ(y) θ 0 θ τ = 3B θ [ (y/l) 1/3 (y 0 /L) 1/3[ u(y) u 0 u τ = 3B u [ (y/l) 1/3 (y 0 /L) 1/3] Velocity fluctuations to scale as v 2 /u 2 τ (y/l) 2/3 Temperature fluctuations to scale as θ 2 /θ 2 τ (y/l) 2/3

60 Flow statistics Free convection: power-law diagnostics θ d log(θcl θ)/d log y u d log u 2 /d log y Nu y/h Nu y/h KH θ d log θ 2 /d log y v d log v 2 /d log y Nu y/h Ra=10 6 Ra=10 7 Ra=10 8 Ra= Nu y/h Kader & Yaglom 90: u should depend on h-sized eddies (y/l) 2/3

61 Forced convection u u/uτ Re b = Re b =10 4 Re b = θ (θw θ)/θτ yu τ /ν k k θ yu τ /ν

62 Mixed convection Mean profiles θ (θ θcl)/ θ Ri b Ri b = Ri b =100 Ri b =10 Ri b =1 Ri b =0.1 Ri b =0.01 Ri b =0.001 Ri b =0 u u/ucl Ri b Ri b = 100 v y/h θ y/h v 21/2 /uτ Ri b θ 21/2 /θτ Ri b Ri b y/h y/h

63 Flow statistics Fluxes and correlations Ri b 1 Ri f Pr t Ri b yu τ/ν yu τ/ν 0.8 Ri b 0.8 Cvθ Cuθ Ri b =100 Ri b =10 Ri b =1 Ri b =0.1 Ri b =0.01 Ri b =0.001 Ri b =0 Ri b yu τ/ν Ri f = βgv θ u v du/dy, yu τ/ν Pr t = ν t α t = u v v θ dθ/dy du/dy

64 Monin-Obukhov similarity Obukhov 46, Monin & Obukhov 54: single length scale encapsulating effect of shear and buoyancy Flow fully characterized by u τ, L L = u3 τ Qβg Constancy of total stress and total heat flux u v τ w, v θ Q Universal representation ( ) y dθ y θ τ dy = ϕ h, L u 2 1/2 ( ) ( ) i y = ϕ i, θ 21/2 y = ϕ θ, u τ L θ τ L ( ) y du y u τ dy = ϕ m L u θ Asymptotic behavior discussed by Kader & Yaglom 90 Q = ϕ uθ ( y L )

65 Monin-Obukhov similarity Parametrizations Unstable stratification: Businger 71, Dyer 74 ϕ h = 1 k θ (1 + γ h y/l) α h, ϕ m = 1 k (1 + γ my/l) αm, Typical choice (Paulson 70): k = k θ = 0.35, γ m = γ h = 16, α h = 1/2, α m = 1/4 Quantity k DNS γ DNS α DNS α KY α BDP ϕ h /3-1/2 ϕ m /3-1/4 ϕ /3 / ϕ /3 1/3 ϕ θ /3 / ϕ uθ /3 / KY Kader & Yaglom 90, BDP Businger-Dyer-Panofsky Account for deviations from alleged free-convection scaling Widely used as wall models for LES of atmospheric BL (e.g. Khanna & Brasseur 97, 98)

66 Monin-Obukhov similarity DNS data θ 10 1 u 10 1 y/θτ dθ/dy 10 0 y/uτ du/dy y/l y/l Solid: KY, Dashed: BDP; Chained: DNS fit

67 Monin-Obukhov similarity DNS data u 10 1 v 10 1 u 21/2 /uτ 10 0 v 21/2 /uτ y/l y/l Solid: KY, Dashed: BDP; Chained: DNS fit

68 Monin-Obukhov similarity DNS data θ 10 1 u θ 10 1 θ 21/2 /θτ 10 0 u θ /Q y/l y/l Solid: KY, Dashed: BDP; Chained: DNS fit

69 Summary DNS of canonical flows starting to approach Re τ typical of asymptotic wall turbulence Near log layer found for mean velocity Significant flow-dependent deviations: Re τ limit unclear Logarithmic growth of velocity variances confirmed: unbounded growth in wall units? Rollers form in wide variety of flow conditions (0.01 Ri b 100) Aspect ratio 2 at least Strong modulation of near-wall region Prandtl scaling for natural convection does not show up Monin-Obukhov scaling applies to bulk flow, but not to individual profiles Significant deviations in light-wind regime DNS data available at

Boundary layer flows The logarithmic law of the wall Mixing length model for turbulent viscosity

Boundary layer flows The logarithmic law of the wall Mixing length model for turbulent viscosity Boundary layer flows The logarithmic law of the wall Mixing length model for turbulent viscosity Tobias Knopp D 23. November 28 Reynolds averaged Navier-Stokes equations Consider the RANS equations with

More information

Logarithmic velocity profile in the atmospheric (rough wall) boundary layer

Logarithmic velocity profile in the atmospheric (rough wall) boundary layer Logarithmic velocity profile in the atmospheric (rough wall) boundary layer P =< u w > U z = u 2 U z ~ ε = u 3 /kz Mean velocity profile in the Atmospheric Boundary layer Experimentally it was found that

More information

Reynolds number scaling of inertial particle statistics in turbulent channel flows

Reynolds number scaling of inertial particle statistics in turbulent channel flows Reynolds number scaling of inertial particle statistics in turbulent channel flows Matteo Bernardini Dipartimento di Ingegneria Meccanica e Aerospaziale Università di Roma La Sapienza Paolo Orlandi s 70th

More information

Boundary-Layer Theory

Boundary-Layer Theory Hermann Schlichting Klaus Gersten Boundary-Layer Theory With contributions from Egon Krause and Herbert Oertel Jr. Translated by Katherine Mayes 8th Revised and Enlarged Edition With 287 Figures and 22

More information

ROLE OF LARGE SCALE MOTIONS IN TURBULENT POISEUILLE AND COUETTE FLOWS

ROLE OF LARGE SCALE MOTIONS IN TURBULENT POISEUILLE AND COUETTE FLOWS 10 th International Symposium on Turbulence and Shear Flow Phenomena (TSFP10), Chicago, USA, July, 2017 ROLE OF LARGE SCALE MOTIONS IN TURBULENT POISEUILLE AND COUETTE FLOWS Myoungkyu Lee Robert D. Moser

More information

NONLINEAR FEATURES IN EXPLICIT ALGEBRAIC MODELS FOR TURBULENT FLOWS WITH ACTIVE SCALARS

NONLINEAR FEATURES IN EXPLICIT ALGEBRAIC MODELS FOR TURBULENT FLOWS WITH ACTIVE SCALARS June - July, 5 Melbourne, Australia 9 7B- NONLINEAR FEATURES IN EXPLICIT ALGEBRAIC MODELS FOR TURBULENT FLOWS WITH ACTIVE SCALARS Werner M.J. Lazeroms () Linné FLOW Centre, Department of Mechanics SE-44

More information

TURBULENT BOUNDARY LAYERS: CURRENT RESEARCH AND FUTURE DIRECTIONS

TURBULENT BOUNDARY LAYERS: CURRENT RESEARCH AND FUTURE DIRECTIONS TURBULENT BOUNDARY LAYERS: CURRENT RESEARCH AND FUTURE DIRECTIONS Beverley J. McKeon Graduate Aerospace Laboratories California Institute of Technology http://mckeon.caltech.edu * AFOSR #s FA9550-08-1-0049,

More information

The JHU Turbulence Databases (JHTDB)

The JHU Turbulence Databases (JHTDB) The JHU Turbulence Databases (JHTDB) TURBULENT CHANNEL FLOW DATA SET Data provenance: J. Graham 1, M. Lee 2, N. Malaya 2, R.D. Moser 2, G. Eyink 1 & C. Meneveau 1 Database ingest and Web Services: K. Kanov

More information

Velocity statistics in turbulent channel flow up to Re τ = 4000

Velocity statistics in turbulent channel flow up to Re τ = 4000 Under consideration for publication in J. Fluid Mech. 1 Velocity statistics in turbulent channel flow up to Re τ = 4 MATTEO BERNARDINI, SERGIO PIROZZOLI and PAOLO ORLANDI Dipartimento di Ingegneria Meccanica

More information

Wall turbulence with arbitrary mean velocity profiles

Wall turbulence with arbitrary mean velocity profiles Center for Turbulence Research Annual Research Briefs 7 Wall turbulence with arbitrary mean velocity profiles By J. Jiménez. Motivation The original motivation for this work was an attempt to shorten the

More information

Table of Contents. Foreword... xiii. Preface... xv

Table of Contents. Foreword... xiii. Preface... xv Table of Contents Foreword.... xiii Preface... xv Chapter 1. Fundamental Equations, Dimensionless Numbers... 1 1.1. Fundamental equations... 1 1.1.1. Local equations... 1 1.1.2. Integral conservation equations...

More information

The JHU Turbulence Databases (JHTDB)

The JHU Turbulence Databases (JHTDB) The JHU Turbulence Databases (JHTDB) TURBULENT CHANNEL FLOW AT Re τ = 5200 DATA SET Data provenance: M. Lee 1 & R. D. Moser 1 Database ingest and Web Services: Z. Wu 2, G. Lemson 2, R. Burns 2, A. Szalay

More information

Turbulent boundary layer

Turbulent boundary layer Turbulent boundary layer 0. Are they so different from laminar flows? 1. Three main effects of a solid wall 2. Statistical description: equations & results 3. Mean velocity field: classical asymptotic

More information

CHAPTER 11: REYNOLDS-STRESS AND RELATED MODELS. Turbulent Flows. Stephen B. Pope Cambridge University Press, 2000 c Stephen B. Pope y + < 1.

CHAPTER 11: REYNOLDS-STRESS AND RELATED MODELS. Turbulent Flows. Stephen B. Pope Cambridge University Press, 2000 c Stephen B. Pope y + < 1. 1/3 η 1C 2C, axi 1/6 2C y + < 1 axi, ξ > 0 y + 7 axi, ξ < 0 log-law region iso ξ -1/6 0 1/6 1/3 Figure 11.1: The Lumley triangle on the plane of the invariants ξ and η of the Reynolds-stress anisotropy

More information

DNS STUDY OF TURBULENT HEAT TRANSFER IN A SPANWISE ROTATING SQUARE DUCT

DNS STUDY OF TURBULENT HEAT TRANSFER IN A SPANWISE ROTATING SQUARE DUCT 10 th International Symposium on Turbulence and Shear Flow Phenomena (TSFP10), Chicago, USA, July, 2017 DNS STUDY OF TURBULENT HEAT TRANSFER IN A SPANWISE ROTATING SQUARE DUCT Bing-Chen Wang Department

More information

The stagnation point Karman constant

The stagnation point Karman constant . p.1/25 The stagnation point Karman constant V. Dallas & J.C. Vassilicos Imperial College London Using a code developed at the Université de Poitiers by S. Laizet & E. Lamballais . p.2/25 DNS of turbulent

More information

Shear Turbulence. Fabian Waleffe. Depts. of Mathematics and Engineering Physics. Wisconsin

Shear Turbulence. Fabian Waleffe. Depts. of Mathematics and Engineering Physics. Wisconsin Shear Turbulence Fabian Waleffe Depts. of Mathematics and Engineering Physics, Madison University of Wisconsin Mini-Symposium on Subcritical Flow Instability for training of early stage researchers Mini-Symposium

More information

DAY 19: Boundary Layer

DAY 19: Boundary Layer DAY 19: Boundary Layer flat plate : let us neglect the shape of the leading edge for now flat plate boundary layer: in blue we highlight the region of the flow where velocity is influenced by the presence

More information

An evaluation of a conservative fourth order DNS code in turbulent channel flow

An evaluation of a conservative fourth order DNS code in turbulent channel flow Center for Turbulence Research Annual Research Briefs 2 2 An evaluation of a conservative fourth order DNS code in turbulent channel flow By Jessica Gullbrand. Motivation and objectives Direct numerical

More information

Analysis of Turbulent Free Convection in a Rectangular Rayleigh-Bénard Cell

Analysis of Turbulent Free Convection in a Rectangular Rayleigh-Bénard Cell Proceedings of the 8 th International Symposium on Experimental and Computational Aerothermodynamics of Internal Flows Lyon, July 2007 Paper reference : ISAIF8-00130 Analysis of Turbulent Free Convection

More information

Lecture 3. Turbulent fluxes and TKE budgets (Garratt, Ch 2)

Lecture 3. Turbulent fluxes and TKE budgets (Garratt, Ch 2) Lecture 3. Turbulent fluxes and TKE budgets (Garratt, Ch 2) The ABL, though turbulent, is not homogeneous, and a critical role of turbulence is transport and mixing of air properties, especially in the

More information

Numerical and Experimental Results

Numerical and Experimental Results (G) Numerical and Experimental Results To begin, we shall show some data of R. D. Moser, J. Kim & N. N. Mansour, Direct numerical simulation of turbulent flow up to Re τ = 59, Phys. Fluids 11 943-945 (1999)

More information

Open boundary conditions in numerical simulations of unsteady incompressible flow

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

More information

Turbulence - Theory and Modelling GROUP-STUDIES:

Turbulence - Theory and Modelling GROUP-STUDIES: Lund Institute of Technology Department of Energy Sciences Division of Fluid Mechanics Robert Szasz, tel 046-0480 Johan Revstedt, tel 046-43 0 Turbulence - Theory and Modelling GROUP-STUDIES: Turbulence

More information

A dynamic global-coefficient subgrid-scale eddy-viscosity model for large-eddy simulation in complex geometries

A dynamic global-coefficient subgrid-scale eddy-viscosity model for large-eddy simulation in complex geometries Center for Turbulence Research Annual Research Briefs 2006 41 A dynamic global-coefficient subgrid-scale eddy-viscosity model for large-eddy simulation in complex geometries By D. You AND P. Moin 1. Motivation

More information

Influence of high temperature gradient on turbulence spectra

Influence of high temperature gradient on turbulence spectra NIA CFD Conference, Hampton, August 6-8, 2012 Future Directions in CFD Research, A Modeling and Simulation Conference Influence of high temperature gradient on turbulence spectra Sylvain Serra Françoise

More information

Principles of Convection

Principles of Convection Principles of Convection Point Conduction & convection are similar both require the presence of a material medium. But convection requires the presence of fluid motion. Heat transfer through the: Solid

More information

FLOW-NORDITA Spring School on Turbulent Boundary Layers1

FLOW-NORDITA Spring School on Turbulent Boundary Layers1 Jonathan F. Morrison, Ati Sharma Department of Aeronautics Imperial College, London & Beverley J. McKeon Graduate Aeronautical Laboratories, California Institute Technology FLOW-NORDITA Spring School on

More information

Curriculum Vitae of Sergio Pirozzoli

Curriculum Vitae of Sergio Pirozzoli Curriculum Vitae of Sergio Pirozzoli Address University of Rome La Sapienza Department of Mechanical and Aerospace Engineering Via Eudossiana 18 00184, Roma Contact tel.: +39 06 44585202 fax : +39 06 4881759

More information

A Finite-Element based Navier-Stokes Solver for LES

A Finite-Element based Navier-Stokes Solver for LES A Finite-Element based Navier-Stokes Solver for LES W. Wienken a, J. Stiller b and U. Fladrich c. a Technische Universität Dresden, Institute of Fluid Mechanics (ISM) b Technische Universität Dresden,

More information

10. Buoyancy-driven flow

10. Buoyancy-driven flow 10. Buoyancy-driven flow For such flows to occur, need: Gravity field Variation of density (note: not the same as variable density!) Simplest case: Viscous flow, incompressible fluid, density-variation

More information

Before we consider two canonical turbulent flows we need a general description of turbulence.

Before we consider two canonical turbulent flows we need a general description of turbulence. Chapter 2 Canonical Turbulent Flows Before we consider two canonical turbulent flows we need a general description of turbulence. 2.1 A Brief Introduction to Turbulence One way of looking at turbulent

More information

WALL RESOLUTION STUDY FOR DIRECT NUMERICAL SIMULATION OF TURBULENT CHANNEL FLOW USING A MULTIDOMAIN CHEBYSHEV GRID

WALL RESOLUTION STUDY FOR DIRECT NUMERICAL SIMULATION OF TURBULENT CHANNEL FLOW USING A MULTIDOMAIN CHEBYSHEV GRID WALL RESOLUTION STUDY FOR DIRECT NUMERICAL SIMULATION OF TURBULENT CHANNEL FLOW USING A MULTIDOMAIN CHEBYSHEV GRID Zia Ghiasi sghias@uic.edu Dongru Li dli@uic.edu Jonathan Komperda jonk@uic.edu Farzad

More information

Turbulence Modeling I!

Turbulence Modeling I! Outline! Turbulence Modeling I! Grétar Tryggvason! Spring 2010! Why turbulence modeling! Reynolds Averaged Numerical Simulations! Zero and One equation models! Two equations models! Model predictions!

More information

Hybrid LES RANS Method Based on an Explicit Algebraic Reynolds Stress Model

Hybrid LES RANS Method Based on an Explicit Algebraic Reynolds Stress Model Hybrid RANS Method Based on an Explicit Algebraic Reynolds Stress Model Benoit Jaffrézic, Michael Breuer and Antonio Delgado Institute of Fluid Mechanics, LSTM University of Nürnberg bjaffrez/breuer@lstm.uni-erlangen.de

More information

Analysis and comparison between rough channel and pipe flows

Analysis and comparison between rough channel and pipe flows Journal of Physics: Conference Series PAPER OPEN ACCESS Analysis and comparison between rough channel and pipe flows To cite this article: David Sassun et al 2016 J. Phys.: Conf. Ser. 708 012011 View the

More information

Role of polymers in the mixing of Rayleigh-Taylor turbulence

Role of polymers in the mixing of Rayleigh-Taylor turbulence Physics Department University of Genova Italy Role of polymers in the mixing of Rayleigh-Taylor turbulence Andrea Mazzino andrea.mazzino@unige.it Guido Boffetta: University of Torino (Italy) Stefano Musacchio:

More information

Computation of turbulent natural convection at vertical walls using new wall functions

Computation of turbulent natural convection at vertical walls using new wall functions Computation of turbulent natural convection at vertical alls using ne all functions M. Hölling, H. Herig Institute of Thermo-Fluid Dynamics Hamburg University of Technology Denickestraße 17, 2173 Hamburg,

More information

Numerical Methods in Aerodynamics. Turbulence Modeling. Lecture 5: Turbulence modeling

Numerical Methods in Aerodynamics. Turbulence Modeling. Lecture 5: Turbulence modeling Turbulence Modeling Niels N. Sørensen Professor MSO, Ph.D. Department of Civil Engineering, Alborg University & Wind Energy Department, Risø National Laboratory Technical University of Denmark 1 Outline

More information

Exercise 5: Exact Solutions to the Navier-Stokes Equations I

Exercise 5: Exact Solutions to the Navier-Stokes Equations I Fluid Mechanics, SG4, HT009 September 5, 009 Exercise 5: Exact Solutions to the Navier-Stokes Equations I Example : Plane Couette Flow Consider the flow of a viscous Newtonian fluid between two parallel

More information

Turbulent Boundary Layers & Turbulence Models. Lecture 09

Turbulent Boundary Layers & Turbulence Models. Lecture 09 Turbulent Boundary Layers & Turbulence Models Lecture 09 The turbulent boundary layer In turbulent flow, the boundary layer is defined as the thin region on the surface of a body in which viscous effects

More information

Engineering. Spring Department of Fluid Mechanics, Budapest University of Technology and Economics. Large-Eddy Simulation in Mechanical

Engineering. Spring Department of Fluid Mechanics, Budapest University of Technology and Economics. Large-Eddy Simulation in Mechanical Outline Geurts Book Department of Fluid Mechanics, Budapest University of Technology and Economics Spring 2013 Outline Outline Geurts Book 1 Geurts Book Origin This lecture is strongly based on the book:

More information

A Simple Turbulence Closure Model

A Simple Turbulence Closure Model A Simple Turbulence Closure Model Atmospheric Sciences 6150 1 Cartesian Tensor Notation Reynolds decomposition of velocity: Mean velocity: Turbulent velocity: Gradient operator: Advection operator: V =

More information

Homework 4 in 5C1212; Part A: Incompressible Navier- Stokes, Finite Volume Methods

Homework 4 in 5C1212; Part A: Incompressible Navier- Stokes, Finite Volume Methods Homework 4 in 5C11; Part A: Incompressible Navier- Stokes, Finite Volume Methods Consider the incompressible Navier Stokes in two dimensions u x + v y = 0 u t + (u ) x + (uv) y + p x = 1 Re u + f (1) v

More information

Chapter 7: Natural Convection

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

More information

Generation of initial fields for channel flow investigation

Generation of initial fields for channel flow investigation Generation of initial fields for channel flow investigation Markus Uhlmann Potsdam Institut für Klimafolgenforschung, D-442 Potsdam uhlmann@pik-potsdam.de (Mai 2) In the framework of the DFG-funded research

More information

Outline: Phenomenology of Wall Bounded Turbulence: Minimal Models First Story: Large Re Neutrally-Stratified (NS) Channel Flow.

Outline: Phenomenology of Wall Bounded Turbulence: Minimal Models First Story: Large Re Neutrally-Stratified (NS) Channel Flow. Victor S. L vov: Israeli-Italian March 2007 Meeting Phenomenology of Wall Bounded Turbulence: Minimal Models In collaboration with : Anna Pomyalov, Itamar Procaccia, Oleksii Rudenko (WIS), Said Elgobashi

More information

Colloquium FLUID DYNAMICS 2012 Institute of Thermomechanics AS CR, v.v.i., Prague, October 24-26, 2012 p.

Colloquium FLUID DYNAMICS 2012 Institute of Thermomechanics AS CR, v.v.i., Prague, October 24-26, 2012 p. Colloquium FLUID DYNAMICS 212 Institute of Thermomechanics AS CR, v.v.i., Prague, October 24-26, 212 p. ON A COMPARISON OF NUMERICAL SIMULATIONS OF ATMOSPHERIC FLOW OVER COMPLEX TERRAIN T. Bodnár, L. Beneš

More information

arxiv: v1 [physics.flu-dyn] 10 Dec 2018

arxiv: v1 [physics.flu-dyn] 10 Dec 2018 REVISITING THE AMPLITUDE MODULATION IN WALL-BOUNDED TURBULENCE: TOWARDS A ROBUST DEFINITION Eda Dogan 1, Ramis Örlü 1, Davide Gatti 2, Ricardo Vinuesa 1 and Philipp Schlatter 1 1 Linné FLOW Centre, KTH

More information

Turbulence and its modelling. Outline. Department of Fluid Mechanics, Budapest University of Technology and Economics.

Turbulence and its modelling. Outline. Department of Fluid Mechanics, Budapest University of Technology and Economics. Outline Department of Fluid Mechanics, Budapest University of Technology and Economics October 2009 Outline Outline Definition and Properties of Properties High Re number Disordered, chaotic 3D phenomena

More information

Masters in Mechanical Engineering. Problems of incompressible viscous flow. 2µ dx y(y h)+ U h y 0 < y < h,

Masters in Mechanical Engineering. Problems of incompressible viscous flow. 2µ dx y(y h)+ U h y 0 < y < h, Masters in Mechanical Engineering Problems of incompressible viscous flow 1. Consider the laminar Couette flow between two infinite flat plates (lower plate (y = 0) with no velocity and top plate (y =

More information

Coherent structures in stably stratified plane Couette flow

Coherent structures in stably stratified plane Couette flow Coherent structures in stably stratified plane Couette flow D. Olvera * & R. R. Kerswell School of Mathematics, University of Bristol, Bristol, UK. * do2542@bristol.ac.uk Abstract A large body of recent

More information

Homogeneous Rayleigh-Bénard convection

Homogeneous Rayleigh-Bénard convection Slide 1 Homogeneous Rayleigh-Bénard convection scaling, heat transport and structures E. Calzavarini and F. Toschi, D. Lohse, R. Tripiccione, C. R. Doering, J. D. Gibbon, A. Tanabe Euromech Colloquium

More information

Direct and Large Eddy Simulation of stably stratified turbulent Ekman layers

Direct and Large Eddy Simulation of stably stratified turbulent Ekman layers Direct and Large Eddy Simulation of stably stratified turbulent Ekman layers Stimit Shah, Elie Bou-Zeid Princeton University 64 th APS DFD Baltimore, Maryland Nov 21, 211 Effect of Stability on Atmospheric

More information

Very large-scale structures observed in DNS of turbulent channel flow with passive scalar transport

Very large-scale structures observed in DNS of turbulent channel flow with passive scalar transport 5 th Australasian Fluid Mechanics Conference 3-7 December 4 Very large-scale structures observed in DNS of turbulent channel flow with passive scalar transport H. Kawamura, H. Abe and Y. Matsuo Department

More information

2.3 The Turbulent Flat Plate Boundary Layer

2.3 The Turbulent Flat Plate Boundary Layer Canonical Turbulent Flows 19 2.3 The Turbulent Flat Plate Boundary Layer The turbulent flat plate boundary layer (BL) is a particular case of the general class of flows known as boundary layer flows. The

More information

An Introduction to Theories of Turbulence. James Glimm Stony Brook University

An Introduction to Theories of Turbulence. James Glimm Stony Brook University An Introduction to Theories of Turbulence James Glimm Stony Brook University Topics not included (recent papers/theses, open for discussion during this visit) 1. Turbulent combustion 2. Turbulent mixing

More information

Available online at ScienceDirect. Procedia Engineering 90 (2014 )

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

More information

Two-dimensional energy spectra in high-reynolds-number turbulent boundary layers

Two-dimensional energy spectra in high-reynolds-number turbulent boundary layers J. Fluid Mech. (217), vol. 826, R1, doi:1.117/jfm.217.359 journals.cambridge.org/rapids Two-dimensional energy spectra in high-reynolds-number turbulent boundary layers Dileep Chandran 1,, Rio Baidya 1,

More information

Chapter 8 Flow in Conduits

Chapter 8 Flow in Conduits 57:00 Mechanics of Fluids and Transport Processes Chapter 8 Professor Fred Stern Fall 013 1 Chapter 8 Flow in Conduits Entrance and developed flows Le = f(d, V,, ) i theorem Le/D = f(re) Laminar flow:

More information

INFLUENCE OF THE BOUNDARY CONDITIONS ON A TEMPERATURE FIELD IN THE TURBULENT FLOW NEAR THE HEATED WALL

INFLUENCE OF THE BOUNDARY CONDITIONS ON A TEMPERATURE FIELD IN THE TURBULENT FLOW NEAR THE HEATED WALL International Conference Nuclear Energy for New Europe 22 Kranjska Gora, Slovenia, September 9-2, 22 www.drustvo-js.si/gora22 INFLUENCE OF THE BOUNDARY CONDITIONS ON A TEMPERATURE FIELD IN THE TURBULENT

More information

Turbulent drag reduction by streamwise traveling waves

Turbulent drag reduction by streamwise traveling waves 51st IEEE Conference on Decision and Control December 10-13, 2012. Maui, Hawaii, USA Turbulent drag reduction by streamwise traveling waves Armin Zare, Binh K. Lieu, and Mihailo R. Jovanović Abstract For

More information

Fluid Mechanics. Chapter 9 Surface Resistance. Dr. Amer Khalil Ababneh

Fluid Mechanics. Chapter 9 Surface Resistance. Dr. Amer Khalil Ababneh Fluid Mechanics Chapter 9 Surface Resistance Dr. Amer Khalil Ababneh Wind tunnel used for testing flow over models. Introduction Resistances exerted by surfaces are a result of viscous stresses which create

More information

A Simple Turbulence Closure Model. Atmospheric Sciences 6150

A Simple Turbulence Closure Model. Atmospheric Sciences 6150 A Simple Turbulence Closure Model Atmospheric Sciences 6150 1 Cartesian Tensor Notation Reynolds decomposition of velocity: V = V + v V = U i + u i Mean velocity: V = Ui + V j + W k =(U, V, W ) U i =(U

More information

Multiscale Computation of Isotropic Homogeneous Turbulent Flow

Multiscale Computation of Isotropic Homogeneous Turbulent Flow Multiscale Computation of Isotropic Homogeneous Turbulent Flow Tom Hou, Danping Yang, and Hongyu Ran Abstract. In this article we perform a systematic multi-scale analysis and computation for incompressible

More information

Experience with DNS of particulate flow using a variant of the immersed boundary method

Experience with DNS of particulate flow using a variant of the immersed boundary method Experience with DNS of particulate flow using a variant of the immersed boundary method Markus Uhlmann Numerical Simulation and Modeling Unit CIEMAT Madrid, Spain ECCOMAS CFD 2006 Motivation wide range

More information

Introduction to Turbulence and Turbulence Modeling

Introduction to Turbulence and Turbulence Modeling Introduction to Turbulence and Turbulence Modeling Part I Venkat Raman The University of Texas at Austin Lecture notes based on the book Turbulent Flows by S. B. Pope Turbulent Flows Turbulent flows Commonly

More information

Effect of an adiabatic fin on natural convection heat transfer in a triangular enclosure

Effect of an adiabatic fin on natural convection heat transfer in a triangular enclosure American Journal of Applied Mathematics 2013; 1(4): 78-83 Published online November 10, 2013 (http://www.sciencepublishinggroup.com/j/ajam) doi: 10.11648/j.ajam.20130104.16 Effect of an adiabatic fin on

More information

Fundamentals of Fluid Dynamics: Elementary Viscous Flow

Fundamentals of Fluid Dynamics: Elementary Viscous Flow Fundamentals of Fluid Dynamics: Elementary Viscous Flow Introductory Course on Multiphysics Modelling TOMASZ G. ZIELIŃSKI bluebox.ippt.pan.pl/ tzielins/ Institute of Fundamental Technological Research

More information

Computation of turbulent Prandtl number for mixed convection around a heated cylinder

Computation of turbulent Prandtl number for mixed convection around a heated cylinder Center for Turbulence Research Annual Research Briefs 2010 295 Computation of turbulent Prandtl number for mixed convection around a heated cylinder By S. Kang AND G. Iaccarino 1. Motivation and objectives

More information

SECONDARY MOTION IN TURBULENT FLOWS OVER SUPERHYDROPHOBIC SURFACES

SECONDARY MOTION IN TURBULENT FLOWS OVER SUPERHYDROPHOBIC SURFACES SECONDARY MOTION IN TURBULENT FLOWS OVER SUPERHYDROPHOBIC SURFACES Yosuke Hasegawa Institute of Industrial Science The University of Tokyo Komaba 4-6-1, Meguro-ku, Tokyo 153-8505, Japan ysk@iis.u-tokyo.ac.jp

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

Numerical simulation of wave breaking in turbulent two-phase Couette flow

Numerical simulation of wave breaking in turbulent two-phase Couette flow Center for Turbulence Research Annual Research Briefs 2012 171 Numerical simulation of wave breaking in turbulent two-phase Couette flow By D. Kim, A. Mani AND P. Moin 1. Motivation and objectives When

More information

Comparison of Turbulence Models in the Flow over a Backward-Facing Step Priscila Pires Araujo 1, André Luiz Tenório Rezende 2

Comparison of Turbulence Models in the Flow over a Backward-Facing Step Priscila Pires Araujo 1, André Luiz Tenório Rezende 2 Comparison of Turbulence Models in the Flow over a Backward-Facing Step Priscila Pires Araujo 1, André Luiz Tenório Rezende 2 Department of Mechanical and Materials Engineering, Military Engineering Institute,

More information

The Atmospheric Boundary Layer. The Surface Energy Balance (9.2)

The Atmospheric Boundary Layer. The Surface Energy Balance (9.2) The Atmospheric Boundary Layer Turbulence (9.1) The Surface Energy Balance (9.2) Vertical Structure (9.3) Evolution (9.4) Special Effects (9.5) The Boundary Layer in Context (9.6) Fair Weather over Land

More information

7.6 Example von Kármán s Laminar Boundary Layer Problem

7.6 Example von Kármán s Laminar Boundary Layer Problem CEE 3310 External Flows (Boundary Layers & Drag, Nov. 11, 2016 157 7.5 Review Non-Circular Pipes Laminar: f = 64/Re DH ± 40% Turbulent: f(re DH, ɛ/d H ) Moody chart for f ± 15% Bernoulli-Based Flow Metering

More information

OPTIMIZATION OF HEAT TRANSFER ENHANCEMENT IN PLANE COUETTE FLOW

OPTIMIZATION OF HEAT TRANSFER ENHANCEMENT IN PLANE COUETTE FLOW OPTIMIZATION OF HEAT TRANSFER ENHANCEMENT IN PLANE COUETTE FLOW Shingo Motoki, Genta Kawahara and Masaki Shimizu Graduate School of Engineering Science Osaka University 1-3 Machikaneyama, Toyonaka, Osaka

More information

Explicit algebraic Reynolds stress models for boundary layer flows

Explicit algebraic Reynolds stress models for boundary layer flows 1. Explicit algebraic models Two explicit algebraic models are here compared in order to assess their predictive capabilities in the simulation of boundary layer flow cases. The studied models are both

More information

General introduction to Hydrodynamic Instabilities

General introduction to Hydrodynamic Instabilities KTH ROYAL INSTITUTE OF TECHNOLOGY General introduction to Hydrodynamic Instabilities L. Brandt & J.-Ch. Loiseau KTH Mechanics, November 2015 Luca Brandt Professor at KTH Mechanics Email: luca@mech.kth.se

More information

CHAPTER 4 BOUNDARY LAYER FLOW APPLICATION TO EXTERNAL FLOW

CHAPTER 4 BOUNDARY LAYER FLOW APPLICATION TO EXTERNAL FLOW CHAPTER 4 BOUNDARY LAYER FLOW APPLICATION TO EXTERNAL FLOW 4.1 Introduction Boundary layer concept (Prandtl 1904): Eliminate selected terms in the governing equations Two key questions (1) What are the

More information

A combined application of the integral wall model and the rough wall rescaling-recycling method

A combined application of the integral wall model and the rough wall rescaling-recycling method AIAA 25-299 A combined application of the integral wall model and the rough wall rescaling-recycling method X.I.A. Yang J. Sadique R. Mittal C. Meneveau Johns Hopkins University, Baltimore, MD, 228, USA

More information

Fluid Dynamics: Theory, Computation, and Numerical Simulation Second Edition

Fluid Dynamics: Theory, Computation, and Numerical Simulation Second Edition Fluid Dynamics: Theory, Computation, and Numerical Simulation Second Edition C. Pozrikidis m Springer Contents Preface v 1 Introduction to Kinematics 1 1.1 Fluids and solids 1 1.2 Fluid parcels and flow

More information

Lattice-Boltzmann vs. Navier-Stokes simulation of particulate flows

Lattice-Boltzmann vs. Navier-Stokes simulation of particulate flows Lattice-Boltzmann vs. Navier-Stokes simulation of particulate flows Amir Eshghinejadfard, Abouelmagd Abdelsamie, Dominique Thévenin University of Magdeburg, Germany 14th Workshop on Two-Phase Flow Predictions

More information

Chapter 9: Differential Analysis of Fluid Flow

Chapter 9: Differential Analysis of Fluid Flow of Fluid Flow Objectives 1. Understand how the differential equations of mass and momentum conservation are derived. 2. Calculate the stream function and pressure field, and plot streamlines for a known

More information

AER1310: TURBULENCE MODELLING 1. Introduction to Turbulent Flows C. P. T. Groth c Oxford Dictionary: disturbance, commotion, varying irregularly

AER1310: TURBULENCE MODELLING 1. Introduction to Turbulent Flows C. P. T. Groth c Oxford Dictionary: disturbance, commotion, varying irregularly 1. Introduction to Turbulent Flows Coverage of this section: Definition of Turbulence Features of Turbulent Flows Numerical Modelling Challenges History of Turbulence Modelling 1 1.1 Definition of Turbulence

More information

Numerical Heat and Mass Transfer

Numerical Heat and Mass Transfer Master Degree in Mechanical Engineering Numerical Heat and Mass Transfer 19 Turbulent Flows Fausto Arpino f.arpino@unicas.it Introduction All the flows encountered in the engineering practice become unstable

More information

Note the diverse scales of eddy motion and self-similar appearance at different lengthscales of the turbulence in this water jet. Only eddies of size

Note the diverse scales of eddy motion and self-similar appearance at different lengthscales of the turbulence in this water jet. Only eddies of size L Note the diverse scales of eddy motion and self-similar appearance at different lengthscales of the turbulence in this water jet. Only eddies of size 0.01L or smaller are subject to substantial viscous

More information

Some remarks on grad-div stabilization of incompressible flow simulations

Some remarks on grad-div stabilization of incompressible flow simulations Some remarks on grad-div stabilization of incompressible flow simulations Gert Lube Institute for Numerical and Applied Mathematics Georg-August-University Göttingen M. Stynes Workshop Numerical Analysis

More information

Large eddy simulation of turbulent flow over a backward-facing step: effect of inflow conditions

Large eddy simulation of turbulent flow over a backward-facing step: effect of inflow conditions June 30 - July 3, 2015 Melbourne, Australia 9 P-26 Large eddy simulation of turbulent flow over a backward-facing step: effect of inflow conditions Jungwoo Kim Department of Mechanical System Design Engineering

More information

Feedback Control of Turbulent Wall Flows

Feedback Control of Turbulent Wall Flows Feedback Control of Turbulent Wall Flows Dipartimento di Ingegneria Aerospaziale Politecnico di Milano Outline Introduction Standard approach Wiener-Hopf approach Conclusions Drag reduction A model problem:

More information

1 The Richardson Number 1 1a Flux Richardson Number b Gradient Richardson Number c Bulk Richardson Number The Obukhov Length 3

1 The Richardson Number 1 1a Flux Richardson Number b Gradient Richardson Number c Bulk Richardson Number The Obukhov Length 3 Contents 1 The Richardson Number 1 1a Flux Richardson Number...................... 1 1b Gradient Richardson Number.................... 2 1c Bulk Richardson Number...................... 3 2 The Obukhov

More information

Bounds on Surface Stress Driven Flows

Bounds on Surface Stress Driven Flows Bounds on Surface Stress Driven Flows George Hagstrom Charlie Doering January 1, 9 1 Introduction In the past fifteen years the background method of Constantin, Doering, and Hopf has been used to derive

More information

CONVECTIVE HEAT TRANSFER

CONVECTIVE HEAT TRANSFER CONVECTIVE HEAT TRANSFER Mohammad Goharkhah Department of Mechanical Engineering, Sahand Unversity of Technology, Tabriz, Iran CHAPTER 4 HEAT TRANSFER IN CHANNEL FLOW BASIC CONCEPTS BASIC CONCEPTS Laminar

More information

Eddy viscosity. AdOc 4060/5060 Spring 2013 Chris Jenkins. Turbulence (video 1hr):

Eddy viscosity. AdOc 4060/5060 Spring 2013 Chris Jenkins. Turbulence (video 1hr): AdOc 4060/5060 Spring 2013 Chris Jenkins Eddy viscosity Turbulence (video 1hr): http://cosee.umaine.edu/programs/webinars/turbulence/?cfid=8452711&cftoken=36780601 Part B Surface wind stress Wind stress

More information

The Effect of the DNS Data Averaging Time on the Accuracy of RANS-DNS Simulations

The Effect of the DNS Data Averaging Time on the Accuracy of RANS-DNS Simulations The Effect of the DNS Data Averaging Time on the Accuracy of RANS-DNS Simulations Svetlana V. Poroseva 1, The University of New Mexico, Albuquerque, New Mexico, 87131 Elbert Jeyapaul 2, Scott M. Murman

More information

Introduction to Turbulence AEEM Why study turbulent flows?

Introduction to Turbulence AEEM Why study turbulent flows? Introduction to Turbulence AEEM 7063-003 Dr. Peter J. Disimile UC-FEST Department of Aerospace Engineering Peter.disimile@uc.edu Intro to Turbulence: C1A Why 1 Most flows encountered in engineering and

More information

A Scalable, Parallel Implementation of Weighted, Non-Linear Compact Schemes

A Scalable, Parallel Implementation of Weighted, Non-Linear Compact Schemes A Scalable, Parallel Implementation of Weighted, Non-Linear Compact Schemes Debojyoti Ghosh Emil M. Constantinescu Jed Brown Mathematics Computer Science Argonne National Laboratory SIAM Annual Meeting

More information

Turbulence modelling. Sørensen, Niels N. Publication date: Link back to DTU Orbit

Turbulence modelling. Sørensen, Niels N. Publication date: Link back to DTU Orbit Downloaded from orbit.dtu.dk on: Dec 19, 2017 Turbulence modelling Sørensen, Niels N. Publication date: 2010 Link back to DTU Orbit Citation (APA): Sørensen, N. N. (2010). Turbulence modelling. Paper presented

More information

Fluctuation dynamo amplified by intermittent shear bursts

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

More information

LES of turbulent shear flow and pressure driven flow on shallow continental shelves.

LES of turbulent shear flow and pressure driven flow on shallow continental shelves. LES of turbulent shear flow and pressure driven flow on shallow continental shelves. Guillaume Martinat,CCPO - Old Dominion University Chester Grosch, CCPO - Old Dominion University Ying Xu, Michigan State

More information