Zonal modelling approach in aerodynamic simulation

Size: px
Start display at page:

Download "Zonal modelling approach in aerodynamic simulation"

Transcription

1 Zonal modelling approach in aerodynamic simulation and Carlos Castro Barcelona Supercomputing Center Technical University of Madrid

2 Outline 1 2 State of the art Proposed strategy 3 Consistency Stability 4 Laminar RAE Turbulent RAE 5

3 Motivation In aerodynamic simulations, ignoring the viscous effects far from sharp layers leads to the coupling of NS and Euler equations. Why? The velocity of a fluid flow around a streamlined body is of the same order of magnitude as the free-stream velocity. The inertial forces are dominant over the viscous stresses. But: only in a region outside the body surface, where boundary layers do not appear. Recall: the physical problem is the full NS or RANS equations.

4 Motivation Critical points The position of the interface: depends on the flow condition and the solution convergence. It affects to the accuracy. The passing algorithm: it can introduce errors or extra computational cost. Trade of between accuracy and time saving.

5 Zonal Solver: Split the domain into several independent partitions where distinct flow models can be solved. Advantages Simulation of multiphysic phenomena Simplification of the numerical problem Computational saving ( ) Challenges Will a new interface affect the accuracy? May it affect efficiency somehow? May it affect stability?

6 Zonal Solver: Split the domain into several independent partitions where distinct flow models can be solved. Advantages Simulation of multiphysic phenomena Simplification of the numerical problem Computational saving ( ) Challenges Will a new interface affect the accuracy? May it affect efficiency somehow? May it affect stability?

7 Zonal Solver: Split the domain into several independent partitions where distinct flow models can be solved. Advantages Simulation of multiphysic phenomena Simplification of the numerical problem Computational saving ( ) Challenges Will a new interface affect the accuracy? May it affect efficiency somehow? May it affect stability?

8 Zonal Solver: Split the domain into several independent partitions where distinct flow models can be solved. Advantages Simulation of multiphysic phenomena Simplification of the numerical problem Computational saving ( ) Challenges Will a new interface affect the accuracy? May it affect efficiency somehow? May it affect stability?

9 Zonal Solver: Split the domain into several independent partitions where distinct flow models can be solved. Advantages Simulation of multiphysic phenomena Simplification of the numerical problem Computational saving ( ) Challenges Will a new interface affect the accuracy? May it affect efficiency somehow? May it affect stability?

10 The equations The Euler equations U t + F (U) = 0 U(:, 0) = U 0 in Ω 1 + Boundary conditions on Ω Ω 1 The RANS equations U t + F (U) F v (U, U) = S(U, U) U(:, 0) = U 0 in Ω 2 + Boundary conditions on Ω Ω 2

11 The compressible Navier-Stokes equations U t + F (U) F v (U, U) = S(U, U). ρv i 0 F = ρv i v j + δ ij p F v = τ ij T ρv i H v j τ ij + k T x i where p is the pressure, H = E + p/ρ is the enthalpy and δ ij is the Kronecker delta. The pressure is related tot he state vector by the equation of state, p = (γ 1)ρ(E (u 2 + v 2 )/2) where γ is the ratio of specific heats (γ = 1,4).

12 The compressible Navier-Stokes equations If there is turbulence the NS equations turn into the RANS equations and it is necessary to introduce a turbulence model (one equation SA model): D ν Dt = c b1 S ν + 1 [ ((ν + ν) ν) + c b2 ( ν) 2] [ ν ] 2 c w1 f w σ d The turbulent dynamic viscosity µ t is computed as follows, µ t = ρν t, ν t = νf v1, f v1 = Ψ 3 Ψ 3 + c 3 v1, Ψ = ν ν

13 Heterogeneous DDM State of the art for Euler/NS coupling State of the art Proposed strategy 1 Variational strategy: strong approach [Quarteroni, Stolcis (1995)] Continuity of fluxes. Continuity of incoming characteristic variables. 2 Variational strategy: weak approach [Hesthaven (1996)] Enforce continuity using a penalty term. The penalty evaluation involves the values that are compatible with upwind and downwind locations. 3 χ-formulation [Brezzi, Canuto (1988) ] Introduce a continuous interface region (decay viscous fluxes). Three regions (Euler, NS and a transition region). Smooth transition. 4 Non-variatonal (NV) strategy.

14 Heterogeneous DDM The non-variational approach State of the art Proposed strategy { u = v if f (u) > 0 u = v, u x = v x if f (u) < 0 Suggested by Quarteroni [Gastaldi, Quarteroni (1989)] Mathematical analysis for linear case [Gander (2009)] NV conditions: not physical but continuous., Lack of mathematical analysis: the non-linearity prevents the analysis of existence and uniqueness. / Systems of equations require characteristic analysis. / Conditions depend on the flow direction.

15 Proposed approach State of the art Proposed strategy Key idea: Consider the same transmission conditions as used in parallel computation. We show that they are consistent with the set of NV conditions. What do we win? Avoid characteristic analysis. Imposed in a natural and intuitive way. Keep consistency and stability. It can be used with any parallel code. No iterations between subdomains. Efficient and robust algorithm. Continuity of variables.

16 1D illustration State of the art Proposed strategy Model equation: Burgers equation u t + f (u) = 0 v t + f (v) νv xx = 0 { u = v on x = δ, t > 0, u x = v x on x = δ, t > 0 if f (u(δ, t)) < 0. The boundary u x (δ, t) is not properly defined for a first order equation. Formally: { u = v on x = δ, t > 0, v t + f (v)v x = 0 on x = δ, t > 0 if f (u(δ, t)) < 0.

17 1D illustration State of the art Proposed strategy Model equation: Burgers equation u t + f (u) = 0 v t + f (v) νv xx = 0 Compute interior nodal values: {u n 1,..., un I }, {v n 1,..., v n J }. Continuity enforced using ghost values in the passing step of parallelization: u n I +1 = v n 1, v n 0 = un I. Reconstruct fluxes and derivatives in viscous region. Use conservative scheme in the inviscid region (upwind, LF,...).

18 1D illustration State of the art Proposed strategy This numerical implementation does not distinguish between incoming and outcoming characteristics in the inviscid part BUT it is proven that the algorithm makes this distinction naturally. This simplifies the implementation when considering systems.

19 Consistency Consistency Stability Theorem Let {u1 n,..., un I } and {v 1 n,..., v J n } be the solution of the discrete mixed model u n+1 i = ui n λ(ˆf n i+ 2 1 ˆf n i 1 ), i=1,...,i, n = 1,..., N 2 u0 n = b.c. at x = L 1 = vi n λ(ˆf n i+ 2 1 vj+1 n = b.c. at x = L 2 v n+1 i ˆf n i 1 2 ) + ν (v n x j 1 2vj n + vj+1), n j=1,...,j, n = 1,..., N with the transmission conditions. Assume that the solution of the continuous mixed problem satisfies either f (u(δ, t)) > 0 or f (u(δ, t)) < 0 for all t [0, T ]. Then, any consistent numerical flux to both sides of the interface provides a first order consistent system with the mixed problem and the NV interface conditions.

20 Stability (linear model: f (u) = au) Theorem GSKO stability Consistency Stability Let {u1 n,..., un I } and {v 1 n,..., v J n } be the solution of the discrete mixed model u n+1 i = ui n λ(ˆf n i+ 2 1 ˆf n i 1 ), i=1,...,i, n = 1,..., N 2 u0 n = b.c. at x = L 1 = vi n λ(ˆf n i+ 2 1 vj+1 n = b.c. at x = L 2 v n+1 i ˆf n i 1 2 ) + ν (v n x j 1 2vj n + vj+1), n j=1,...,j, n = 1,..., N with the transmission conditions and the upwind numerical flux. The numerical scheme is stable under the conditions a t x 1 in Ω 1 and λ = t x x x a + 2λ in Ω 2 Reference: [Gustaffson, Kreiss, Sundstrom and Osher]

21 Stability Consistency Stability Proof: In the linear case f (u) = au the discrete coupled problem can be solved sequentially Ω 1 Ω 2, if a > 0 Ω 2 Ω 1, if a < 0 Therefore, the stability in Ω 1 and Ω 2 can be analyzed separately. Moreover, transmission conditions can be interpreted as boundary conditions and the general GSKO theory for the stability of B.C. applies.

22 Stability Consistency Stability Example: Case a < 0 1 Solve in Ω 2. Scheme: v n+1 j = vj n λa(vj+1 n v j n) + ν x (v j 1 n 2v j n + vj+1 n ) B.C. at x = δ: u n I = v n 0 u n+1 I = u n I λa(u n I u n I +1 ) 2 Solve in Ω 1 : u n+1 i = u n i λa(u n i u n i+1 ) } v n+1 0 = v n 0 λa(v n 1 v n 0 )

23 Stability Consistency Stability In Ω 2 : Consider the scheme in x, t (0, ) 2 with BC for x = 0: v n+1 j = v n j λa(v n j+1 v n j ) + ν x (v j 1 n 2vj n + vj+1) n v n+1 0 = v n 0 λa(v n 1 v n 0 ) at x = 0 A sufficient condition for stability is then the lack of solutions (z, ṽ j ) for z 1 and z 1 Solution in the form ṽ j = ϕk j satisfy:

24 Stability Consistency Stability In Ω 2 : Taking the discrete Laplace transform of both equations (z 1)ṽ j = λa(ṽ j+1 ṽ j ) λ x (ṽ j 1 2ṽ j + ṽ j+1 ) (z 1)ṽ 0 = λa(ṽ 1 ṽ 0) with ṽ j = ṽ j (z) = 1 2π n=0 e zn u n j, z = iτ, τ [ π, π] A sufficient condition for stability is then the lack of solutions (z, ṽ j ) for z 1 and z 1 Solution in the form ṽ j = ϕk j satisfy:

25 Stability Consistency Stability In Ω 2 : Taking the discrete Laplace transform of both equations (z 1)ṽ j = λa(ṽ j+1 ṽ j ) λ x (ṽ j 1 2ṽ j + ṽ j+1 ) (z 1)ṽ 0 = λa(ṽ 1 ṽ 0) with ṽ j = ṽ j (z) = 1 2π n=0 e zn u n j, z = iτ, τ [ π, π] A sufficient condition for stability is then the lack of solutions (z, ṽ j ) for z 1 and z 1 Solution in the form ṽ j = ϕk j satisfy:

26 Stability Consistency Stability In Ω 2 : Taking the discrete Laplace transform of both equations (z 1)ṽ j = λa(ṽ j+1 ṽ j ) λ x (ṽ j 1 2ṽ j + ṽ j+1 ) (z 1)ṽ 0 = λa(ṽ 1 ṽ 0) with ṽ j = ṽ j (z) = 1 2π n=0 e zn u n j, z = iτ, τ [ π, π] A sufficient condition for stability is then the lack of solutions (z, ṽ j ) for z 1 and z 1 Solution in the form ṽ j = ϕk j satisfy: { z 1 = λa(k 1) λ x (k k ) z 1 = λa(k 1)

27 Stability Consistency Stability In Ω 2 : Taking the discrete Laplace transform of both equations (z 1)ṽ j = λa(ṽ j+1 ṽ j ) λ x (ṽ j 1 2ṽ j + ṽ j+1 ) (z 1)ṽ 0 = λa(ṽ 1 ṽ 0) with ṽ j = ṽ j (z) = 1 2π n=0 e zn u n j, z = iτ, τ [ π, π] A sufficient condition for stability is then the lack of solutions (z, ṽ j ) for z 1 and z 1 Solution in the form ṽ j = ϕk j satisfy: k = 1 z = 1 Stable

28 Consistency Stability Stability only for the linear case but consistency can be applied to linear and non-linear. Time step is set from the viscous scheme since it is more restrictive. GSKO stability is a well-known method for boundary value problems. Here it can be used because the transmission problem is reduced to two boundary problems, which are solved sequencially in Ω 1 and Ω 2.

29 Parallellization Consistency Stability Repeat step = step +1 Compute local time steps Main parallel loop Compute interior values on Ω 1 Compute interior values on Ω 2 Exchange conservative variables using ghost values. Update physical values. CPU 1 CPU 2 Network

30 Parallellization Consistency Stability Repeat step = step +1 Compute local time steps Main parallel loop Compute interior values on Ω 1 Compute interior values on Ω 2 Exchange conservative variables using ghost values. Update physical values. CPU 1 CPU 2 Network

31 Parallellization Consistency Stability Repeat step = step +1 Compute local time steps Main parallel loop Compute interior values on Ω 1 Compute interior values on Ω 2 Exchange conservative variables using ghost values. Update physical values. transmission CPU 1 CPU 2 Network

32 Parallellization Consistency Stability Repeat step = step +1 Compute local time steps Main parallel loop Compute interior values on Ω 1 Compute interior values on Ω 2 Exchange conservative variables using ghost values. Update physical values. transmission CPU 1 CPU 2 Network Overlapping region depends on the order of the FV scheme!

33 Laminar RAE2822 Problem setting Laminar RAE Turbulent RAE Laminar flow over a RAE2822 airfoil. M = 0,2, Re = , AoA = 0,5 deg No-slip wall at the airfoil and farfield Euler BC s at the outer boundary. Hybrid mesh of nodes.

34 Laminar RAE2822 Accuracy analysis Laminar RAE Turbulent RAE To study the efficiency and robustness of the method different partitions are considered: the interface is located at different distance of the airfoil. Partititions with 38 %, 24 % and 14 % of nodes in the viscous (NS) subdomain.

35 Laminar RAE2822 Accuracy analysis Laminar RAE Turbulent RAE To study the efficiency and robustness of the method different partitions are considered: the interface is located at different distance of the airfoil. Partititions with 38 %, 24 % and 14 % of nodes in the viscous (NS) subdomain.

36 Laminar RAE2822 Accuracy analysis Laminar RAE Turbulent RAE Density Residual in terms of the number of iterations for the different partitions.

37 Laminar RAE2822 Accuracy analysis Laminar RAE Turbulent RAE Pressure coefficient shows robustness of the method: as the interface gets closer to the airfoil, Cp degenerates to Euler profile. Cp profile for full NS and full Euler computations. Cp profile for Zonal Solver with different partitions.

38 Laminar RAE2822 Accuracy and efficiency analysis Laminar RAE Turbulent RAE W dist : distance to wall (it mainly affects C L value). C L C D Time iter Full NS Full Euler W dist = W dist = W dist = W dist = W dist =

39 Turbulent RAE2822 Problem setting Laminar RAE Turbulent RAE Turbulent flow over a RAE2822 airfoil. M = 0,729, Re = 6,5 10 6, AoA = 2,31 deg No-slip wall at the airfoil and farfield Euler BC s at the outer boundary. Hybrid mesh of nodes. Partition for the zonal solver for solving the turbulent RAE2822: showing the wake and detail of the distance to the airfoil.

40 Turbulent RAE2822 Accuracy and efficiency analysis Laminar RAE Turbulent RAE C L C D Time iter % NS nodes Full viscous DDM % Full viscous DDM full viscous DDM Res(!) 2 Cp iter x/c Residual of the density. Pressure coefficient on the airfoil.

41 Conclusions Simple and intuitive algorithm. Adaptable and easy implementation using parallellization. Guarantees continuity of the solution. Mathematically consistent and stable. Strategy to provide optimal subdomain partitions. Robust: continuous transition from Euler to NS profiles. Minimizes error between the physical and numerical solution. Extensible to other higher-order schemes. Lack of mathematical proof of uniqueness and existency.

42 Thank your attention!

43

44 1D illustration Notation: Mesh in [L 1, L 2 ] [0, T ]: (x j, t n ) = (L 1 + j x, n t) (j = 0,..., L 2 L 1 ; n = 0,..., N + 1 s.t (N + 1) t = T ) x wj n: numerical approximation of w(x j, t n ) of the physical viscous problem. Numerical scheme for viscous equation with a 3-points first order FV in convective part: w n+1 i = w n i with λ = t x λ(ˆf n ˆf n ) + ν i+ 1 i x (w j 1 n 2wj n + wj+1) n and ˆf n i+ 1 2 = ˆf (wi n, wi+1 n ) is the numerical flux.

45 1D illustration Theorem Let {u1 n,..., un I } and {v 1 n,..., v J n } be the solution of the discrete mixed model u n+1 i = ui n λ(ˆf n i+ 2 1 ˆf n i 1 ), i=1,...,i, n = 1,..., N 2 u0 n = b.c. at x = L 1 = vi n λ(ˆf n i+ 2 1 vj+1 n = b.c. at x = L 2 v n+1 i ˆf n i 1 2 ) + ν (v n x j 1 2vj n + vj+1), n j=1,...,j, n = 1,..., N with the transmission conditions. Assume that the solution of the continuous mixed problem satisfies either f (u(δ, t)) > 0 or f (u(δ, t)) < 0 for all t [0, T ]. Then, for any numerical flux of the type E-flux, the solution is first order consistent with the mixed problem and the NV interface conditions.

46 1D illustration: Theorem proof Linear case f (u) = au and upwind flux: ˆf up (u, v) = Case 1: a > 0. Note that u n I is given by u n+1 I = u n I λa(u n I u n I 1 ), n > 0 { f (u), if f > 0 f (v), if f < 0 It does not use the information from the ghost value u n I +1. ui n does not depend on the viscous solution vi n : interface condition v0 n = un I can be interpreted as a classical Dirichlet BC for Ω 2, which is first order accurate with the continuity condition, i.e. u(δ, t) = v(δ, t), t > 0.

47 1D illustration: Theorem proof Case 2: a < 0. Consider a smooth solution (u, v) of the mixed problem with the proposed transmission conditions. Assume that (u, v) can be extended in a smooth way to the overlapping region [x I, x I +1 ]. (recall that x = δ [x I, x I +1 ]). Replacing u(x i, t n ) by ui n and v(x i, t n ) by vi n : u(x I, t n ) = v(x I, t n ), u(x I, t n+1 ) = v(x I, t n+1 ), u(x I, t n+1 ) = u(x I, t n ) λ(ˆf (u(x I + 1, t n )) ˆf (u(x 2 I 1, t n ))) 2 These equations can be combined to obtain the relation v(x I, t n+1 ) = v(x I, t n ) λa(v(x I +1, t n ) v(x I, t n )).

48 1D illustration: Theorem proof Case 2: a < 0. Consider a smooth solution (u, v) of the mixed problem with the proposed transmission conditions. Assume that (u, v) can be extended in a smooth way to the overlapping region [x I, x I +1 ]. (recall that x = δ [x I, x I +1 ]). Replacing u(x i, t n ) by ui n and v(x i, t n ) by vi n : u(x I, t n ) = v(x I, t n ), u(x I, t n+1 ) = v(x I, t n+1 ), u(x I, t n+1 ) = u(x I, t n ) λa(u(x I +1, t n ) u(x I, t n )) These equations can be combined to obtain the relation v(x I, t n+1 ) = v(x I, t n ) λa(v(x I +1, t n ) v(x I, t n )).

49 1D illustration: Theorem proof Case 2: a < 0. Using Taylor expansion for v at (δ, t): v(x I, t) = v(δ, t n) x 2 vx(δ, tn) + O( x 2 ), v(x I +1, t) = v(δ, t n) + x 2 vx(δ, tn) + O( x 2 ), v(δ, t x x n+1) vx(δ, tn+1) = v(δ, tn) 2 2 vx(δ, tn) λa xvx(δ, tn)+o( x 2 ). Using Taylor expansion of v and v x, with respect to the time variable, at (δ, t n ). This provides easily the consistency with the boundary condition v t (δ, t n ) av x (δ, t n ) = 0.

50 Multi-dimensional extension No characteristic analysis. Same number of variables. Computation of normal along each face. { u i = v i u i n = v i n But... what happens with the turbulent equation and variables?

51 Multi-dimensional extension Turbulent interface conditions Turbulence only makes sense in viscous region. Values related to turbulence are set equal to 0 in Euler subdomain: viscous and source terms are neglected. The interface is treated as far-field boundary. This requires the interface to be set far away from the sources of turbulence. Solve the turbulent equation in the viscous part and add the information to the source term.

52 Laminar RAE2822 Results Laminar flow over a RAE2822 airfoil. M = 0,2, Re = , AoA = 0,5 deg Hybrid mesh of nodes. Density and pressure profiles for the partition atw d ist = 10 1.

53 Turbulent RAE2822 Results Turbulent flow over a RAE2822 airfoil. M = 0,729, Re = , AoA = 2,31 deg Hybrid mesh of nodes. Density and eddy viscosity profiles for the partition atw d ist = 10 1.

54 Domain Decomposition Definition of the interface Subdomain partition computed from Truncation Error estimation of sensing variables + Smoothing algorithm. Define a sensor and compute the local truncation error map Smoothing algorithm: post-processing of the maps to create interfaces able to be parallellized. Output: list of nodes for each partition

55 Domain Decomposition Definition of the interface Subdomain partition computed from Truncation Error estimation of sensing variables + Smoothing algorithm. Define a sensor and compute the local truncation error map Smoothing algorithm: post-processing of the maps to create interfaces able to be parallellized. Output: list of nodes for each partition

56 Domain Decomposition Definition of the interface Subdomain partition computed from Truncation Error estimation of sensing variables + Smoothing algorithm. Define a sensor and compute the local truncation error map Smoothing algorithm: post-processing of the maps to create interfaces able to be parallellized. Output: list of nodes for each partition

AA214B: NUMERICAL METHODS FOR COMPRESSIBLE FLOWS

AA214B: NUMERICAL METHODS FOR COMPRESSIBLE FLOWS AA214B: NUMERICAL METHODS FOR COMPRESSIBLE FLOWS 1 / 29 AA214B: NUMERICAL METHODS FOR COMPRESSIBLE FLOWS Hierarchy of Mathematical Models 1 / 29 AA214B: NUMERICAL METHODS FOR COMPRESSIBLE FLOWS 2 / 29

More information

A Multi-Dimensional Limiter for Hybrid Grid

A Multi-Dimensional Limiter for Hybrid Grid APCOM & ISCM 11-14 th December, 2013, Singapore A Multi-Dimensional Limiter for Hybrid Grid * H. W. Zheng ¹ 1 State Key Laboratory of High Temperature Gas Dynamics, Institute of Mechanics, Chinese Academy

More information

Finite Volume Method

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

More information

Manhar Dhanak Florida Atlantic University Graduate Student: Zaqie Reza

Manhar Dhanak Florida Atlantic University Graduate Student: Zaqie Reza REPRESENTING PRESENCE OF SUBSURFACE CURRENT TURBINES IN OCEAN MODELS Manhar Dhanak Florida Atlantic University Graduate Student: Zaqie Reza 1 Momentum Equations 2 Effect of inclusion of Coriolis force

More information

There are no simple turbulent flows

There are no simple turbulent flows Turbulence 1 There are no simple turbulent flows Turbulent boundary layer: Instantaneous velocity field (snapshot) Ref: Prof. M. Gad-el-Hak, University of Notre Dame Prediction of turbulent flows standard

More information

Interaction of Incompressible Fluid and Moving Bodies

Interaction of Incompressible Fluid and Moving Bodies WDS'06 Proceedings of Contributed Papers, Part I, 53 58, 2006. ISBN 80-86732-84-3 MATFYZPRESS Interaction of Incompressible Fluid and Moving Bodies M. Růžička Charles University, Faculty of Mathematics

More information

Zonal hybrid RANS-LES modeling using a Low-Reynolds-Number k ω approach

Zonal hybrid RANS-LES modeling using a Low-Reynolds-Number k ω approach Zonal hybrid RANS-LES modeling using a Low-Reynolds-Number k ω approach S. Arvidson 1,2, L. Davidson 1, S.-H. Peng 1,3 1 Chalmers University of Technology 2 SAAB AB, Aeronautics 3 FOI, Swedish Defence

More information

Borel Summability in PDE initial value problems

Borel Summability in PDE initial value problems Borel Summability in PDE initial value problems Saleh Tanveer (Ohio State University) Collaborator Ovidiu Costin & Guo Luo Research supported in part by Institute for Math Sciences (IC), EPSRC & NSF. Main

More information

An Introduction to the Discontinuous Galerkin Method

An Introduction to the Discontinuous Galerkin Method An Introduction to the Discontinuous Galerkin Method Krzysztof J. Fidkowski Aerospace Computational Design Lab Massachusetts Institute of Technology March 16, 2005 Computational Prototyping Group Seminar

More information

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

Finite volume method on unstructured grids

Finite volume method on unstructured grids Finite volume method on unstructured grids Praveen. C praveen@math.tifrbng.res.in Tata Institute of Fundamental Research Center for Applicable Mathematics Bangalore 560065 http://math.tifrbng.res.in/~praveen

More information

AA214B: NUMERICAL METHODS FOR COMPRESSIBLE FLOWS

AA214B: NUMERICAL METHODS FOR COMPRESSIBLE FLOWS AA214B: NUMERICAL METHODS FOR COMPRESSIBLE FLOWS 1 / 43 AA214B: NUMERICAL METHODS FOR COMPRESSIBLE FLOWS Treatment of Boundary Conditions These slides are partially based on the recommended textbook: Culbert

More information

Basic Aspects of Discretization

Basic Aspects of Discretization Basic Aspects of Discretization Solution Methods Singularity Methods Panel method and VLM Simple, very powerful, can be used on PC Nonlinear flow effects were excluded Direct numerical Methods (Field Methods)

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

AA214B: NUMERICAL METHODS FOR COMPRESSIBLE FLOWS

AA214B: NUMERICAL METHODS FOR COMPRESSIBLE FLOWS AA214B: NUMERICAL METHODS FOR COMPRESSIBLE FLOWS 1 / 59 AA214B: NUMERICAL METHODS FOR COMPRESSIBLE FLOWS The Finite Volume Method These slides are partially based on the recommended textbook: Culbert B.

More information

Poisson Equation in 2D

Poisson Equation in 2D A Parallel Strategy Department of Mathematics and Statistics McMaster University March 31, 2010 Outline Introduction 1 Introduction Motivation Discretization Iterative Methods 2 Additive Schwarz Method

More information

Divergence Formulation of Source Term

Divergence Formulation of Source Term Preprint accepted for publication in Journal of Computational Physics, 2012 http://dx.doi.org/10.1016/j.jcp.2012.05.032 Divergence Formulation of Source Term Hiroaki Nishikawa National Institute of Aerospace,

More information

CHAPTER 7 SEVERAL FORMS OF THE EQUATIONS OF MOTION

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

More information

Chapter 9: Differential Analysis

Chapter 9: Differential Analysis 9-1 Introduction 9-2 Conservation of Mass 9-3 The Stream Function 9-4 Conservation of Linear Momentum 9-5 Navier Stokes Equation 9-6 Differential Analysis Problems Recall 9-1 Introduction (1) Chap 5: Control

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

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

Block-Structured Adaptive Mesh Refinement

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

More information

( ) A i,j. Appendices. A. Sensitivity of the Van Leer Fluxes The flux Jacobians of the inviscid flux vector in Eq.(3.2), and the Van Leer fluxes in

( ) A i,j. Appendices. A. Sensitivity of the Van Leer Fluxes The flux Jacobians of the inviscid flux vector in Eq.(3.2), and the Van Leer fluxes in Appendices A. Sensitivity of the Van Leer Fluxes The flux Jacobians of the inviscid flux vector in Eq.(3.2), and the Van Leer fluxes in Eq.(3.11), can be found in the literature [9,172,173] and are therefore

More information

Chapter 2. General concepts. 2.1 The Navier-Stokes equations

Chapter 2. General concepts. 2.1 The Navier-Stokes equations Chapter 2 General concepts 2.1 The Navier-Stokes equations The Navier-Stokes equations model the fluid mechanics. This set of differential equations describes the motion of a fluid. In the present work

More information

Introduction to numerical simulation of fluid flows

Introduction to numerical simulation of fluid flows Introduction to numerical simulation of fluid flows Mónica de Mier Torrecilla Technical University of Munich Winterschool April 2004, St. Petersburg (Russia) 1 Introduction The central task in natural

More information

Application of Chimera Grids in Rotational Flow

Application of Chimera Grids in Rotational Flow CES Seminar Write-up Application of Chimera Grids in Rotational Flow Marc Schwalbach 292414 marc.schwalbach@rwth-aachen.de Supervisors: Dr. Anil Nemili & Emre Özkaya, M.Sc. MATHCCES RWTH Aachen University

More information

V (r,t) = i ˆ u( x, y,z,t) + ˆ j v( x, y,z,t) + k ˆ w( x, y, z,t)

V (r,t) = i ˆ u( x, y,z,t) + ˆ j v( x, y,z,t) + k ˆ w( x, y, z,t) IV. DIFFERENTIAL RELATIONS FOR A FLUID PARTICLE This chapter presents the development and application of the basic differential equations of fluid motion. Simplifications in the general equations and common

More information

Reliability of LES in complex applications

Reliability of LES in complex applications Reliability of LES in complex applications Bernard J. Geurts Multiscale Modeling and Simulation (Twente) Anisotropic Turbulence (Eindhoven) DESIDER Symposium Corfu, June 7-8, 27 Sample of complex flow

More information

Turbulence Modeling. Cuong Nguyen November 05, The incompressible Navier-Stokes equations in conservation form are u i x i

Turbulence Modeling. Cuong Nguyen November 05, The incompressible Navier-Stokes equations in conservation form are u i x i Turbulence Modeling Cuong Nguyen November 05, 2005 1 Incompressible Case 1.1 Reynolds-averaged Navier-Stokes equations The incompressible Navier-Stokes equations in conservation form are u i x i = 0 (1)

More information

Numerical methods for the Navier- Stokes equations

Numerical methods for the Navier- Stokes equations Numerical methods for the Navier- Stokes equations Hans Petter Langtangen 1,2 1 Center for Biomedical Computing, Simula Research Laboratory 2 Department of Informatics, University of Oslo Dec 6, 2012 Note:

More information

A high-order discontinuous Galerkin solver for 3D aerodynamic turbulent flows

A high-order discontinuous Galerkin solver for 3D aerodynamic turbulent flows A high-order discontinuous Galerkin solver for 3D aerodynamic turbulent flows F. Bassi, A. Crivellini, D. A. Di Pietro, S. Rebay Dipartimento di Ingegneria Industriale, Università di Bergamo CERMICS-ENPC

More information

The Generalized Boundary Layer Equations

The Generalized Boundary Layer Equations The Generalized Boundary Layer Equations Gareth H. McKinley (MIT-HML) November 004 We have seen that in general high Reynolds number flow past a slender body such as an airfoil can be considered as an

More information

Construction of a New Domain Decomposition Method for the Stokes Equations

Construction of a New Domain Decomposition Method for the Stokes Equations Construction of a New Domain Decomposition Method for the Stokes Equations Frédéric Nataf 1 and Gerd Rapin 2 1 CMAP, CNRS; UMR7641, Ecole Polytechnique, 91128 Palaiseau Cedex, France 2 Math. Dep., NAM,

More information

Acceleration of a Domain Decomposition Method for Advection-Diffusion Problems

Acceleration of a Domain Decomposition Method for Advection-Diffusion Problems Acceleration of a Domain Decomposition Method for Advection-Diffusion Problems Gert Lube 1, Tobias Knopp 2, and Gerd Rapin 2 1 University of Göttingen, Institute of Numerical and Applied Mathematics (http://www.num.math.uni-goettingen.de/lube/)

More information

On the well-posedness of the Prandtl boundary layer equation

On the well-posedness of the Prandtl boundary layer equation On the well-posedness of the Prandtl boundary layer equation Vlad Vicol Department of Mathematics, The University of Chicago Incompressible Fluids, Turbulence and Mixing In honor of Peter Constantin s

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

RANS Solutions Using High Order Discontinuous Galerkin Methods

RANS Solutions Using High Order Discontinuous Galerkin Methods RANS Solutions Using High Order Discontinuous Galerkin Methods Ngoc Cuong Nguyen, Per-Olof Persson and Jaime Peraire Massachusetts Institute of Technology, Cambridge, MA 2139, U.S.A. We present a practical

More information

Chapter 6: Incompressible Inviscid Flow

Chapter 6: Incompressible Inviscid Flow Chapter 6: Incompressible Inviscid Flow 6-1 Introduction 6-2 Nondimensionalization of the NSE 6-3 Creeping Flow 6-4 Inviscid Regions of Flow 6-5 Irrotational Flow Approximation 6-6 Elementary Planar Irrotational

More information

Une méthode de pénalisation par face pour l approximation des équations de Navier-Stokes à nombre de Reynolds élevé

Une méthode de pénalisation par face pour l approximation des équations de Navier-Stokes à nombre de Reynolds élevé Une méthode de pénalisation par face pour l approximation des équations de Navier-Stokes à nombre de Reynolds élevé CMCS/IACS Ecole Polytechnique Federale de Lausanne Erik.Burman@epfl.ch Méthodes Numériques

More information

UNIVERSITY of LIMERICK

UNIVERSITY of LIMERICK UNIVERSITY of LIMERICK OLLSCOIL LUIMNIGH Faculty of Science and Engineering END OF SEMESTER ASSESSMENT PAPER MODULE CODE: MA4607 SEMESTER: Autumn 2012-13 MODULE TITLE: Introduction to Fluids DURATION OF

More information

Study of Forced and Free convection in Lid driven cavity problem

Study of Forced and Free convection in Lid driven cavity problem MIT Study of Forced and Free convection in Lid driven cavity problem 18.086 Project report Divya Panchanathan 5-11-2014 Aim To solve the Navier-stokes momentum equations for a lid driven cavity problem

More information

AMS 529: Finite Element Methods: Fundamentals, Applications, and New Trends

AMS 529: Finite Element Methods: Fundamentals, Applications, and New Trends AMS 529: Finite Element Methods: Fundamentals, Applications, and New Trends Lecture 25: Introduction to Discontinuous Galerkin Methods Xiangmin Jiao SUNY Stony Brook Xiangmin Jiao Finite Element Methods

More information

Aerodynamic force analysis in high Reynolds number flows by Lamb vector integration

Aerodynamic force analysis in high Reynolds number flows by Lamb vector integration Aerodynamic force analysis in high Reynolds number flows by Lamb vector integration Claudio Marongiu, Renato Tognaccini 2 CIRA, Italian Center for Aerospace Research, Capua (CE), Italy E-mail: c.marongiu@cira.it

More information

ρ Du i Dt = p x i together with the continuity equation = 0, x i

ρ Du i Dt = p x i together with the continuity equation = 0, x i 1 DIMENSIONAL ANALYSIS AND SCALING Observation 1: Consider the flow past a sphere: U a y x ρ, µ Figure 1: Flow past a sphere. Far away from the sphere of radius a, the fluid has a uniform velocity, u =

More information

LARGE EDDY SIMULATION AND FLOW CONTROL OVER A 25 RAMP MODEL

LARGE EDDY SIMULATION AND FLOW CONTROL OVER A 25 RAMP MODEL LARGE EDDY SIMULATION AND FLOW CONTROL OVER A 25 RAMP MODEL 09/11/2017 Paolo Casco Stephie Edwige Philippe Gilotte Iraj Mortazavi LES and flow control over a 25 ramp model : context 2 Context Validation

More information

First, Second, and Third Order Finite-Volume Schemes for Diffusion

First, Second, and Third Order Finite-Volume Schemes for Diffusion First, Second, and Third Order Finite-Volume Schemes for Diffusion Hiro Nishikawa 51st AIAA Aerospace Sciences Meeting, January 10, 2013 Supported by ARO (PM: Dr. Frederick Ferguson), NASA, Software Cradle.

More information

Simulation of Aeroelastic System with Aerodynamic Nonlinearity

Simulation of Aeroelastic System with Aerodynamic Nonlinearity Simulation of Aeroelastic System with Aerodynamic Nonlinearity Muhamad Khairil Hafizi Mohd Zorkipli School of Aerospace Engineering, Universiti Sains Malaysia, Penang, MALAYSIA Norizham Abdul Razak School

More information

Space-time XFEM for two-phase mass transport

Space-time XFEM for two-phase mass transport Space-time XFEM for two-phase mass transport Space-time XFEM for two-phase mass transport Christoph Lehrenfeld joint work with Arnold Reusken EFEF, Prague, June 5-6th 2015 Christoph Lehrenfeld EFEF, Prague,

More information

CHAPTER 7 NUMERICAL MODELLING OF A SPIRAL HEAT EXCHANGER USING CFD TECHNIQUE

CHAPTER 7 NUMERICAL MODELLING OF A SPIRAL HEAT EXCHANGER USING CFD TECHNIQUE CHAPTER 7 NUMERICAL MODELLING OF A SPIRAL HEAT EXCHANGER USING CFD TECHNIQUE In this chapter, the governing equations for the proposed numerical model with discretisation methods are presented. Spiral

More information

Termination criteria for inexact fixed point methods

Termination criteria for inexact fixed point methods Termination criteria for inexact fixed point methods Philipp Birken 1 October 1, 2013 1 Institute of Mathematics, University of Kassel, Heinrich-Plett-Str. 40, D-34132 Kassel, Germany Department of Mathematics/Computer

More information

Spatial discretization scheme for incompressible viscous flows

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

More information

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

Least-Squares Spectral Collocation with the Overlapping Schwarz Method for the Incompressible Navier Stokes Equations

Least-Squares Spectral Collocation with the Overlapping Schwarz Method for the Incompressible Navier Stokes Equations Least-Squares Spectral Collocation with the Overlapping Schwarz Method for the Incompressible Navier Stokes Equations by Wilhelm Heinrichs Universität Duisburg Essen, Ingenieurmathematik Universitätsstr.

More information

Postprint.

Postprint. http://www.diva-portal.org Postprint This is the accepted version of a chapter published in Domain Decomposition Methods in Science and Engineering XXI. Citation for the original published chapter: Gander,

More information

Pressure-velocity correction method Finite Volume solution of Navier-Stokes equations Exercise: Finish solving the Navier Stokes equations

Pressure-velocity correction method Finite Volume solution of Navier-Stokes equations Exercise: Finish solving the Navier Stokes equations Today's Lecture 2D grid colocated arrangement staggered arrangement Exercise: Make a Fortran program which solves a system of linear equations using an iterative method SIMPLE algorithm Pressure-velocity

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

UNIT IV BOUNDARY LAYER AND FLOW THROUGH PIPES Definition of boundary layer Thickness and classification Displacement and momentum thickness Development of laminar and turbulent flows in circular pipes

More information

Algebraic flux correction and its application to convection-dominated flow. Matthias Möller

Algebraic flux correction and its application to convection-dominated flow. Matthias Möller Algebraic flux correction and its application to convection-dominated flow Matthias Möller matthias.moeller@math.uni-dortmund.de Institute of Applied Mathematics (LS III) University of Dortmund, Germany

More information

Numerical Solutions to Partial Differential Equations

Numerical Solutions to Partial Differential Equations Numerical Solutions to Partial Differential Equations Zhiping Li LMAM and School of Mathematical Sciences Peking University Numerical Methods for Partial Differential Equations Finite Difference Methods

More information

Schur Complement Technique for Advection-Diffusion Equation using Matching Structured Finite Volumes

Schur Complement Technique for Advection-Diffusion Equation using Matching Structured Finite Volumes Advances in Dynamical Systems and Applications ISSN 973-5321, Volume 8, Number 1, pp. 51 62 (213) http://campus.mst.edu/adsa Schur Complement Technique for Advection-Diffusion Equation using Matching Structured

More information

UNIVERSITY OF OSLO. Faculty of Mathematics and Natural Sciences. MEK4300/9300 Viscous flow og turbulence

UNIVERSITY OF OSLO. Faculty of Mathematics and Natural Sciences. MEK4300/9300 Viscous flow og turbulence UNIVERSITY OF OSLO Faculty of Mathematics and Natural Sciences Examination in: Day of examination: Friday 15. June 212 Examination hours: 9. 13. This problem set consists of 5 pages. Appendices: Permitted

More information

Shock Capturing for Discontinuous Galerkin Methods using Finite Volume Sub-cells

Shock Capturing for Discontinuous Galerkin Methods using Finite Volume Sub-cells Abstract We present a shock capturing procedure for high order Discontinuous Galerkin methods, by which shock regions are refined in sub-cells and treated by finite volume techniques Hence, our approach

More information

Improvement of convergence to steady state solutions of Euler equations with. the WENO schemes. Abstract

Improvement of convergence to steady state solutions of Euler equations with. the WENO schemes. Abstract Improvement of convergence to steady state solutions of Euler equations with the WENO schemes Shuhai Zhang, Shufen Jiang and Chi-Wang Shu 3 Abstract The convergence to steady state solutions of the Euler

More information

PDE Solvers for Fluid Flow

PDE Solvers for Fluid Flow PDE Solvers for Fluid Flow issues and algorithms for the Streaming Supercomputer Eran Guendelman February 5, 2002 Topics Equations for incompressible fluid flow 3 model PDEs: Hyperbolic, Elliptic, Parabolic

More information

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

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

More information

Implementing a Partitioned Algorithm for Fluid-Structure Interaction of Flexible Flapping Wings within Overture

Implementing a Partitioned Algorithm for Fluid-Structure Interaction of Flexible Flapping Wings within Overture 10 th Symposimum on Overset Composite Grids and Solution Technology, NASA Ames Research Center Moffett Field, California, USA 1 Implementing a Partitioned Algorithm for Fluid-Structure Interaction of Flexible

More information

IMPLEMENTATION OF PRESSURE BASED SOLVER FOR SU2. 3rd SU2 Developers Meet Akshay.K.R, Huseyin Ozdemir, Edwin van der Weide

IMPLEMENTATION OF PRESSURE BASED SOLVER FOR SU2. 3rd SU2 Developers Meet Akshay.K.R, Huseyin Ozdemir, Edwin van der Weide IMPLEMENTATION OF PRESSURE BASED SOLVER FOR SU2 3rd SU2 Developers Meet Akshay.K.R, Huseyin Ozdemir, Edwin van der Weide Content ECN part of TNO SU2 applications at ECN Incompressible flow solver Pressure-based

More information

Numerical Solution of Partial Differential Equations governing compressible flows

Numerical Solution of Partial Differential Equations governing compressible flows Numerical Solution of Partial Differential Equations governing compressible flows Praveen. C praveen@math.tifrbng.res.in Tata Institute of Fundamental Research Center for Applicable Mathematics Bangalore

More information

Modelling of turbulent flows: RANS and LES

Modelling of turbulent flows: RANS and LES Modelling of turbulent flows: RANS and LES Turbulenzmodelle in der Strömungsmechanik: RANS und LES Markus Uhlmann Institut für Hydromechanik Karlsruher Institut für Technologie www.ifh.kit.edu SS 2012

More information

Assessment of Implicit Implementation of the AUSM + Method and the SST Model for Viscous High Speed Flow

Assessment of Implicit Implementation of the AUSM + Method and the SST Model for Viscous High Speed Flow Assessment of Implicit Implementation of the AUSM + Method and the SST Model for Viscous High Speed Flow Simone Colonia, René Steijl and George N. Barakos CFD Laboratory - School of Engineering - University

More information

Direct Numerical Simulations of a Two-dimensional Viscous Flow in a Shocktube using a Kinetic Energy Preserving Scheme

Direct Numerical Simulations of a Two-dimensional Viscous Flow in a Shocktube using a Kinetic Energy Preserving Scheme 19th AIAA Computational Fluid Dynamics - 5 June 009, San Antonio, Texas AIAA 009-3797 19th AIAA Computational Fluid Dynamics Conference, - 5 June 009, San Antonio, Texas Direct Numerical Simulations of

More information

Multigrid Methods and their application in CFD

Multigrid Methods and their application in CFD Multigrid Methods and their application in CFD Michael Wurst TU München 16.06.2009 1 Multigrid Methods Definition Multigrid (MG) methods in numerical analysis are a group of algorithms for solving differential

More information

n i,j+1/2 q i,j * qi+1,j * S i+1/2,j

n i,j+1/2 q i,j * qi+1,j * S i+1/2,j Helsinki University of Technology CFD-group/ The Laboratory of Applied Thermodynamics MEMO No CFD/TERMO-5-97 DATE: December 9,997 TITLE A comparison of complete vs. simplied viscous terms in boundary layer

More information

Application of High-Order Summation-by-Parts Operators to the Steady Reynolds-Averaged Navier-Stokes Equations. Xiaoyue Shen

Application of High-Order Summation-by-Parts Operators to the Steady Reynolds-Averaged Navier-Stokes Equations. Xiaoyue Shen Application of High-Order Summation-by-Parts Operators to the Steady Reynolds-Averaged Navier-Stokes Equations Xiaoyue Shen Supervisor: Prof. David W. Zingg A thesis submitted in conformity with the requirements

More information

A unifying model for fluid flow and elastic solid deformation: a novel approach for fluid-structure interaction and wave propagation

A unifying model for fluid flow and elastic solid deformation: a novel approach for fluid-structure interaction and wave propagation A unifying model for fluid flow and elastic solid deformation: a novel approach for fluid-structure interaction and wave propagation S. Bordère a and J.-P. Caltagirone b a. CNRS, Univ. Bordeaux, ICMCB,

More information

Efficient Augmented Lagrangian-type Preconditioning for the Oseen Problem using Grad-Div Stabilization

Efficient Augmented Lagrangian-type Preconditioning for the Oseen Problem using Grad-Div Stabilization Efficient Augmented Lagrangian-type Preconditioning for the Oseen Problem using Grad-Div Stabilization Timo Heister, Texas A&M University 2013-02-28 SIAM CSE 2 Setting Stationary, incompressible flow problems

More information

Scientific Computing I

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

More information

Chapter 9 Flow over Immersed Bodies

Chapter 9 Flow over Immersed Bodies 57:00 Mechanics of Fluids and Transport Processes Chapter 9 Professor Fred Stern Fall 009 1 Chapter 9 Flow over Immersed Bodies Fluid flows are broadly categorized: 1. Internal flows such as ducts/pipes,

More information

Implicit Solution of Viscous Aerodynamic Flows using the Discontinuous Galerkin Method

Implicit Solution of Viscous Aerodynamic Flows using the Discontinuous Galerkin Method Implicit Solution of Viscous Aerodynamic Flows using the Discontinuous Galerkin Method Per-Olof Persson and Jaime Peraire Massachusetts Institute of Technology 7th World Congress on Computational Mechanics

More information

Implementation of 3D Incompressible N-S Equations. Mikhail Sekachev

Implementation of 3D Incompressible N-S Equations. Mikhail Sekachev Implementation of 3D Incompressible N-S Equations Mikhail Sekachev Navier-Stokes Equations The motion of a viscous incompressible fluid is governed by the Navier-Stokes equations u + t u = ( u ) 0 Quick

More information

Entropy stable schemes for compressible flows on unstructured meshes

Entropy stable schemes for compressible flows on unstructured meshes Entropy stable schemes for compressible flows on unstructured meshes Tata Institute of Fundamental Research Center for Applicable Mathematics Bangalore deep@math.tifrbng.res.in http://math.tifrbng.res.in/

More information

Extension to moving grids

Extension to moving grids Extension to moving grids P. Lafon 1, F. Crouzet 2 & F. Daude 1 1 LaMSID - UMR EDF/CNRS 2832 2 EDF R&D, AMA April 3, 2008 1 Governing equations Physical coordinates Generalized coordinates Geometrical

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

Diffusion / Parabolic Equations. PHY 688: Numerical Methods for (Astro)Physics

Diffusion / Parabolic Equations. PHY 688: Numerical Methods for (Astro)Physics Diffusion / Parabolic Equations Summary of PDEs (so far...) Hyperbolic Think: advection Real, finite speed(s) at which information propagates carries changes in the solution Second-order explicit methods

More information

Fundamentals of Fluid Dynamics: Ideal Flow Theory & Basic Aerodynamics

Fundamentals of Fluid Dynamics: Ideal Flow Theory & Basic Aerodynamics Fundamentals of Fluid Dynamics: Ideal Flow Theory & Basic Aerodynamics Introductory Course on Multiphysics Modelling TOMASZ G. ZIELIŃSKI (after: D.J. ACHESON s Elementary Fluid Dynamics ) bluebox.ippt.pan.pl/

More information

NUMERICAL SIMULATION OF THE FLOW AROUND A SQUARE CYLINDER USING THE VORTEX METHOD

NUMERICAL SIMULATION OF THE FLOW AROUND A SQUARE CYLINDER USING THE VORTEX METHOD NUMERICAL SIMULATION OF THE FLOW AROUND A SQUARE CYLINDER USING THE VORTEX METHOD V. G. Guedes a, G. C. R. Bodstein b, and M. H. Hirata c a Centro de Pesquisas de Energia Elétrica Departamento de Tecnologias

More information

J. Liou Tulsa Research Center Amoco Production Company Tulsa, OK 74102, USA. Received 23 August 1990 Revised manuscript received 24 October 1990

J. Liou Tulsa Research Center Amoco Production Company Tulsa, OK 74102, USA. Received 23 August 1990 Revised manuscript received 24 October 1990 Computer Methods in Applied Mechanics and Engineering, 94 (1992) 339 351 1 A NEW STRATEGY FOR FINITE ELEMENT COMPUTATIONS INVOLVING MOVING BOUNDARIES AND INTERFACES THE DEFORMING-SPATIAL-DOMAIN/SPACE-TIME

More information

arxiv: v1 [math.na] 11 Jul 2018

arxiv: v1 [math.na] 11 Jul 2018 An Additive Overlapping Domain Decomposition Method for the Helmholtz Equation Wei Leng Lili Ju arxiv:1807.04180v1 [math.na] 11 Jul 2018 July 12, 2018 Abstract In this paper, we propose and analyze an

More information

4.2 Concepts of the Boundary Layer Theory

4.2 Concepts of the Boundary Layer Theory Advanced Heat by Amir Faghri, Yuwen Zhang, and John R. Howell 4.2 Concepts of the Boundary Layer Theory It is difficult to solve the complete viscous flow fluid around a body unless the geometry is very

More information

Lecture 14. Turbulent Combustion. We know what a turbulent flow is, when we see it! it is characterized by disorder, vorticity and mixing.

Lecture 14. Turbulent Combustion. We know what a turbulent flow is, when we see it! it is characterized by disorder, vorticity and mixing. Lecture 14 Turbulent Combustion 1 We know what a turbulent flow is, when we see it! it is characterized by disorder, vorticity and mixing. In a fluid flow, turbulence is characterized by fluctuations of

More information

AProofoftheStabilityoftheSpectral Difference Method For All Orders of Accuracy

AProofoftheStabilityoftheSpectral Difference Method For All Orders of Accuracy AProofoftheStabilityoftheSpectral Difference Method For All Orders of Accuracy Antony Jameson 1 1 Thomas V. Jones Professor of Engineering Department of Aeronautics and Astronautics Stanford University

More information

Tdyn Theory Manual - 2 -

Tdyn Theory Manual - 2 - - 2 - 1. INTRODUCTION... 4 2. NAVIER STOKES SOLVER (RANSOL MODULE)... 5 2.1 Governing equations... 5 2.2 CFD algorithms and stability... 5 2.2.1 Finite calculus (FIC)formulation... 6 2.2.2 Stabilized Navier-Stokes

More information

A Study on Numerical Solution to the Incompressible Navier-Stokes Equation

A Study on Numerical Solution to the Incompressible Navier-Stokes Equation A Study on Numerical Solution to the Incompressible Navier-Stokes Equation Zipeng Zhao May 2014 1 Introduction 1.1 Motivation One of the most important applications of finite differences lies in the field

More information

Masters in Mechanical Engineering Aerodynamics 1 st Semester 2015/16

Masters in Mechanical Engineering Aerodynamics 1 st Semester 2015/16 Masters in Mechanical Engineering Aerodynamics st Semester 05/6 Exam st season, 8 January 06 Name : Time : 8:30 Number: Duration : 3 hours st Part : No textbooks/notes allowed nd Part : Textbooks allowed

More information

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

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

More information

Inverse Lax-Wendroff Procedure for Numerical Boundary Conditions of. Conservation Laws 1. Abstract

Inverse Lax-Wendroff Procedure for Numerical Boundary Conditions of. Conservation Laws 1. Abstract Inverse Lax-Wendroff Procedure for Numerical Boundary Conditions of Conservation Laws Sirui Tan and Chi-Wang Shu 3 Abstract We develop a high order finite difference numerical boundary condition for solving

More information

Fourth Order Convergence of Compact Finite Difference Solver for 2D Incompressible Flow

Fourth Order Convergence of Compact Finite Difference Solver for 2D Incompressible Flow Fourth Order Convergence of Compact Finite Difference Solver for D Incompressible Flow Cheng Wang 1 Institute for Scientific Computing and Applied Mathematics and Department of Mathematics, Indiana University,

More information

A simple FEM solver and its data parallelism

A simple FEM solver and its data parallelism A simple FEM solver and its data parallelism Gundolf Haase Institute for Mathematics and Scientific Computing University of Graz, Austria Chile, Jan. 2015 Partial differential equation Considered Problem

More information

Regularization modeling of turbulent mixing; sweeping the scales

Regularization modeling of turbulent mixing; sweeping the scales Regularization modeling of turbulent mixing; sweeping the scales Bernard J. Geurts Multiscale Modeling and Simulation (Twente) Anisotropic Turbulence (Eindhoven) D 2 HFest, July 22-28, 2007 Turbulence

More information

A Hybrid Method for the Wave Equation. beilina

A Hybrid Method for the Wave Equation.   beilina A Hybrid Method for the Wave Equation http://www.math.unibas.ch/ beilina 1 The mathematical model The model problem is the wave equation 2 u t 2 = (a 2 u) + f, x Ω R 3, t > 0, (1) u(x, 0) = 0, x Ω, (2)

More information