You are on page 1of 4

Computational Fluid Dynamics I

Computational Fluid Dynamics I


http://users.wpi.edu/~gretar/me612.html

What did we learn?

ME612 Computational Coarse goals and brief outline

Fluid Dynamics More detailed list of topics

Summary Grading

Exam
Grétar Tryggvason
Questionnaire/input
Worcester Polytechnic Institute,
Spring 2009

Computational Fluid Dynamics I Computational Fluid Dynamics I


Course outline

Coarse Goals: Part I


Learn how to solve the Navier-Stokes and Euler A Two Week introduction to CFD, including an
equations for engineering problems. introduction to a commercial package (FLUENT)
Hear about various concepts to allow continuing studies Part II
of the literature. Standard Numerical Analysis of partial differential
equations, cumulating in solution techniques for
Ways: the Navier-Stokes equations
Detailed coverage of selected topics, such as: simple
finite difference methods, accuracy, stability, etc. Part III
Advanced topics in CFD
Rapid coverage of other topics, such as: multigrid,
monotone advection, unstructured grids.

Computational Fluid Dynamics I Computational Fluid Dynamics I


Course outline—Part I Course outline—Part II

Introduction, what is CFD, examples, computers, First order Partial Differential Equations (PDF's).
elementary numerical analysis, course administration Characteristics. Classification of Second Order PDF's.

Elementary numerical analysis, integration of ordinary Algorithms for Hyperbolic equations. The Euler
differential equations equations.

Elementary numerical analysis, accuracy, stability, Algorithms for Parabolic equations.


partial differential equations
Algorithms for Elliptic equations.
Review of fluid mechanics: the governing equations
Finite Difference solution of the Navier-Stokes Equations
Commercial solvers in vorticity/streamfunction form

Finite Volume Approach, Solving the Navier-Stokes


Equations in Primitive Variables, the MAC Method
Computational Fluid Dynamics I Computational Fluid Dynamics I
Course outline—Part III

Project 1
Complex Domains. Body fitted Coordinates. Warm-up. Solving a one-dimensional unsteady advection-
diffusion problem
Complex Domains. Grid Generation
Project 2
Introduction to Turbulence, Multiphase flow, and Flow in an L-shaped channel using FLUENT
Combustion
Project 3
Parallel Computations, Visualization One dimensional shock capturing using Lax-Wendroff
method
Direct Numerical Simulations of Multiphase Flows
Project 4
Modify a code for the Navier-Stokes equations in the
primitive variables (pressure and velocity)

Computational Fluid Dynamics I Computational Fluid Dynamics I

Partial Differential Equations:


The Navier Stokes Equations: Characteristics and the basic theory of first order
The basic equations of fluid mechanics in integral and partial differential equations. Second order partial
differential form. The difference between a conservative differential equations and how to convert them to a
and non-conservative form. Different formulations of the system of first order equations. Hyperbolic, parabolic
basic equations: Primitive (velocity-pressure) form; stream and elliptic second order equations and their physical
function-vorticity, and velocity-vorticity form in two- and significance. What is an ill-posed problem.
three-dimensions. The representation of advection, Conservation laws and the conservative form.
viscous friction, and incompressibility, in the equations of Classical model equations and their solutions.
motion. The pressure equation for the primitive Diffusion, linear and nonlinear advection, and the
formulation. Physical boundary conditions. Laplace equation. The advection-diffusion equation
and its relation to the Navier-Stokes equations.

Computational Fluid Dynamics I Computational Fluid Dynamics I

Numerical Solutions of PDE's:


Elementary Numerical Concepts: Accuracy by Taylor series expansion. Consistency and the
Discrete approximations; finite differences; finite volume; Modified Equation. Stability by the von Neumann's
spectral and finite elements. method. Basic finite difference schemes for hyperbolic,
Numerical differentiation and integration. Time parabolic and elliptic equations.
integration: Euler, Runga-Kutta and predictor-corrector.
Implicit time integration. Parabolic equations: The forward in time, centered in
space method. Implicit versus explicit methods. Backward
Euler's method, ADI and splitting. Stability limits. The
Crank-Nicholson method, predictor-corrector schemes.

Elliptic equations: Iterative solutions of elliptic equations.


Jacobi, Gauss-Seidel, and SOR iterations. Fundamentals
of multigrid methods.
Computational Fluid Dynamics I Computational Fluid Dynamics I

Numerical Solutions of the Navier-Stokes equations:


Hyperbolic equations: The method of characteristics.
Finite difference methods: upwind, leap-frog and Lax- Vorticity-streamfunction form. Order in which the equations
Wendroff's method. The Courant conditions. Advection of must be solved. Boundary conditions for the vorticity.
sharp shocks: Numerical diffusion and oscillations.
Godunov's theorem, Monotonic advection, artificial Primitive variables. The MAC method and staggered grids.
viscosity, high order Godunov methods, and FCT. Linear Solution strategies and projection methods. Derivation of a
versus nonlinear advection. discretized pressure equation and treatment of boundaries.
Boundary conditions for the velocities.
The advection-diffusion equation. Cell Reynolds numbers Higher order methods: Adams-Bashford/Crank-Nicolson,
and the stabilization of advection methods by diffusion predictor-corrector.
terms.

Computational Fluid Dynamics I Computational Fluid Dynamics I

Complex domains: Complex flows:


Boundary fitted grids. Derivatives and partial differential Additional considerations for stratified and turbulent flows.
equations in the mapped coordinates. One dimensional The k-ε model for turbulent flows.
stretching and algebraic grid generation. Elliptic grid
generation and elementary control strategies. The Computations of multiphase flows. Lagrangian and
vorticity-streamfunction equation in mapped coordinates Eularian modeling of disperse flow
and its solution. Alternative strategies: Mapping versus
unstructured grids. Rectangular and triangular cells. Combustion modeling: Diffusion flames versus Premixed
Block-structured grids. flames

Computational Fluid Dynamics I Computational Fluid Dynamics I

Parallel computing Grading


Serial versus parallel, Shared versus distributed
memory, Domain decomposition, Message Passing Projects 50%
Interface (MPI) Homework 25%
Quizzes 25%
Commercial codes
Major players (Fluent, StarCD). Solution process: pre- Project and HW due May 4.
prosessing and post-processing
Computational Fluid Dynamics I Computational Fluid Dynamics I

Quiz 2: Homework
Three questions
Elementary Concepts (problems 1, 4, 5)
1. Multiple choice Basic Numerical Analysis (problems 2, 3, 6, 7, 9)
Partial Differential Equations (problems 8, 10-14)
(covering everything)
Mapped Grids (problems 15, 16)
2. Complex domains Solution Approach (problems 17-20)
3. Solution to a
professional problem
Open book and notes

Computational Fluid Dynamics I

What if I donʼt have MATLAB?


Try OCTAVE (free)
http://www.octave.org/

You might also like