Physics 432, Physics of fluids: Assignment #1 Solutions

Size: px
Start display at page:

Download "Physics 432, Physics of fluids: Assignment #1 Solutions"

Transcription

1 Physics 432, Physics of fluids: Assignment #1 Solutions 1. This is an investigation of the two-dimensional draining bathtub problem described in lecture, where the tub has fluid level h, width 2L and drain width 2D. (a) Rewrite the order-of-magnitude prediction from lecture for the typical velocity in terms of the dimensionless variable u = u/u where U = gh, for the cases where Reynold s number R 1 and R 1. We want to test these predictions numerically in the following. In the inviscid limit, our prediction was u gh. This is the same as our unit of velocity U, so the dimensionless variable u is expected to be of order unity in this case. If viscosity is significant, then we expect u gh 2 /ν, which leads to u gh 3/2 /ν. This is the same as Reynold s number in this problem, so we predict u R. Hence we can write u R both for the cases where R 1 and when R 1. (b) Supposing that h = 15 cm, compute R for the fluids listed in Table 2.1 of the textbook, as well as for ketchup. gh 3/2 = cm 2 /s. Then R = , , , 101, 1.5 for the fluids in table 2.1, and for ketchup 0.3, taking ν = 6000 cm 2 /s. (c) Write a subroutine to compute the average value u y in the drain. Compute it for enough values of R < 1 to deduce the relation between u y and R. Does u y vary with R as predicted? Determine the constant of proportionality. subroutine average(uy,nx,ny,nd,u_avg) c returns average value of u_y on the lattice integer Nd,Nx,Ny,i,k real*8 uy(-nx:nx,0:ny), u_avg k=0 u_avg = 0 do i=-nd,nd u_avg = u_avg + uy(i,0) k=k+1 u_avg = u_avg/k Computing u y at R = 10 3, 10 2, 10 1 and 1, we find a linear result shown in fig. 1. It is fit by u y = R. Unfortunately it does not level off for large R as predicted. This is part of the more general problem that our program does not work at large R, as explored in the next part. (d) You will notice that strange results occur when R 1...

2 0.01 u y R Figure 1: Average value of u y at the drain, versus R. Show that with the proper rescalings, it can be written as t u + ( u ) u = p + R 1 2 u (1) Modify the program accordingly to incorporate the new version of the momentum equation (remember that that pressure discontinuity and its relaxation equation will also be changed). Show that unfortunately this doesn t fix the problem. We notice that at large R, there is an upward flow of fluid to the sides of the drain; see left graph of fig. 2. It is as though the fluid at the top wants to fall faster than it can get through the drain and so there is a backwash near the drain boundary. This doesn t seem physical. Figure 2: Left: spurious solution for u y at R = 40. Right: same, but in the modified program using eq. (1). Let u = u gh, x = hx, t = h/g t, p = ρgh p Then the equation takes the desired form. Thus we have to change the discontinuity in the pressure to p = 1 at the drain, instead of p = R as we had before, in subroutine init values. When we take the divergence of the momentum equation in these new variables, it gives 2 p = i u j j u i rather than 2 p = R i u j j u i as we had before, so we need to take this factor of R out of the relax subroutine. In subroutine evolve u, we need to change the lines

3 to read uxn(ix,iy) = ux(ix,iy) + dt*( - R*Dux - gpx + Lux) uyn(ix,iy) = uy(ix,iy) + dt*( - R*Duy - gpy + Luy) uxn(ix,iy) = ux(ix,iy) + dt*( - Dux - gpx + Lux/R) uyn(ix,iy) = uy(ix,iy) + dt*( - Duy - gpy + Luy/R) The result for R = 40 is shown in the right-hand side of fig. 2. In fact, our modifications make the problem less severe, but they don t fix it completely. (e) Assuming that h = 15 cm, L = 50 cm, D = 5 cm, and that ρ is the same as for water, are there any fluids in the list considered in (b) such that you can hope to apply this program? If so, estimate the time needed for the tub to drain for these fluids. We get reasonable results for R 1, so we could hope to apply this program for golden syrup and for ketchup. I find that u y = 0.1 for R = 1.5 and 0.02 for R = 0.3. We must multiply by gh to convert these to physical velocities. The flow through the drain, per unit length in the z direction, is φ = 2D u y, while the volume of water per length in the z direction is V = 2Lh. Then the time for the tub to drain is t = V φ = 2Lh 2D gh u y = { 12 s, R = s, R = 0.3 With the modified program from part (d) I find values that differ by 20% from these. (f) It is good to check whether the u = 0 condition is satisfied. The program comes with subroutines to compute and display u. Check it at the of an evolution. At first it might look small enough, but the question is, how small should it be? Find a criterion to determine whether the discrete approximation to u is really small compared to an appropriate quantity, and modify the routines so that it plots the ratio of u to this quantity. You should see that the result is not so impressive any more. This is why many computational fluid dynamics programs use conservative methods, that automatically enforce the divergence-free condition. A good criterion for whether the divergence is really small could be x u x + y u y x u x + y u y 1 (2) or something similar, that compares the sum of the terms to the typical value that either one is taking. To plot it, we should modify the routines divergence and display div so that they pass the individual terms approximating x u x and y u y rather than just the sum: subroutine divergence(ux,uy,nx,ny,dx,dy,dux,duy) c computes the divergence of velocity field integer Nx,Ny,ix,iy real*8 ux(-nx:nx,0:ny),uy(-nx:nx,0:ny),dx,dy, & dux(-nx+1:nx-1,1:ny-1),duy(-nx+1:nx-1,1:ny-1)

4 do ix=-nx+1,nx-1 do iy = 1,Ny-1 dux(ix,iy) = (ux(ix+1,iy)-ux(ix-1,iy))/(2*dx) duy(ix,iy) = (uy(ix,iy+1)-uy(ix,iy-1))/(2*dy) subroutine display_div(dux,duy,nx,ny) c to check the divergence of u, c creates data file for plotting by gnuplot. c Assumes preexisting files dp.gnu, ux,gnu, uy.gnu character*2 name integer Nx,Ny,ix,iy,sys real*8 dux(-nx+1:nx-1,1:ny-1),duy(-nx+1:nx-1,1:ny-1),div open(1,file= du.dat,status= unknown ) do ix = -Nx+1,Nx-1 do iy = 1,Ny-1 div = ( dux(ix,iy) + duy(ix,iy) ) & /( abs(dux(ix,iy))+abs(duy(ix,iy)) ) write(1,*) ix,iy,div write(1,*) close(1) sys = system( gnuplot du.gnu ) The result is shown for the case of R = 0.3 in fig. 3). It is not small as we would have hoped, showing the need for better algorithms such as finite-volume methods. Figure 3: Graph of (2) for the solution with R = 0.3 (g) In lecture it was noted that to get just the steady-state solution, it is possible to solve the whole system using relaxation. Make a new version of the relax subroutine so that the new values of u x and u y are given by the relaxation algorithm in the same loop

5 that updates the pressure. (The time loop in this case is no longer necessary and you can set Nt = 1 in the main program.) Check whether the result is the same as in the previous method. Note that this one is much more efficient. We add the equations for the Laplacian of u and solve them by over-relaxation simultaneously with p. subroutine relax2(ux,uy,p,nx,ny,dx,dy) c over-relaxation routine to solve Laplace equation for pressure c checks for convergence of average pressure to tolerance conv real*8 h,l,dx,dy,r,d,w/1.4d0/, S, ptot, lastptot integer Nx,Ny, Nitmax/ /, ix, iy, it, Nd real*8 ux(-nx:nx,0:ny),uy(-nx:nx,0:ny),p(-nx:nx,0:ny),pnew real*8 uxn,uyn,gpx,gpy,dux,duy real*8 conv/1.d-3/, C, dxdy,dydx common/rb/r common/ndb/nd ptot = 0.d0 dxdy = dx/dy dydx = dy/dx C = (dxdy + dydx)/2 do it = 1,Nitmax lastptot = ptot ptot = 0.d0 do ix = -Nx+1,Nx-1 do iy = 1,Ny-1 S = R*( (uy(ix+1,iy)-uy(ix-1,iy))*(ux(ix,iy+1)-ux(ix,iy-1)) & -(ux(ix+1,iy)-ux(ix-1,iy))*(uy(ix,iy+1)-uy(ix,iy-1)) )/8 pnew = ( dydx*(p(ix+1,iy) + p(ix-1,iy)) & + dxdy*(p(ix,iy+1) + p(ix,iy-1)) )/(4*C) - S/C gpx = (p(ix+1,iy)-p(ix-1,iy))/(2*dx) gpy = (p(ix,iy+1)-p(ix,iy-1))/(2*dy)! pressure gradient uxn = ( dydx*(ux(ix+1,iy) + ux(ix-1,iy)) & + dxdy*(ux(ix,iy+1) + ux(ix,iy-1)) )/(4*C) & - dx*dy*(gpx)/(4*c) uyn = ( dydx*(uy(ix+1,iy) + uy(ix-1,iy)) & + dxdy*(uy(ix,iy+1) + uy(ix,iy-1)) )/(4*C) & - dx*dy*(gpy)/(4*c) p(ix,iy) = w*pnew + (1-w)*p(ix,iy) ux(ix,iy) = w*uxn + (1-w)*ux(ix,iy) uy(ix,iy) = w*uyn + (1-w)*uy(ix,iy)

6 ptot = ptot +p(ix,iy) do ix=-nd,nd! maintain Neumann b.c. over drain ux(ix,0) = ux(ix,1) uy(ix,0) = uy(ix,1) if (it.gt.1.and.abs(1.d0 -ptot/lastptot).lt.conv) return write(6,*) convergence not achieved in relax stop The graphs of the solution look the same as for the previous algorithm, but careful comparison shows differences. When we redo part (c), we find that u y = R, which differs by 20% from our previous result. Notice that we have not tested convergence with respect to taking x, y 0. Experimentation shows that our lattice is still rather coarse and we should take it to be larger to get more accurate predictions. Doubling the number of lattice points in each direction causes the two methods to converge toward u y = 0.07 R. The time-depent method starts getting very slow for such large lattices. 2. Look at the toy model problem of eq. (8.10) of the textbook (also discussed in lecture). Write a program to solve this problem using the relaxation technique. (This is much simpler than the previous problem because there is only one dimension.) Compare how the algorithm works for large values of ɛ relative to small ones. (Do not start with a guess that is very good.) To graph your results you can use a gnuplot command similar to those in the previous problem, but replace the splot command ( splot stands for surface plot) with the command plot filename with lines. The filename (referring to the file generated by your fortran program) must be within single quotes. You can plot multiple curves on a single graph by the command plot filename1 w lines, filename2 w lines,... Here is my code: integer M,Nd,i,j,k, Niter,sys,system, Nskip/1000/,M1 parameter (M=1000,Niter=20000,M1=M+1) real*8 u(0:m1),y(0:m1),eps,a,unew,w/1.4/ a = 1.d0/M1 eps = 1.d-2 c initial guess do i = 0,M1 y(i) = i*a u(i) = 1.d0-y(i)

7 c c & boundary conditions u(0) = 0.d0 u(m1) = 2.d0 iterations do k=0, Niter open(1,file= u1d.dat,status= unknown ) do j=0,m1 if (j.ne.0.and.j.ne.m1) then unew = 0.5d0*(u(j+1) + u(j-1)) + a/eps*(u(j+1) - u(j-1))/4 - a**2/(2*eps) u(j) = w*unew + (1-w)*u(j) if if (Nskip*(k/Nskip).eq.k) write(1,*) u(j),y(j) write(1,*) close(1) sys = system( xmgrace u1d.dat ) open(1,file= exact.dat,status= unknown ) do i=0,m1 write(1,*) y(i) + (1-exp(-y(i)/eps))/(1-exp(-1/eps)), y(i) close(1) Notice I am using over-relaxation, which one can verify does help to speed up the convergence significantly. I used a different plotting program, xmgrace, which I prefer for 1D plots. The results are shown for ɛ = 0.01 and ɛ = 1 in fig. 4. Here I deliberately chose a very bad initial guess to make the algorithm work hard, since we wanted to test it. Some results of intermediate iterations are shown to indicate the speed of convergence. I was surprised by the fact that convergence is actually much faster for smaller rather than larger ɛ!. This must have something to do with the fact that the driving force which is causing changes in the solution between iterations is small when ɛ As an example of a situation that could arise in a finite-volume numerical approach, consider the 2D control volume shown in fig. 5. Let the coordinates be (s, t) such that the lower right corner of the volume is at the origin, as shown, and the nodes are at halfinteger values. Show that inside the square with the vertices hosting velocities u 1,..., u 4, linear interpolation gives u(s, t) = ( 1 2 s)( 1 2 t) u 1 + (s )( 1 2 t) u 2 + (s )(t ) u 3 + ( 1 2 s)( t) u 4 Using this, evaluate the flux of fluid through the surface e 1. Once you have this result, it is easy to write down the net flux through the remaining surfaces e 2, w 1, w 2, and also through the top and bottom surfaces. What constraint does fluid conservation in the control volume place on the velocities at the nodes? A simpler interpolation scheme is often used, in which for a given face, one only interpolates in the direction perpicular to that face, and ignores all but the closest two nodes. How does your result look in

8 1 ε = 0.01 initial guess 1 ε = 1 initial guess y exact solution y ,000 40,000 exact solution u u Figure 4: Relaxation solutions for the 1D toy problem with ɛ = 0.01 (left) and ɛ = 1 (right). Intermediate results are labeled by the iteration number; they converge to the exact result. that case? (A nice feature of this method is that it also works for highly irregular and nonuniform lattices, where the corresponding results would be less trivial.) u 6 u 7 u 8 w 2 e 2 u5 w 1 u 4 e 1 u 3 (s,t)=(0,0) u 0 u 1 u 2 Figure 5: A control volume in a finite-volume numerical setup. To prove the formula, simply evaluate it at the points (s, t) = (± 1, ± 1 ), where the 2 2 variables u 1,..., u 4 live. It is easy to see that it gives the right values at those points. Thus the coefficients of each u i in the interpolation formula are correctly determined. For the surface e 1, the flux (to the right) is given by φ e1 = 1 2 Then by geometric comparison, 0 u x (0, t)dt = 1 16 (ux 1 + u x 2) (ux 3 + u x 4) φ e2 = 1 16 (ux 7 + u x 8) (ux 3 + u x 4) φ w1 = 1 16 (ux 0 + u x 1) (ux 4 + u x 5) φ w2 = 1 16 (ux 6 + u x 7) (ux 4 + u x 5) The total flux out of the control volume through the the vertical walls is φ e1 + φ e2 φ w1 φ w2 = 3 8 (ux 3 u x 5) (ux 2 u x 0 + u x 8 u x 6)

9 Then it is easy to see that the corresponding expression for the outward flux through the horizontal walls is φ n φ s = 3 8 (uy 7 u y 1) (uy 6 u y 0 + u y 8 u y 2) Our contraint is that the sum of these two quantities vanishes. In the simpler interpolation scheme, we have φ e = 1 2 (ux 3 + u x 4), φ w = 1 2 (ux 4 + u x 5), φ n = 1 2 (uy 4 + u y 7), φ s = 1 2 (uy 1 + u y 4). Then the constraint becomes u x 3 u x 5 + u y 7 u y 4 = 0 which you recognize as a discrete approximation to the vanishing of the divergence.

7 The Navier-Stokes Equations

7 The Navier-Stokes Equations 18.354/12.27 Spring 214 7 The Navier-Stokes Equations In the previous section, we have seen how one can deduce the general structure of hydrodynamic equations from purely macroscopic considerations and

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

Fluid flow I: The potential function

Fluid flow I: The potential function 5//0 Miscellaneous Exercises Fluid Flow I Fluid flow I: The potential function One of the equations describing the flow of a fluid is the continuity equation: u 0 t where is the fluid density and u is

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

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

2. FLUID-FLOW EQUATIONS SPRING 2019

2. FLUID-FLOW EQUATIONS SPRING 2019 2. FLUID-FLOW EQUATIONS SPRING 2019 2.1 Introduction 2.2 Conservative differential equations 2.3 Non-conservative differential equations 2.4 Non-dimensionalisation Summary Examples 2.1 Introduction Fluid

More information

The Shallow Water Equations

The Shallow Water Equations If you have not already done so, you are strongly encouraged to read the companion file on the non-divergent barotropic vorticity equation, before proceeding to this shallow water case. We do not repeat

More information

Candidates must show on each answer book the type of calculator used. Only calculators permitted under UEA Regulations may be used.

Candidates must show on each answer book the type of calculator used. Only calculators permitted under UEA Regulations may be used. UNIVERSITY OF EAST ANGLIA School of Mathematics May/June UG Examination 2011 2012 FLUID DYNAMICS MTH-3D41 Time allowed: 3 hours Attempt FIVE questions. Candidates must show on each answer book the type

More information

Candidates must show on each answer book the type of calculator used. Log Tables, Statistical Tables and Graph Paper are available on request.

Candidates must show on each answer book the type of calculator used. Log Tables, Statistical Tables and Graph Paper are available on request. UNIVERSITY OF EAST ANGLIA School of Mathematics Spring Semester Examination 2004 FLUID DYNAMICS Time allowed: 3 hours Attempt Question 1 and FOUR other questions. Candidates must show on each answer book

More information

Fluid flow II: The stream function

Fluid flow II: The stream function 5//0 Miscellaneous Exercises Fluid Flow II Fluid flow II: The stream function This exercise is a continuation of the Fluid flow I exercise. Read that exercise an introduction. It is possible to obtain

More information

Chapter 5. Methods for Solving Elliptic Equations

Chapter 5. Methods for Solving Elliptic Equations Chapter 5. Methods for Solving Elliptic Equations References: Tannehill et al Section 4.3. Fulton et al (1986 MWR). Recommended reading: Chapter 7, Numerical Methods for Engineering Application. J. H.

More information

Exam in Fluid Mechanics 5C1214

Exam in Fluid Mechanics 5C1214 Eam in Fluid Mechanics 5C1214 Final eam in course 5C1214 13/01 2004 09-13 in Q24 Eaminer: Prof. Dan Henningson The point value of each question is given in parenthesis and you need more than 20 points

More information

Notes for CS542G (Iterative Solvers for Linear Systems)

Notes for CS542G (Iterative Solvers for Linear Systems) Notes for CS542G (Iterative Solvers for Linear Systems) Robert Bridson November 20, 2007 1 The Basics We re now looking at efficient ways to solve the linear system of equations Ax = b where in this course,

More information

PowerPoints organized by Dr. Michael R. Gustafson II, Duke University

PowerPoints organized by Dr. Michael R. Gustafson II, Duke University Part 6 Chapter Boundary-Value Problems PowerPoints organized by Dr. Michael R. Gustafson II, Duke University All images copyright The McGraw-Hill Companies, Inc. Permission required for reproduction or

More information

Lifting Airfoils in Incompressible Irrotational Flow. AA210b Lecture 3 January 13, AA210b - Fundamentals of Compressible Flow II 1

Lifting Airfoils in Incompressible Irrotational Flow. AA210b Lecture 3 January 13, AA210b - Fundamentals of Compressible Flow II 1 Lifting Airfoils in Incompressible Irrotational Flow AA21b Lecture 3 January 13, 28 AA21b - Fundamentals of Compressible Flow II 1 Governing Equations For an incompressible fluid, the continuity equation

More information

Physics 342 Lecture 23. Radial Separation. Lecture 23. Physics 342 Quantum Mechanics I

Physics 342 Lecture 23. Radial Separation. Lecture 23. Physics 342 Quantum Mechanics I Physics 342 Lecture 23 Radial Separation Lecture 23 Physics 342 Quantum Mechanics I Friday, March 26th, 2010 We begin our spherical solutions with the simplest possible case zero potential. Aside from

More information

Solving PDEs with Multigrid Methods p.1

Solving PDEs with Multigrid Methods p.1 Solving PDEs with Multigrid Methods Scott MacLachlan maclachl@colorado.edu Department of Applied Mathematics, University of Colorado at Boulder Solving PDEs with Multigrid Methods p.1 Support and Collaboration

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

Math 234 Exam 3 Review Sheet

Math 234 Exam 3 Review Sheet Math 234 Exam 3 Review Sheet Jim Brunner LIST OF TOPIS TO KNOW Vector Fields lairaut s Theorem & onservative Vector Fields url Divergence Area & Volume Integrals Using oordinate Transforms hanging the

More information

MASSACHUSETTS INSTITUTE OF TECHNOLOGY DEPARTMENT OF MECHANICAL ENGINEERING CAMBRIDGE, MASSACHUSETTS NUMERICAL FLUID MECHANICS FALL 2011

MASSACHUSETTS INSTITUTE OF TECHNOLOGY DEPARTMENT OF MECHANICAL ENGINEERING CAMBRIDGE, MASSACHUSETTS NUMERICAL FLUID MECHANICS FALL 2011 MASSACHUSETTS INSTITUTE OF TECHNOLOGY DEPARTMENT OF MECHANICAL ENGINEERING CAMBRIDGE, MASSACHUSETTS 02139 2.29 NUMERICAL FLUID MECHANICS FALL 2011 QUIZ 2 The goals of this quiz 2 are to: (i) ask some general

More information

One-dimensional Schrödinger equation

One-dimensional Schrödinger equation Chapter 1 One-dimensional Schrödinger equation In this chapter we will start from the harmonic oscillator to introduce a general numerical methodology to solve the one-dimensional, time-independent Schrödinger

More information

Divergence Theorem and Its Application in Characterizing

Divergence Theorem and Its Application in Characterizing Divergence Theorem and Its Application in Characterizing Fluid Flow Let v be the velocity of flow of a fluid element and ρ(x, y, z, t) be the mass density of fluid at a point (x, y, z) at time t. Thus,

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

Elliptic Problems / Multigrid. PHY 604: Computational Methods for Physics and Astrophysics II

Elliptic Problems / Multigrid. PHY 604: Computational Methods for Physics and Astrophysics II Elliptic Problems / Multigrid Summary of Hyperbolic PDEs We looked at a simple linear and a nonlinear scalar hyperbolic PDE There is a speed associated with the change of the solution Explicit methods

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

Lattice Boltzmann Method Solver Documentation

Lattice Boltzmann Method Solver Documentation Lattice Boltzmann Method Solver Documentation Release 0.0.1 Sayop Kim May 03, 2016 Contents 1 Code Instruction 3 1.1 Quick instruction for running the simulation.............................. 3 2 Results

More information

Project Two. Outline. James K. Peterson. March 27, Cooling Models. Estimating the Cooling Rate k. Typical Cooling Project Matlab Session

Project Two. Outline. James K. Peterson. March 27, Cooling Models. Estimating the Cooling Rate k. Typical Cooling Project Matlab Session Project Two James K. Peterson Department of Biological Sciences and Department of Mathematical Sciences Clemson University March 27, 2018 Outline Cooling Models Estimating the Cooling Rate k Typical Cooling

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

MATH 333: Partial Differential Equations

MATH 333: Partial Differential Equations MATH 333: Partial Differential Equations Problem Set 9, Final version Due Date: Tues., Nov. 29, 2011 Relevant sources: Farlow s book: Lessons 9, 37 39 MacCluer s book: Chapter 3 44 Show that the Poisson

More information

14 Divergence, flux, Laplacian

14 Divergence, flux, Laplacian Tel Aviv University, 204/5 Analysis-III,IV 240 4 Divergence, flux, Laplacian 4a What is the problem................ 240 4b Integral of derivative (again)........... 242 4c Divergence and flux.................

More information

FINITE VOLUME METHOD: BASIC PRINCIPLES AND EXAMPLES

FINITE VOLUME METHOD: BASIC PRINCIPLES AND EXAMPLES FINITE VOLUME METHOD: BASIC PRINCIPLES AND EXAMPLES SHRUTI JAIN B.Tech III Year, Electronics and Communication IIT Roorkee Tutors: Professor G. Biswas Professor S. Chakraborty ACKNOWLEDGMENTS I would like

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

Partial Differential Equations Summary

Partial Differential Equations Summary Partial Differential Equations Summary 1. The heat equation Many physical processes are governed by partial differential equations. temperature of a rod. In this chapter, we will examine exactly that.

More information

Lecture 8: Tissue Mechanics

Lecture 8: Tissue Mechanics Computational Biology Group (CoBi), D-BSSE, ETHZ Lecture 8: Tissue Mechanics Prof Dagmar Iber, PhD DPhil MSc Computational Biology 2015/16 7. Mai 2016 2 / 57 Contents 1 Introduction to Elastic Materials

More information

Exercice I Exercice II Exercice III Exercice IV Exercice V. Exercises. Boundary Conditions in lattice Boltzmann method

Exercice I Exercice II Exercice III Exercice IV Exercice V. Exercises. Boundary Conditions in lattice Boltzmann method Exercises Boundary Conditions in lattice Boltzmann method Goncalo Silva Department of Mechanical Engineering Instituto Superior Técnico (IST) Lisbon, Portugal Setting the problem Exercise I: Poiseuille

More information

Multistep Methods for IVPs. t 0 < t < T

Multistep Methods for IVPs. t 0 < t < T Multistep Methods for IVPs We are still considering the IVP dy dt = f(t,y) t 0 < t < T y(t 0 ) = y 0 So far we have looked at Euler s method, which was a first order method and Runge Kutta (RK) methods

More information

7. Basics of Turbulent Flow Figure 1.

7. Basics of Turbulent Flow Figure 1. 1 7. Basics of Turbulent Flow Whether a flow is laminar or turbulent depends of the relative importance of fluid friction (viscosity) and flow inertia. The ratio of inertial to viscous forces is the Reynolds

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

7 Mathematical Methods 7.6 Insulation (10 units)

7 Mathematical Methods 7.6 Insulation (10 units) 7 Mathematical Methods 7.6 Insulation (10 units) There are no prerequisites for this project. 1 Introduction When sheets of plastic and of other insulating materials are used in the construction of building

More information

CS 542G: The Poisson Problem, Finite Differences

CS 542G: The Poisson Problem, Finite Differences CS 542G: The Poisson Problem, Finite Differences Robert Bridson November 10, 2008 1 The Poisson Problem At the end last time, we noticed that the gravitational potential has a zero Laplacian except at

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

Relevant sections from AMATH 351 Course Notes (Wainwright): Relevant sections from AMATH 351 Course Notes (Poulin and Ingalls):

Relevant sections from AMATH 351 Course Notes (Wainwright): Relevant sections from AMATH 351 Course Notes (Poulin and Ingalls): Lecture 5 Series solutions to DEs Relevant sections from AMATH 35 Course Notes (Wainwright):.4. Relevant sections from AMATH 35 Course Notes (Poulin and Ingalls): 2.-2.3 As mentioned earlier in this course,

More information

Turbulence is a ubiquitous phenomenon in environmental fluid mechanics that dramatically affects flow structure and mixing.

Turbulence is a ubiquitous phenomenon in environmental fluid mechanics that dramatically affects flow structure and mixing. Turbulence is a ubiquitous phenomenon in environmental fluid mechanics that dramatically affects flow structure and mixing. Thus, it is very important to form both a conceptual understanding and a quantitative

More information

Introduction. Math 1080: Numerical Linear Algebra Chapter 4, Iterative Methods. Example: First Order Richardson. Strategy

Introduction. Math 1080: Numerical Linear Algebra Chapter 4, Iterative Methods. Example: First Order Richardson. Strategy Introduction Math 1080: Numerical Linear Algebra Chapter 4, Iterative Methods M. M. Sussman sussmanm@math.pitt.edu Office Hours: MW 1:45PM-2:45PM, Thack 622 Solve system Ax = b by repeatedly computing

More information

A First Course on Kinetics and Reaction Engineering Unit D and 3-D Tubular Reactor Models

A First Course on Kinetics and Reaction Engineering Unit D and 3-D Tubular Reactor Models Unit 34. 2-D and 3-D Tubular Reactor Models Overview Unit 34 describes two- and three-dimensional models for tubular reactors. One limitation of the ideal PFR model is that the temperature and composition

More information

Solving the Generalized Poisson Equation Using the Finite-Difference Method (FDM)

Solving the Generalized Poisson Equation Using the Finite-Difference Method (FDM) Solving the Generalized Poisson Equation Using the Finite-Difference Method (FDM) James R. Nagel September 30, 2009 1 Introduction Numerical simulation is an extremely valuable tool for those who wish

More information

Quick Introduction to Momentum Principle. Momentum. Momentum. Basic principle not at all obvious on Earth 24/02/11

Quick Introduction to Momentum Principle. Momentum. Momentum. Basic principle not at all obvious on Earth 24/02/11 Momentum Quick Introduction to Momentum Principle We will come back to all of this - this is just a taster. The momentum principle is another way of saying Newton s Laws It is one of the three great principles

More information

Higher-order ordinary differential equations

Higher-order ordinary differential equations Higher-order ordinary differential equations 1 A linear ODE of general order n has the form a n (x) dn y dx n +a n 1(x) dn 1 y dx n 1 + +a 1(x) dy dx +a 0(x)y = f(x). If f(x) = 0 then the equation is called

More information

Boundary Layers. Lecture 2 by Basile Gallet. 2i(1+i) The solution to this equation with the boundary conditions A(0) = U and B(0) = 0 is

Boundary Layers. Lecture 2 by Basile Gallet. 2i(1+i) The solution to this equation with the boundary conditions A(0) = U and B(0) = 0 is Boundary Layers Lecture 2 by Basile Gallet continued from lecture 1 This leads to a differential equation in Z Z (A ib) + (A ib)[ C + Uy Uy 2i(1+i) ] = 0 with C = 2. The solution to this equation with

More information

Introduction to Heat and Mass Transfer. Week 9

Introduction to Heat and Mass Transfer. Week 9 Introduction to Heat and Mass Transfer Week 9 補充! Multidimensional Effects Transient problems with heat transfer in two or three dimensions can be considered using the solutions obtained for one dimensional

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

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 3: Finite Elements in 2-D Xiangmin Jiao SUNY Stony Brook Xiangmin Jiao Finite Element Methods 1 / 18 Outline 1 Boundary

More information

4. Analysis of heat conduction

4. Analysis of heat conduction 4. Analysis of heat conduction John Richard Thome 11 mars 2008 John Richard Thome (LTCM - SGM - EPFL) Heat transfer - Conduction 11 mars 2008 1 / 47 4.1 The well-posed problem Before we go further with

More information

3 Generation and diffusion of vorticity

3 Generation and diffusion of vorticity Version date: March 22, 21 1 3 Generation and diffusion of vorticity 3.1 The vorticity equation We start from Navier Stokes: u t + u u = 1 ρ p + ν 2 u 1) where we have not included a term describing a

More information

Numerical Methods. Equations and Partial Fractions. Jaesung Lee

Numerical Methods. Equations and Partial Fractions. Jaesung Lee Numerical Methods Equations and Partial Fractions Jaesung Lee Solving linear equations Solving linear equations Introduction Many problems in engineering reduce to the solution of an equation or a set

More information

Heat and Mass Transfer Prof. S.P. Sukhatme Department of Mechanical Engineering Indian Institute of Technology, Bombay

Heat and Mass Transfer Prof. S.P. Sukhatme Department of Mechanical Engineering Indian Institute of Technology, Bombay Heat and Mass Transfer Prof. S.P. Sukhatme Department of Mechanical Engineering Indian Institute of Technology, Bombay Lecture No. 18 Forced Convection-1 Welcome. We now begin our study of forced convection

More information

Name: Instructor: Lecture time: TA: Section time:

Name: Instructor: Lecture time: TA: Section time: Math 222 Final May 11, 29 Name: Instructor: Lecture time: TA: Section time: INSTRUCTIONS READ THIS NOW This test has 1 problems on 16 pages worth a total of 2 points. Look over your test package right

More information

Physics 2B. Lecture 24B. Gauss 10 Deutsche Mark

Physics 2B. Lecture 24B. Gauss 10 Deutsche Mark Physics 2B Lecture 24B Gauss 10 Deutsche Mark Electric Flux Flux is the amount of something that flows through a given area. Electric flux, Φ E, measures the amount of electric field lines that passes

More information

Lecture 3: Vectors. Any set of numbers that transform under a rotation the same way that a point in space does is called a vector.

Lecture 3: Vectors. Any set of numbers that transform under a rotation the same way that a point in space does is called a vector. Lecture 3: Vectors Any set of numbers that transform under a rotation the same way that a point in space does is called a vector i.e., A = λ A i ij j j In earlier courses, you may have learned that a vector

More information

REVIEW: The Matching Method Algorithm

REVIEW: The Matching Method Algorithm Lecture 26: Numerov Algorithm for Solving the Time-Independent Schrödinger Equation 1 REVIEW: The Matching Method Algorithm Need for a more general method The shooting method for solving the time-independent

More information

1 Introduction to MATLAB

1 Introduction to MATLAB L3 - December 015 Solving PDEs numerically (Reports due Thursday Dec 3rd, carolinemuller13@gmail.com) In this project, we will see various methods for solving Partial Differential Equations (PDEs) using

More information

Chapter 3. Stability theory for zonal flows :formulation

Chapter 3. Stability theory for zonal flows :formulation Chapter 3. Stability theory for zonal flows :formulation 3.1 Introduction Although flows in the atmosphere and ocean are never strictly zonal major currents are nearly so and the simplifications springing

More information

4 Divergence theorem and its consequences

4 Divergence theorem and its consequences Tel Aviv University, 205/6 Analysis-IV 65 4 Divergence theorem and its consequences 4a Divergence and flux................. 65 4b Piecewise smooth case............... 67 4c Divergence of gradient: Laplacian........

More information

FINITE TIME BLOW-UP FOR A DYADIC MODEL OF THE EULER EQUATIONS

FINITE TIME BLOW-UP FOR A DYADIC MODEL OF THE EULER EQUATIONS TRANSACTIONS OF THE AMERICAN MATHEMATICAL SOCIETY Volume 357, Number 2, Pages 695 708 S 0002-9947(04)03532-9 Article electronically published on March 12, 2004 FINITE TIME BLOW-UP FOR A DYADIC MODEL OF

More information

Project 4: Navier-Stokes Solution to Driven Cavity and Channel Flow Conditions

Project 4: Navier-Stokes Solution to Driven Cavity and Channel Flow Conditions Project 4: Navier-Stokes Solution to Driven Cavity and Channel Flow Conditions R. S. Sellers MAE 5440, Computational Fluid Dynamics Utah State University, Department of Mechanical and Aerospace Engineering

More information

Lecture 1: Introduction to Linear and Non-Linear Waves

Lecture 1: Introduction to Linear and Non-Linear Waves Lecture 1: Introduction to Linear and Non-Linear Waves Lecturer: Harvey Segur. Write-up: Michael Bates June 15, 2009 1 Introduction to Water Waves 1.1 Motivation and Basic Properties There are many types

More information

Sourabh V. Apte. 308 Rogers Hall

Sourabh V. Apte. 308 Rogers Hall Sourabh V. Apte 308 Rogers Hall sva@engr.orst.edu 1 Topics Quick overview of Fluid properties, units Hydrostatic forces Conservation laws (mass, momentum, energy) Flow through pipes (friction loss, Moody

More information

Kinetic Theory. T.R. Lemberger, Feb Calculation of Pressure for an Ideal Gas. Area, A.

Kinetic Theory. T.R. Lemberger, Feb Calculation of Pressure for an Ideal Gas. Area, A. Kinetic Theory. T.R. Lemberger, Feb. 2007 In the simplest model, the equilibrium distribution of gas particle velocities is this: all particles move with the same speed, c. The equipartition theorem requires:

More information

Turbulence Modeling I!

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

More information

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

P3317 HW from Lecture 15 and Recitation 8

P3317 HW from Lecture 15 and Recitation 8 P3317 HW from Lecture 15 and Recitation 8 Due Oct 23, 218 Problem 1. Variational Energy of Helium Here we will estimate the ground state energy of Helium. Helium has two electrons circling around a nucleus

More information

CHAPTER 4 BOUNDARY LAYER FLOW APPLICATION TO EXTERNAL FLOW

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

More information

Lecture 38 Insulated Boundary Conditions

Lecture 38 Insulated Boundary Conditions Lecture 38 Insulated Boundary Conditions Insulation In many of the previous sections we have considered fixed boundary conditions, i.e. u(0) = a, u(l) = b. We implemented these simply by assigning u j

More information

Info. No lecture on Thursday in a week (March 17) PSet back tonight

Info. No lecture on Thursday in a week (March 17) PSet back tonight Lecture 0 8.086 Info No lecture on Thursday in a week (March 7) PSet back tonight Nonlinear transport & conservation laws What if transport becomes nonlinear? Remember: Nonlinear transport A first attempt

More information

Math background. Physics. Simulation. Related phenomena. Frontiers in graphics. Rigid fluids

Math background. Physics. Simulation. Related phenomena. Frontiers in graphics. Rigid fluids Fluid dynamics Math background Physics Simulation Related phenomena Frontiers in graphics Rigid fluids Fields Domain Ω R2 Scalar field f :Ω R Vector field f : Ω R2 Types of derivatives Derivatives measure

More information

[#1] R 3 bracket for the spherical pendulum

[#1] R 3 bracket for the spherical pendulum .. Holm Tuesday 11 January 2011 Solutions to MSc Enhanced Coursework for MA16 1 M3/4A16 MSc Enhanced Coursework arryl Holm Solutions Tuesday 11 January 2011 [#1] R 3 bracket for the spherical pendulum

More information

Interphase Mass Transfer see Handout. At equilibrium a species will distribute (or partition ) between two phases.

Interphase Mass Transfer see Handout. At equilibrium a species will distribute (or partition ) between two phases. Interphase Mass Transfer see Handout At equilibrium a species will distribute (or partition ) between two phases. Examples: 1. oxygen (species) will partition between air (gas phase) and water (liquid

More information

JMBC Computational Fluid Dynamics I Exercises by A.E.P. Veldman

JMBC Computational Fluid Dynamics I Exercises by A.E.P. Veldman JMBC Computational Fluid Dynamics I Exercises by A.E.P. Veldman The exercises will be carried out on PC s in the practicum rooms. Several (Matlab and Fortran) files are required. How these can be obtained

More information

Lecture 8. Instructor: Haipeng Luo

Lecture 8. Instructor: Haipeng Luo Lecture 8 Instructor: Haipeng Luo Boosting and AdaBoost In this lecture we discuss the connection between boosting and online learning. Boosting is not only one of the most fundamental theories in machine

More information

Fluid Dynamics for Ocean and Environmental Engineering Homework #2 Viscous Flow

Fluid Dynamics for Ocean and Environmental Engineering Homework #2 Viscous Flow OCEN 678-600 Fluid Dynamics for Ocean and Environmental Engineering Homework #2 Viscous Flow Date distributed : 9.18.2005 Date due : 9.29.2005 at 5:00 pm Return your solution either in class or in my mail

More information

Mathematical Notes for E&M Gradient, Divergence, and Curl

Mathematical Notes for E&M Gradient, Divergence, and Curl Mathematical Notes for E&M Gradient, Divergence, and Curl In these notes I explain the differential operators gradient, divergence, and curl (also known as rotor), the relations between them, the integral

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

Math 1080: Numerical Linear Algebra Chapter 4, Iterative Methods

Math 1080: Numerical Linear Algebra Chapter 4, Iterative Methods Math 1080: Numerical Linear Algebra Chapter 4, Iterative Methods M. M. Sussman sussmanm@math.pitt.edu Office Hours: MW 1:45PM-2:45PM, Thack 622 March 2015 1 / 70 Topics Introduction to Iterative Methods

More information

1 Introduction to Governing Equations 2 1a Methodology... 2

1 Introduction to Governing Equations 2 1a Methodology... 2 Contents 1 Introduction to Governing Equations 2 1a Methodology............................ 2 2 Equation of State 2 2a Mean and Turbulent Parts...................... 3 2b Reynolds Averaging.........................

More information

Boosting. Ryan Tibshirani Data Mining: / April Optional reading: ISL 8.2, ESL , 10.7, 10.13

Boosting. Ryan Tibshirani Data Mining: / April Optional reading: ISL 8.2, ESL , 10.7, 10.13 Boosting Ryan Tibshirani Data Mining: 36-462/36-662 April 25 2013 Optional reading: ISL 8.2, ESL 10.1 10.4, 10.7, 10.13 1 Reminder: classification trees Suppose that we are given training data (x i, y

More information

Class Meeting # 2: The Diffusion (aka Heat) Equation

Class Meeting # 2: The Diffusion (aka Heat) Equation MATH 8.52 COURSE NOTES - CLASS MEETING # 2 8.52 Introduction to PDEs, Fall 20 Professor: Jared Speck Class Meeting # 2: The Diffusion (aka Heat) Equation The heat equation for a function u(, x (.0.). Introduction

More information

SOE3213/4: CFD Lecture 3

SOE3213/4: CFD Lecture 3 CFD { SOE323/4: CFD Lecture 3 @u x @t @u y @t @u z @t r:u = 0 () + r:(uu x ) = + r:(uu y ) = + r:(uu z ) = @x @y @z + r 2 u x (2) + r 2 u y (3) + r 2 u z (4) Transport equation form, with source @x Two

More information

Shape Optimization Tutorial

Shape Optimization Tutorial Shape Optimization Tutorial By Stephan Schmidt Exercise 1. The first exercise is to familiarise with Python and FEniCS. We can use the built-in FEniCS tutorial to implement a small solver for the Laplacian

More information

Computational Fluid Dynamics Prof. Dr. Suman Chakraborty Department of Mechanical Engineering Indian Institute of Technology, Kharagpur

Computational Fluid Dynamics Prof. Dr. Suman Chakraborty Department of Mechanical Engineering Indian Institute of Technology, Kharagpur Computational Fluid Dynamics Prof. Dr. Suman Chakraborty Department of Mechanical Engineering Indian Institute of Technology, Kharagpur Lecture No. # 02 Conservation of Mass and Momentum: Continuity and

More information

Burgers equation - a first look at fluid mechanics and non-linear partial differential equations

Burgers equation - a first look at fluid mechanics and non-linear partial differential equations Burgers equation - a first look at fluid mechanics and non-linear partial differential equations In this assignment you will solve Burgers equation, which is useo model for example gas dynamics anraffic

More information

CS 6820 Fall 2014 Lectures, October 3-20, 2014

CS 6820 Fall 2014 Lectures, October 3-20, 2014 Analysis of Algorithms Linear Programming Notes CS 6820 Fall 2014 Lectures, October 3-20, 2014 1 Linear programming The linear programming (LP) problem is the following optimization problem. We are given

More information

Numerical Solution of Laplace Equation By Gilberto E. Urroz, October 2004

Numerical Solution of Laplace Equation By Gilberto E. Urroz, October 2004 Numerical Solution of Laplace Equation By Gilberto E. Urroz, October 004 Laplace equation governs a variety of equilibrium physical phenomena such as temperature distribution in solids, electrostatics,

More information

Chapter 13. Eddy Diffusivity

Chapter 13. Eddy Diffusivity Chapter 13 Eddy Diffusivity Glenn introduced the mean field approximation of turbulence in two-layer quasigesotrophic turbulence. In that approximation one must solve the zonally averaged equations for

More information

Applications in Fluid Mechanics

Applications in Fluid Mechanics CHAPTER 8 Applications in Fluid 8.1 INTRODUCTION The general topic of fluid mechanics encompasses a wide range of problems of interest in engineering applications. The most basic definition of a fluid

More information

of Friction in Fluids Dept. of Earth & Clim. Sci., SFSU

of Friction in Fluids Dept. of Earth & Clim. Sci., SFSU Summary. Shear is the gradient of velocity in a direction normal to the velocity. In the presence of shear, collisions among molecules in random motion tend to transfer momentum down-shear (from faster

More information

Before we look at numerical methods, it is important to understand the types of equations we will be dealing with.

Before we look at numerical methods, it is important to understand the types of equations we will be dealing with. Chapter 1. Partial Differential Equations (PDEs) Required Readings: Chapter of Tannehill et al (text book) Chapter 1 of Lapidus and Pinder (Numerical Solution of Partial Differential Equations in Science

More information

Finite volume method for CFD

Finite volume method for CFD Finite volume method for CFD Indo-German Winter Academy-2007 Ankit Khandelwal B-tech III year, Civil Engineering IIT Roorkee Course #2 (Numerical methods and simulation of engineering Problems) Mentor:

More information

Chapter 1 Mathematical Foundations

Chapter 1 Mathematical Foundations Computational Electromagnetics; Chapter 1 1 Chapter 1 Mathematical Foundations 1.1 Maxwell s Equations Electromagnetic phenomena can be described by the electric field E, the electric induction D, the

More information

n v molecules will pass per unit time through the area from left to

n v molecules will pass per unit time through the area from left to 3 iscosity and Heat Conduction in Gas Dynamics Equations of One-Dimensional Gas Flow The dissipative processes - viscosity (internal friction) and heat conduction - are connected with existence of molecular

More information

12 The Heat equation in one spatial dimension: Simple explicit method and Stability analysis

12 The Heat equation in one spatial dimension: Simple explicit method and Stability analysis ATH 337, by T. Lakoba, University of Vermont 113 12 The Heat equation in one spatial dimension: Simple explicit method and Stability analysis 12.1 Formulation of the IBVP and the minimax property of its

More information