1 PART1: Bratu problem

Size: px
Start display at page:

Download "1 PART1: Bratu problem"

Transcription

1 D9: Advanced Numerical Analysis: 3 Computer Assignment 3: Recursive Projection Method(RPM) Joakim Möller PART: Bratu problem. Background The Bratu problem in D is given by xx u + yy u + λe u =, u Γ = () By use of finite differences the discrete solution can be obtained from the fixed point iteration Au n+ i j = f (u n i j), A = [D +x D x + D +y D y ], f (u n i j) = λe un i j, () where D + and D are the forward and backward operators in the x- and y-directions. By using that A is a penta-diagonal symmetric positive definite, the solution u n+ i j can easily be obtain via the Cholesky factorization, A = C T C. This only N p +3p flops and N square roots, see []. To simplify the notations we write the fixed-point iteration as u n+ = F(u n ) (3) The ultimate convergence rate depends on the spectral radius of the Jacobian J(u ) F(u ), u (4) ρ(j) max µ j j where µ j, j =,...,N are the eigenvalues of J, and u is the final solution, u = F(u ) The spectral radius is closely related to the value of the parameter λ, see below

2 u(λ) λ (a) ρ(λ) λ (b) Figure : The spectral radius and solution norm (Euclidean) as a function of the parameter λ. The graphs was obtain by using Pseudo-arclength RPM-continuation, see [6].

3 We see from the solution branch that for each λ-value, there is both a stable and unstable solution. The fixed point iteration can only compute the solutions on the lower part of the branch. Furthermore the convergence rate will approach zero as λ approach 6.88, the turning point where ρ(j) becomes one. In order to increase the convergence rate as λ approaches the critical value and even compute unstable solutions we will use the Recursive Projection Method (RPM), [4], [5], [6]. q n+ = ( I V p Vp T ) F(p n + q n ) p n+ = p n ( ) V p I V T V T p JV p p (F(u n ) p n ) (5) u n+ = q n + p n where p n and q n is the solution projected on the dominant eigenspace, spanned by V p, associated with the p largest eigenvalues, and its orthogonal complement. The lab consists of parts: Part, we will investigate a linear PDE to examine some theoretical properties of RPM. Part, we compute the solution of () for three different λ-values. For two λ-values the solution will be stable, whereas in the last case, ρ(j) > and special care has to be taken. The stable cases will be started with a random initial vector. whereas the last case the initial solution is taken from the upper-part of the branch. Run the Matlab-function u=initfield(x,y ), where X and Y are two matrices containing the grid-points of your mesh. This function will create the initial data for the internal points of the computational by interpolation of the data contained in the file init.mat... Linear test problem Implement the RPM-algorithm. The basis extraction is done via the QR-method. Use a Krylov space with vectors. Test RPM with the following linear problem. Use an equal meshing in x and y, where λ = 9.6. N x = N y = 3, xx u + yy u + λ( + u) = f (x,y), f (x,y) = sin(πx)y( y) (6) Plot the residuals of (3) and p n,q n and of (5) 3

4 Use Arnoldi to compute the largest eigenvalues. Reproduce the the eigenvalue plot below for the largest eigenvalues, mark which eigenvalues that RPM extracted. How do the eigenvalues relate to the convergence plot. largest eigenvalues for lambda= Figure : The largest eigenvalues of (3) associated with (6). Plot u(x, y), p(x, y), q(x, y), when the solution has converged.. Non-linear test problem Run the three test cases given in the table below: CASE λ u initial solution stable rand yes rand yes file no Table : Nonlinear test-cases In order to obtain convergence for the third case, the unstable eigenvalue must first be eliminated. Use Arnoldi to compute the unstable eigenvalue and eigenvector. Use this vector to form the first component of the basis V p, i.e. we will apply RPM directly from the first iteration, and not wait for the QR-method to identify the dominant eigenspace. Plot residuals, spectra of the largest eigenvalues and u(x, y), p(x, y), q(x, y) when the converge solution. 4

5 PART : Compressible Flow Past a Symmetric Airfoil.. Background The governing equations of fluid dynamics are known as the Navier-Stokes equations. t (W ) + x ( f f v) + y (g g v) + z (h h v) = (7) where t denotes the time. The state-vector W is given by W = and the convective fluxes are defined as ρ ρu ρv ρw ρe (8) f = ρu ρu + p ρuv ρuw u(ρe + p),g = ρv ρvu ρv + p ρvw v(ρe + p),h = ρw ρwu ρwv ρw + p w(ρe + p) (9) Here ρ is the density, u, v and w are the Cartesian velocity components, p is the pressure and E is the total energy. The viscous fluxes are defined as f v = τ xx τ xy τ xz (τu) x q x,g v = with the shear stress tensor τ given by τ yx τ yy τ yz (τu) y q y,h v = τ zx τ zy τ zz (τu) z q z () 5

6 ) τ xx = 3 ( µ u x v y w z τ yy = 3 ( µ u x + v y w z τ zz = 3 ( µ u x v y + w z ) τ xy = τ yx = µ( v x + u y τ xz = τ zx = µ( w x + u z τ yz = τ zy = µ( v z + w y ) ) ) ) () where µ is the viscosity (Stokes hypothesis). The viscous dissipation in the energy equation is calculated from (τu) x = τ xx u + τ xy v + τ xz w (τu) y = τ yx u + τ yy v + τ yz w (τu) z = τ zx u + τ zy v + τ zz w () and the heat flux due to conduction is calculated according to Fourier s law, q x = k T x q y = k T y q z = k T z (3) where T is the temperature and k the heat conductivity. Assuming a constant Prandtl number (for air Pr =.7), the heat conductivity can then be found by k = µc p /Pr The specific heats at constant volume and constant pressure are constant for a caloric perfect gas, and can be calculated from c v = R/(γ ) and c p = γc v respectively, with γ =.4, and R the gas constant, equal to 87 (J/kgK) for air. To close the system of equations the pressure p must be related to the state vector W. This relation depends on the model used to describe the thermodynamic properties of the gas. For a caloric perfect gas this relation states p = ρe(γ ) = ρc v T(γ ) = ρrt (4) 6

7 Free stream mach number: M =.65. Free stream mach number: M = Mach Number Mach Number where e is the internal energy. The internal and total energy are related by e = E ( u + v + w ) (5) The equations are discretized using the MacCormack scheme, second order accurate. Here we will restrict the simulation to a stationary inviscid D flow, that is the viscosity is set to zero. The test case is the the transonic- and supersonic flow over a symmetric airfoil. 7 x grid y x Figure 3: The Euler mesh. 7

8 . Setup The students will be given a compressible Euler code implemented in matlab. The task is to connect the Euler code as a black-box to the RPM code, which will be used to accelerate the convergence. In doing so some alteration of the code must be performed. rewrite the file NS.m as a function-file of the form w n+ = F(w,mode,nstep) (6) where w = w(ρ,ρu,ρw,ρe) T for the mass, momentum and energy fluxes. mode is a flag giving information how the function file should operate. If mode =, do initialization. That is the code should create an initial solution and set other parameters. In order not to reset all data in every time step, use matlabs save and load of the workspace. Be sure that w is not contained in your saved work space, since this variable is to be sent into the code. If mode = compute the solution. The parameter nstep indicates the number of time steps to be taken with in the code before returning the state vector to RPM. RPM works on a vector, whereas the code NS-code work with matrices, hence use the matlab function reshape to alter the structure of w each time it is sent in and out of the code function w=f(w,mode,nstep) if mode== initialize w save data reshape w as a vector elseif mode== load data reshape w as a matrix for i=:nstep end Maccormack scheme save data 8

9 end reshape w as a vector The state vector is usually very scew, ρe is usually several order of magnitudes larger than the other components of the state vector. In order to improve the performance of RPM we construct a function that scales the state vector. w=scale(w,flag), where if flag= the vector is scaled and if flag=, the vector is unscaled. Note that the vector should only be scaled within RPM whereas when sent to F it should be unscaled, hence the structure of the function used by RPM, should be of the form function w=func(w,state,nstep) w=scale(w,) w=f(w,state,nstep) w=scale(w,) Note that the scale function also must be added in the beginning and at the end of the RPM algorithm. The scaling is done as follows: ρ = ρ ρ ρu = ρv = ρu ρ p ρv ρ p (7) ρe = ρe γ+ (γ ) p where ρ and p are the initial density and pressure, and γ =.4 is the ratio between the specific heats for air..3 The lab Exercise Set the free stream mach-number to.65 and run the code. Set the amount of artificial viscosity in NS to EPS = [.5,.5]; EPS4 = [.8,.8] and a CFL number equal.8. A good nstep value is 5. Typical values for the Krylov acceptance ratio k a is 3 and the size of the Krylov matrix is. How does these affect the convergence rate and basis size? 9

10 Plot the convergence history. How large was the extracted basis? Plot also the convergence history, that is the projected residuals and the total residual Pr(u n ), Qr(u n ), r(u n ) and compare this with the convergence history for the original problem, that is if RPM is not switched on, see below Supersonic wing, M=.65 Original r(u) Pr(u) Qr(u) 4 residual iter Figure 4: The convergence history for case M =.65. Plot solutions, for example the density and its projections, Pρ and Qρ. Use eigs (or your own Arnoldi implementation ) to plot the largest eigenvalues. Within this plot, plot the eigenvalues of PJP, found by RPM. Also plot maybe the to or 3 first eigenvectors of J. Can you see any resemblance between these and the solution. To plot the eigenvectors of J, use that JVy = V Hy + Ry (8) where y is an eigenvector of H and hence the vector x = Vy is an approximative eigenvector of J. Note that the eigenvectors might be complex, so given to complex conjugates eigenvectors, the change them to [v, v] [R(v), I(v)]

11 Redo the simulations with some different values for k a and k s, does it effect the basis. Redo the simulation with M =.7. Use EPS = [.5,.5] and EPS4 = [.,.] and a CFL number equal.8. 3 PART 3 Assignments for experts: Arclength continuation with RPM Heat and mass transfer in porous spherical catalyst where a first-order reaction occurs is described by a non-linear boundary value problem, d y dξ + a ( ) dy µβ( y) ξ dξ = φ yexp, ξ (9) + β( y) subject to boundary conditions ξ =, dy dξ () = ξ =,y() = For technical purposes usually a plot in η φ is drawn, where η, the effectiveness factor, is defined as η = a + φ dy (ξ = ) dξ Assignment: Using RPM, compute the bifurcation diagram, with the parameter settings a =, µ = 6, β =.5. φ [,.6). In order to pass the turning point, i.e. when max(λ) =, RPM has to be modified. Use the Pseudo-arclength RPM, to handle this task, see [6]. In order for the continuation to work, it might be necessary to update the extracted basis before the computation of the solution at a new φ-value. Use e.g. Arnoldi with DGKS for this purposes, see [4] In Fig(5), the bifurcation diagram for the parameter setting is shown. We used a second order finite difference scheme explicit in the forcing term and implicit in the diffusion term. Using 3 grid points, the equation had different solutions. As the number of grid points increased, so did the number of solutions Fig(5), here we used 3 grid-points, one can at most see 8 solutions around φ =.. In [], one claims that the equation had 5 solutions for this parameter setting. Due to the lack of memory, one can not continue to refine the grid using second order

12 methods. Therefore, you should implement a suitable higher order method, to see if you can reproduce the results of []. If you solve this problem, you do not need to solve the other computer assignments. Good look

13 4.5 η(φ) (a) η φ-plot max λ(φ) (b) Max. eigenvalue of the Jacobian Figure 5: The bifurcation diagram of (9), non-resolved.

14 References [] Childs B., Scott M., Daniel W., Denman E., Nelson P., Codes for Boundary- Value Problems in Ordinary Differential Equations, Lecture Notes in Computer Science 76, Springer-Verlag, 97. Lecture Notes in Computer S [] Golub G., Van Loan C., Matrix Computations, The Johns Hopkins University Press, Baltimore, third edition, 996 [3] Hanke M., Lecture Notes: Advanced Numerical Methods, Royal Institute of Technology, NADA, February [4] Möller J., Lecture Notes: Eigenvalue problems, and Applications, Royal Institute of Technology, NADA, to appear [5] Möller J., Studies of Recursive projection Methods for Convergence acceleration of Steady State Calculations. TRITA-NA-9, Royal Institute of Technology, Stockholm, Sweden, June [6] Shroff G. M., Keller B., Stabilization of Unstable Procedures: The Recursive Projection Method, SIAM J. Numer. Anal. vol 3, No 4,pp. 99-, August 993 4

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

Governing Equations of Fluid Dynamics

Governing Equations of Fluid Dynamics Chapter 3 Governing Equations of Fluid Dynamics The starting point of any numerical simulation are the governing equations of the physics of the problem to be solved. In this chapter, we first present

More information

AE/ME 339. Computational Fluid Dynamics (CFD) K. M. Isaac. Momentum equation. Computational Fluid Dynamics (AE/ME 339) MAEEM Dept.

AE/ME 339. Computational Fluid Dynamics (CFD) K. M. Isaac. Momentum equation. Computational Fluid Dynamics (AE/ME 339) MAEEM Dept. AE/ME 339 Computational Fluid Dynamics (CFD) 9//005 Topic7_NS_ F0 1 Momentum equation 9//005 Topic7_NS_ F0 1 Consider the moving fluid element model shown in Figure.b Basis is Newton s nd Law which says

More information

ENGR Heat Transfer II

ENGR Heat Transfer II ENGR 7901 - Heat Transfer II Convective Heat Transfer 1 Introduction In this portion of the course we will examine convection heat transfer principles. We are now interested in how to predict the value

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

Getting started: CFD notation

Getting started: CFD notation PDE of p-th order Getting started: CFD notation f ( u,x, t, u x 1,..., u x n, u, 2 u x 1 x 2,..., p u p ) = 0 scalar unknowns u = u(x, t), x R n, t R, n = 1,2,3 vector unknowns v = v(x, t), v R m, m =

More information

2. Getting Ready for Computational Aerodynamics: Fluid Mechanics Foundations

2. Getting Ready for Computational Aerodynamics: Fluid Mechanics Foundations . Getting Ready for Computational Aerodynamics: Fluid Mechanics Foundations We need to review the governing equations of fluid mechanics before examining the methods of computational aerodynamics in detail.

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

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

Conservation of Mass. Computational Fluid Dynamics. The Equations Governing Fluid Motion

Conservation of Mass. Computational Fluid Dynamics. The Equations Governing Fluid Motion http://www.nd.edu/~gtryggva/cfd-course/ http://www.nd.edu/~gtryggva/cfd-course/ Computational Fluid Dynamics Lecture 4 January 30, 2017 The Equations Governing Fluid Motion Grétar Tryggvason Outline Derivation

More information

Module 2: Governing Equations and Hypersonic Relations

Module 2: Governing Equations and Hypersonic Relations Module 2: Governing Equations and Hypersonic Relations Lecture -2: Mass Conservation Equation 2.1 The Differential Equation for mass conservation: Let consider an infinitely small elemental control volume

More information

Chapter 5. The Differential Forms of the Fundamental Laws

Chapter 5. The Differential Forms of the Fundamental Laws Chapter 5 The Differential Forms of the Fundamental Laws 1 5.1 Introduction Two primary methods in deriving the differential forms of fundamental laws: Gauss s Theorem: Allows area integrals of the equations

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

RANS Equations in Curvilinear Coordinates

RANS Equations in Curvilinear Coordinates Appendix C RANS Equations in Curvilinear Coordinates To begin with, the Reynolds-averaged Navier-Stokes RANS equations are presented in the familiar vector and Cartesian tensor forms. Each term in the

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

AE/ME 339. K. M. Isaac Professor of Aerospace Engineering. 12/21/01 topic7_ns_equations 1

AE/ME 339. K. M. Isaac Professor of Aerospace Engineering. 12/21/01 topic7_ns_equations 1 AE/ME 339 Professor of Aerospace Engineering 12/21/01 topic7_ns_equations 1 Continuity equation Governing equation summary Non-conservation form D Dt. V 0.(2.29) Conservation form ( V ) 0...(2.33) t 12/21/01

More information

Improvements of Unsteady Simulations for Compressible Navier Stokes Based on a RK/Implicit Smoother Scheme

Improvements of Unsteady Simulations for Compressible Navier Stokes Based on a RK/Implicit Smoother Scheme Improvements of Unsteady Simulations for Compressible Navier Stokes Based on a RK/Implicit Smoother Scheme Oren Peles and Eli Turkel Department of Applied Mathematics, Tel-Aviv University In memoriam of

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

Aerothermodynamics of High Speed Flows

Aerothermodynamics of High Speed Flows Aerothermodynamics of High Speed Flows Lecture 1: Introduction G. Dimitriadis 1 The sound barrier Supersonic aerodynamics and aircraft design go hand in hand Aspects of supersonic flow theory were developed

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

Implementation of Implicit Solution Techniques for Non-equilibrium Hypersonic Flows

Implementation of Implicit Solution Techniques for Non-equilibrium Hypersonic Flows Short Training Program Report Implementation of Implicit Solution Techniques for Non-equilibrium Hypersonic Flows Julian Koellermeier RWTH Aachen University Supervisor: Advisor: Prof. Thierry Magin von

More information

Aalto University School of Science and Technology CFD-group/ Department of Applied Mechanics. MEMO No CFD/MECHA DATE: March 15, 2012

Aalto University School of Science and Technology CFD-group/ Department of Applied Mechanics. MEMO No CFD/MECHA DATE: March 15, 2012 Aalto University School of Science and Technology CFD-group/ Department of Applied Mechanics MEMO No CFD/MECHA-2-212 DATE: March 15, 212 TITLE The Effect of Free-Stream Turbulence Parameters on the SST

More information

High-Order Hyperbolic Navier-Stokes Reconstructed Discontinuous Galerkin Method

High-Order Hyperbolic Navier-Stokes Reconstructed Discontinuous Galerkin Method AIAA SciTech Forum 7- January 29 San Diego California AIAA Scitech 29 Forum.254/6.29-5 High-Order Hyperbolic Navier-Stokes Reconstructed Discontinuous Galerkin Method Lingquan Li Jialin Lou and Hong Luo

More information

Investigation of Co-Flow Jet Airfoil Mixing Mechanism Using Large Eddy Simulation

Investigation of Co-Flow Jet Airfoil Mixing Mechanism Using Large Eddy Simulation 4st AIAA Fluid Dynamics Conference and Exhibit 27-3 June 2, Honolulu, Hawaii AIAA 2-398 Investigation of Co-Flow Jet Airfoil Mixing Mechanism Using Large Eddy Simulation Hong-Sik IM, Ge-Cheng Zha, Bertrand

More information

Introduction to Fluid Mechanics

Introduction to Fluid Mechanics Introduction to Fluid Mechanics Tien-Tsan Shieh April 16, 2009 What is a Fluid? The key distinction between a fluid and a solid lies in the mode of resistance to change of shape. The fluid, unlike the

More information

Computation of NACA0012 Airfoil Transonic Buffet Phenomenon with Unsteady Navier-Stokes Equations

Computation of NACA0012 Airfoil Transonic Buffet Phenomenon with Unsteady Navier-Stokes Equations 5th AIAA Aerospace Sciences Meeting including the New Horizons Forum and Aerospace Exposition 9-2 January 22, Nashville, Tennessee AIAA 22-699 Computation of NACA2 Airfoil Transonic Buffet Phenomenon with

More information

International Engineering Research Journal

International Engineering Research Journal Special Edition PGCON-MECH-7 Development of high resolution methods for solving D Euler equation Ms.Dipti A. Bendale, Dr.Prof. Jayant H. Bhangale and Dr.Prof. Milind P. Ray ϯ Mechanical Department, SavitribaiPhule

More information

7th AIAA/USAF/NASA/ISSMO Symposium on Multidisciplinary Analysis and Optimization September 2 4, 1998/ St. Louis, MO

7th AIAA/USAF/NASA/ISSMO Symposium on Multidisciplinary Analysis and Optimization September 2 4, 1998/ St. Louis, MO AIAA 98 4712 Acceleration of Multidisciplinary Analysis Solvers by Inexact Subsystem Simulations Matthias Heinkenschloss Mary Beth Hribar Michael Kokkolaras Rice University Houston, Texas 77005-1892 7th

More information

Numerical Heat and Mass Transfer

Numerical Heat and Mass Transfer Master Degree in Mechanical Engineering Numerical Heat and Mass Transfer 15-Convective Heat Transfer Fausto Arpino f.arpino@unicas.it Introduction In conduction problems the convection entered the analysis

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

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

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

ALGEBRAIC FLUX CORRECTION FOR FINITE ELEMENT DISCRETIZATIONS OF COUPLED SYSTEMS

ALGEBRAIC FLUX CORRECTION FOR FINITE ELEMENT DISCRETIZATIONS OF COUPLED SYSTEMS Int. Conf. on Computational Methods for Coupled Problems in Science and Engineering COUPLED PROBLEMS 2007 M. Papadrakakis, E. Oñate and B. Schrefler (Eds) c CIMNE, Barcelona, 2007 ALGEBRAIC FLUX CORRECTION

More information

A DARK GREY P O N T, with a Switch Tail, and a small Star on the Forehead. Any

A DARK GREY P O N T, with a Switch Tail, and a small Star on the Forehead. Any Y Y Y X X «/ YY Y Y ««Y x ) & \ & & } # Y \#$& / Y Y X» \\ / X X X x & Y Y X «q «z \x» = q Y # % \ & [ & Z \ & { + % ) / / «q zy» / & / / / & x x X / % % ) Y x X Y $ Z % Y Y x x } / % «] «] # z» & Y X»

More information

Computational Fluid Dynamics I + II. Mathematische Strömungslehre I + II

Computational Fluid Dynamics I + II. Mathematische Strömungslehre I + II Computational Fluid Dynamics I + II Mathematische Strömungslehre I + II Prof. Dr.-Ing. D. Hänel Aerodynamisches Institut RWTH Aachen Contents 1 Governing equations of fluid dynamics 1 1.1 General formulation

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

Chapter 1. Continuum mechanics review. 1.1 Definitions and nomenclature

Chapter 1. Continuum mechanics review. 1.1 Definitions and nomenclature Chapter 1 Continuum mechanics review We will assume some familiarity with continuum mechanics as discussed in the context of an introductory geodynamics course; a good reference for such problems is Turcotte

More information

Aerodynamic study of a small horizontal-axis wind turbine

Aerodynamic study of a small horizontal-axis wind turbine Aerodynamic study of a small horizontal-axis wind turbine Mihai Leonida NICULESCU*,1, Marius Gabriel COJOCARU 1, Cornelia NITA 1 *Corresponding author *,1 INCAS - National Institute for Aerospace Research

More information

Large scale continuation using a block eigensolver

Large scale continuation using a block eigensolver Universidad Central de Venezuela Facultad de Ciencias Escuela de Computación Lecturas en Ciencias de la Computación ISSN 1316-6239 Large scale continuation using a block eigensolver Z. Castillo RT 2006-03

More information

Department of Mathematics University of California Santa Barbara, Santa Barbara, California,

Department of Mathematics University of California Santa Barbara, Santa Barbara, California, The Ghost Fluid Method for Viscous Flows 1 Ronald P. Fedkiw Computer Science Department Stanford University, Stanford, California 9435 Email:fedkiw@cs.stanford.edu Xu-Dong Liu Department of Mathematics

More information

1 Exercise: Linear, incompressible Stokes flow with FE

1 Exercise: Linear, incompressible Stokes flow with FE Figure 1: Pressure and velocity solution for a sinking, fluid slab impinging on viscosity contrast problem. 1 Exercise: Linear, incompressible Stokes flow with FE Reading Hughes (2000), sec. 4.2-4.4 Dabrowski

More information

Simple waves and a characteristic decomposition of the two dimensional compressible Euler equations

Simple waves and a characteristic decomposition of the two dimensional compressible Euler equations Simple waves and a characteristic decomposition of the two dimensional compressible Euler equations Jiequan Li 1 Department of Mathematics, Capital Normal University, Beijing, 100037 Tong Zhang Institute

More information

A Robust Preconditioned Iterative Method for the Navier-Stokes Equations with High Reynolds Numbers

A Robust Preconditioned Iterative Method for the Navier-Stokes Equations with High Reynolds Numbers Applied and Computational Mathematics 2017; 6(4): 202-207 http://www.sciencepublishinggroup.com/j/acm doi: 10.11648/j.acm.20170604.18 ISSN: 2328-5605 (Print); ISSN: 2328-5613 (Online) A Robust Preconditioned

More information

Application of a Non-Linear Frequency Domain Solver to the Euler and Navier-Stokes Equations

Application of a Non-Linear Frequency Domain Solver to the Euler and Navier-Stokes Equations Application of a Non-Linear Frequency Domain Solver to the Euler and Navier-Stokes Equations Matthew McMullen and Antony Jameson and Juan J. Alonso Dept. of Aeronautics & Astronautics Stanford University

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

A Study of Transonic Flow and Airfoils. Presented by: Huiliang Lui 30 th April 2007

A Study of Transonic Flow and Airfoils. Presented by: Huiliang Lui 30 th April 2007 A Study of Transonic Flow and Airfoils Presented by: Huiliang Lui 3 th April 7 Contents Background Aims Theory Conservation Laws Irrotational Flow Self-Similarity Characteristics Numerical Modeling Conclusion

More information

Computational Analysis of an Imploding Gas:

Computational Analysis of an Imploding Gas: 1/ 31 Direct Numerical Simulation of Navier-Stokes Equations Stephen Voelkel University of Notre Dame October 19, 2011 2/ 31 Acknowledges Christopher M. Romick, Ph.D. Student, U. Notre Dame Dr. Joseph

More information

Space-time Discontinuous Galerkin Methods for Compressible Flows

Space-time Discontinuous Galerkin Methods for Compressible Flows Space-time Discontinuous Galerkin Methods for Compressible Flows Jaap van der Vegt Numerical Analysis and Computational Mechanics Group Department of Applied Mathematics University of Twente Joint Work

More information

PEAT SEISMOLOGY Lecture 2: Continuum mechanics

PEAT SEISMOLOGY Lecture 2: Continuum mechanics PEAT8002 - SEISMOLOGY Lecture 2: Continuum mechanics Nick Rawlinson Research School of Earth Sciences Australian National University Strain Strain is the formal description of the change in shape of a

More information

Saul Abarbanel; Half a century of scientific work. Bertil Gustafsson, Uppsala University

Saul Abarbanel; Half a century of scientific work. Bertil Gustafsson, Uppsala University Saul Abarbanel; Half a century of scientific work Bertil Gustafsson, Uppsala University Grew up in Tel Aviv Served in Israeli Army during the War of Independence 1948 1950 MIT 1952 1959 Ph.D 1959, Theoretical

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

In this section, mathematical description of the motion of fluid elements moving in a flow field is

In this section, mathematical description of the motion of fluid elements moving in a flow field is Jun. 05, 015 Chapter 6. Differential Analysis of Fluid Flow 6.1 Fluid Element Kinematics In this section, mathematical description of the motion of fluid elements moving in a flow field is given. A small

More information

Stabilization of Explicit Flow Solvers Using a Proper Orthogonal Decomposition Technique

Stabilization of Explicit Flow Solvers Using a Proper Orthogonal Decomposition Technique 50th AIAA Aerospace Sciences Meeting including the New Horizons Forum and Aerospace Exposition 09-12 January 2012, Nashville, Tennessee AIAA 2012-1096 Stabilization of Explicit Flow Solvers Using a Proper

More information

AA210A Fundamentals of Compressible Flow. Chapter 1 - Introduction to fluid flow

AA210A Fundamentals of Compressible Flow. Chapter 1 - Introduction to fluid flow AA210A Fundamentals of Compressible Flow Chapter 1 - Introduction to fluid flow 1 1.2 Conservation of mass Mass flux in the x-direction [ ρu ] = M L 3 L T = M L 2 T Momentum per unit volume Mass per unit

More information

Parallel Computation of Forced Vibration for A Compressor Cascade

Parallel Computation of Forced Vibration for A Compressor Cascade 44th AIAA Aerospace Sciences Meeting and Exhibit 9-2 January 26, Reno, Nevada AIAA 26-628 AIAA Paper 26-628 Parallel Computation of Forced Vibration for A Compressor Cascade Zongjun Hu and Gecheng Zha

More information

Stabilization and Acceleration of Algebraic Multigrid Method

Stabilization and Acceleration of Algebraic Multigrid Method Stabilization and Acceleration of Algebraic Multigrid Method Recursive Projection Algorithm A. Jemcov J.P. Maruszewski Fluent Inc. October 24, 2006 Outline 1 Need for Algorithm Stabilization and Acceleration

More information

J. Szantyr Lecture No. 4 Principles of the Turbulent Flow Theory The phenomenon of two markedly different types of flow, namely laminar and

J. Szantyr Lecture No. 4 Principles of the Turbulent Flow Theory The phenomenon of two markedly different types of flow, namely laminar and J. Szantyr Lecture No. 4 Principles of the Turbulent Flow Theory The phenomenon of two markedly different types of flow, namely laminar and turbulent, was discovered by Osborne Reynolds (184 191) in 1883

More information

Chapter 2: Basic Governing Equations

Chapter 2: Basic Governing Equations -1 Reynolds Transport Theorem (RTT) - Continuity Equation -3 The Linear Momentum Equation -4 The First Law of Thermodynamics -5 General Equation in Conservative Form -6 General Equation in Non-Conservative

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

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

Solving the Euler Equations!

Solving the Euler Equations! http://www.nd.edu/~gtryggva/cfd-course/! Solving the Euler Equations! Grétar Tryggvason! Spring 0! The Euler equations for D flow:! where! Define! Ideal Gas:! ρ ρu ρu + ρu + p = 0 t x ( / ) ρe ρu E + p

More information

UNIVERSITY OF EAST ANGLIA

UNIVERSITY OF EAST ANGLIA UNIVERSITY OF EAST ANGLIA School of Mathematics May/June UG Examination 2007 2008 FLUIDS DYNAMICS WITH ADVANCED TOPICS Time allowed: 3 hours Attempt question ONE and FOUR other questions. Candidates must

More information

Is My CFD Mesh Adequate? A Quantitative Answer

Is My CFD Mesh Adequate? A Quantitative Answer Is My CFD Mesh Adequate? A Quantitative Answer Krzysztof J. Fidkowski Gas Dynamics Research Colloqium Aerospace Engineering Department University of Michigan January 26, 2011 K.J. Fidkowski (UM) GDRC 2011

More information

Aerodynamics. Lecture 1: Introduction - Equations of Motion G. Dimitriadis

Aerodynamics. Lecture 1: Introduction - Equations of Motion G. Dimitriadis Aerodynamics Lecture 1: Introduction - Equations of Motion G. Dimitriadis Definition Aerodynamics is the science that analyses the flow of air around solid bodies The basis of aerodynamics is fluid dynamics

More information

3. FORMS OF GOVERNING EQUATIONS IN CFD

3. FORMS OF GOVERNING EQUATIONS IN CFD 3. FORMS OF GOVERNING EQUATIONS IN CFD 3.1. Governing and model equations in CFD Fluid flows are governed by the Navier-Stokes equations (N-S), which simpler, inviscid, form is the Euler equations. For

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

University of Bristol - Explore Bristol Research. Peer reviewed version. Link to published version (if available): /6.

University of Bristol - Explore Bristol Research. Peer reviewed version. Link to published version (if available): /6. Huntley, S., Jones, D., & Gaitonde, A. (217). Aeroelastic Gust Response of an Aircraft Using a Prescribed Velocity Method in Viscous Flows. In 23rd AIAA Computational Fluid Dynamics Conference. [AIAA 217-3616]

More information

A Stable Spectral Difference Method for Triangles

A Stable Spectral Difference Method for Triangles A Stable Spectral Difference Method for Triangles Aravind Balan 1, Georg May 1, and Joachim Schöberl 2 1 AICES Graduate School, RWTH Aachen, Germany 2 Institute for Analysis and Scientific Computing, Vienna

More information

Eli Turkel 1 and Veer N. Vatsa 2

Eli Turkel 1 and Veer N. Vatsa 2 ESAIM: MAN Vol. 39, N o 3, 005, pp. 515 535 DOI: 10.1051/man:00501 ESAIM: Mathematical Modelling and Numerical Analysis LOCAL PRECONDITIONERS FOR STEADY AND UNSTEADY FLOW APPLICATIONS Eli Turkel 1 and

More information

M.A. Botchev. September 5, 2014

M.A. Botchev. September 5, 2014 Rome-Moscow school of Matrix Methods and Applied Linear Algebra 2014 A short introduction to Krylov subspaces for linear systems, matrix functions and inexact Newton methods. Plan and exercises. M.A. Botchev

More information

Some notes about PDEs. -Bill Green Nov. 2015

Some notes about PDEs. -Bill Green Nov. 2015 Some notes about PDEs -Bill Green Nov. 2015 Partial differential equations (PDEs) are all BVPs, with the same issues about specifying boundary conditions etc. Because they are multi-dimensional, they can

More information

Dynamics of Glaciers

Dynamics of Glaciers Dynamics of Glaciers McCarthy Summer School 01 Andy Aschwanden Arctic Region Supercomputing Center University of Alaska Fairbanks, USA June 01 Note: This script is largely based on the Physics of Glaciers

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

Physical Diffusion Cures the Carbuncle Phenomenon

Physical Diffusion Cures the Carbuncle Phenomenon Physical Diffusion Cures the Carbuncle Phenomenon J. M. Powers 1, J. Bruns 1, A. Jemcov 1 1 Department of Aerospace and Mechanical Engineering University of Notre Dame, USA Fifty-Third AIAA Aerospace Sciences

More information

Contents of lecture 2b. Lectures 2a & 2b. Physical vs. computational coordinates [2] Physical vs. computational coordinates [1]

Contents of lecture 2b. Lectures 2a & 2b. Physical vs. computational coordinates [2] Physical vs. computational coordinates [1] Contents of lecture b Lectures a & b P. A. Zegeling Mathematical Institute Utrecht University The Netherlands Parameter-free non-singular moving grids in D: Theory & properties Application to resistive

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

MA3D1 Fluid Dynamics Support Class 5 - Shear Flows and Blunt Bodies

MA3D1 Fluid Dynamics Support Class 5 - Shear Flows and Blunt Bodies MA3D1 Fluid Dynamics Support Class 5 - Shear Flows and Blunt Bodies 13th February 2015 Jorge Lindley email: J.V.M.Lindley@warwick.ac.uk 1 2D Flows - Shear flows Example 1. Flow over an inclined plane A

More information

Number of pages in the question paper : 05 Number of questions in the question paper : 48 Modeling Transport Phenomena of Micro-particles Note: Follow the notations used in the lectures. Symbols have their

More information

An Efficient Low Memory Implicit DG Algorithm for Time Dependent Problems

An Efficient Low Memory Implicit DG Algorithm for Time Dependent Problems An Efficient Low Memory Implicit DG Algorithm for Time Dependent Problems P.-O. Persson and J. Peraire Massachusetts Institute of Technology 2006 AIAA Aerospace Sciences Meeting, Reno, Nevada January 9,

More information

Self-similar solutions for the diffraction of weak shocks

Self-similar solutions for the diffraction of weak shocks Self-similar solutions for the diffraction of weak shocks Allen M. Tesdall John K. Hunter Abstract. We numerically solve a problem for the unsteady transonic small disturbance equations that describes

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

Computational Astrophysics

Computational Astrophysics Computational Astrophysics Lecture 1: Introduction to numerical methods Lecture 2:The SPH formulation Lecture 3: Construction of SPH smoothing functions Lecture 4: SPH for general dynamic flow Lecture

More information

STEADY AND UNSTEADY 2D NUMERICAL SOLUTION OF GENERALIZED NEWTONIAN FLUIDS FLOW. Radka Keslerová, Karel Kozel

STEADY AND UNSTEADY 2D NUMERICAL SOLUTION OF GENERALIZED NEWTONIAN FLUIDS FLOW. Radka Keslerová, Karel Kozel Conference Applications of Mathematics 1 in honor of the th birthday of Michal Křížek. Institute of Mathematics AS CR, Prague 1 STEADY AND UNSTEADY D NUMERICAL SOLUTION OF GENERALIZED NEWTONIAN FLUIDS

More information

Joule Heating Effect on the Coupling of Conduction with Magnetohydrodynamic Free Convection Flow from a Vertical Flat Plate

Joule Heating Effect on the Coupling of Conduction with Magnetohydrodynamic Free Convection Flow from a Vertical Flat Plate Nonlinear Analysis: Modelling and Control, 27, Vol. 12, No. 3, 37 316 Joule Heating Effect on the Coupling of Conduction with Magnetohydrodynamic Free Convection Flow from a Vertical Flat Plate M. A. Alim

More information

Follow this and additional works at:

Follow this and additional works at: Washington University in St. Louis Washington University Open Scholarship Mechanical Engineering and Materials Science Independent Study Mechanical Engineering & Materials Science 12-19-2016 The Effects

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

MULTIGRID CALCULATIONS FOB. CASCADES. Antony Jameson and Feng Liu Princeton University, Princeton, NJ 08544

MULTIGRID CALCULATIONS FOB. CASCADES. Antony Jameson and Feng Liu Princeton University, Princeton, NJ 08544 MULTIGRID CALCULATIONS FOB. CASCADES Antony Jameson and Feng Liu Princeton University, Princeton, NJ 0544 1. Introduction Development of numerical methods for internal flows such as the flow in gas turbines

More information

Streamline calculations. Lecture note 2

Streamline calculations. Lecture note 2 Streamline calculations. Lecture note 2 February 26, 2007 1 Recapitulation from previous lecture Definition of a streamline x(τ) = s(τ), dx(τ) dτ = v(x,t), x(0) = x 0 (1) Divergence free, irrotational

More information

tutorial ii: One-parameter bifurcation analysis of equilibria with matcont

tutorial ii: One-parameter bifurcation analysis of equilibria with matcont tutorial ii: One-parameter bifurcation analysis of equilibria with matcont Yu.A. Kuznetsov Department of Mathematics Utrecht University Budapestlaan 6 3508 TA, Utrecht February 13, 2018 1 This session

More information

Estimation of grid-induced errors in computational fluid dynamics solutions using a discrete error transport equation

Estimation of grid-induced errors in computational fluid dynamics solutions using a discrete error transport equation Graduate Theses and Dissertations Graduate College 2009 Estimation of grid-induced errors in computational fluid dynamics solutions using a discrete error transport equation Brandon Williams Iowa State

More information

Marching on the BL equations

Marching on the BL equations Marching on the BL equations Harvey S. H. Lam February 10, 2004 Abstract The assumption is that you are competent in Matlab or Mathematica. White s 4-7 starting on page 275 shows us that all generic boundary

More information

Application of Dual Time Stepping to Fully Implicit Runge Kutta Schemes for Unsteady Flow Calculations

Application of Dual Time Stepping to Fully Implicit Runge Kutta Schemes for Unsteady Flow Calculations Application of Dual Time Stepping to Fully Implicit Runge Kutta Schemes for Unsteady Flow Calculations Antony Jameson Department of Aeronautics and Astronautics, Stanford University, Stanford, CA, 94305

More information

A recovery-assisted DG code for the compressible Navier-Stokes equations

A recovery-assisted DG code for the compressible Navier-Stokes equations A recovery-assisted DG code for the compressible Navier-Stokes equations January 6 th, 217 5 th International Workshop on High-Order CFD Methods Kissimmee, Florida Philip E. Johnson & Eric Johnsen Scientific

More information

ON USING ARTIFICIAL COMPRESSIBILITY METHOD FOR SOLVING TURBULENT FLOWS

ON USING ARTIFICIAL COMPRESSIBILITY METHOD FOR SOLVING TURBULENT FLOWS Conference Applications of Mathematics 212 in honor of the 6th birthday of Michal Křížek. Institute of Mathematics AS CR, Prague 212 ON USING ARTIFICIAL COMPRESSIBILITY METHOD FOR SOLVING TURBULENT FLOWS

More information

Lecture: Wave-induced Momentum Fluxes: Radiation Stresses

Lecture: Wave-induced Momentum Fluxes: Radiation Stresses Chapter 4 Lecture: Wave-induced Momentum Fluxes: Radiation Stresses Here we derive the wave-induced depth-integrated momentum fluxes, otherwise known as the radiation stress tensor S. These are the 2nd-order

More information

Module-5: Hypersonic Boundary Layer theory. Lecture-20: Hypersonic boundary equation

Module-5: Hypersonic Boundary Layer theory. Lecture-20: Hypersonic boundary equation Module-5: Hypersonic Boundary Layer theory Lecture-0: Hypersonic boundary equation 0.1 Governing Equations for Viscous Flows The Navier-Stokes (NS) equaadtions are the governing equations for the viscous

More information

LibMesh Experience and Usage

LibMesh Experience and Usage LibMesh Experience and Usage John W. Peterson peterson@cfdlab.ae.utexas.edu and Roy H. Stogner roystgnr@cfdlab.ae.utexas.edu Univ. of Texas at Austin September 9, 2008 1 Introduction 2 Weighted Residuals

More information

Nonlinear Frequency Domain Methods Applied to the Euler and Navier-Stokes Equations p.1/50

Nonlinear Frequency Domain Methods Applied to the Euler and Navier-Stokes Equations p.1/50 Nonlinear Frequency Domain Methods Applied to the Euler and Navier-Stokes Equations Matthew McMullen Advisor: Antony Jameson Co-advisor: Juan Alonso Sponsor: Accelerated Strategic Computing Initiative

More information

Computer Applications in Engineering and Construction Programming Assignment #9 Principle Stresses and Flow Nets in Geotechnical Design

Computer Applications in Engineering and Construction Programming Assignment #9 Principle Stresses and Flow Nets in Geotechnical Design CVEN 302-501 Computer Applications in Engineering and Construction Programming Assignment #9 Principle Stresses and Flow Nets in Geotechnical Design Date distributed : 12/2/2015 Date due : 12/9/2015 at

More information

Computational Fluid Dynamics-1(CFDI)

Computational Fluid Dynamics-1(CFDI) بسمه تعالی درس دینامیک سیالات محاسباتی 1 دوره کارشناسی ارشد دانشکده مهندسی مکانیک دانشگاه صنعتی خواجه نصیر الدین طوسی Computational Fluid Dynamics-1(CFDI) Course outlines: Part I A brief introduction to

More information