Solution Methods. Steady State Diffusion Equation. Lecture 04

Size: px
Start display at page:

Download "Solution Methods. Steady State Diffusion Equation. Lecture 04"

Transcription

1 Solution Methods Steady State Diffusion Equation Lecture 04 1

2 Solution methods Focus on finite volume method. Background of finite volume method. Discretization example. General solution method. Convergence. Accuracy and numerical diffusion. Pressure velocity coupling. Segregated versus coupled solver methods. Multigrid solver. Summary.

3 Overview of numerical methods Many CFD techniques exist. The most common in commercially available CFD programs are: The finite volume method has the broadest applicability (~80%). Finite element (~15%). Here we will focus on the finite volume method. There are certainly many other approaches (5%), including: Finite difference method (FDM). Finite element method (FEM). Spectral method. Boundary element method (BEM). Vorticity based methods. Lattice gas/lattice Boltzmann. And more!

4 Finite difference method (FDM) Historically, the oldest of the three. Techniques published as early as 1910 by L. F. Richardson. Seminal paper by Courant, Fredrichson and Lewy (1928) derived stability criteria for explicit time stepping. First ever numerical solution: flow over a circular cylinder by Thom (1933). Scientific American article by Harlow and Fromm (1965) clearly and publicly expresses the idea of computer experiments for the first time and CFD is born!! Advantage: easy to implement. Disadvantages: restricted to simple grids and does not conserve momentum, energy, and mass on coarse grids. 4

5 Finite difference: basic methodology The domain is discretized into a series of grid points. A structured (ijk) mesh is required. The governing equations (in differential form) are discretized (converted to algebraic form). First and second derivatives are approximated by truncated Taylor series expansions. The resulting set of linear algebraic equations is solved either iteratively or simultaneously.

6 Taylor Series: central finite difference method Subtract: Central difference formula 2 nd order accurate

7 Finite element method (FEM) Earliest use was by Courant (1943) for solving a torsion problem. Clough (1960) gave the method its name. Method was refined greatly in the 60 s and 70 s, mostly for analyzing structural mechanics problem. FEM analysis of fluid flow was developed in the mid- to late 70 s. Advantages: highest accuracy on coarse grids. Excellent for diffusion dominated problems (viscous flow) and viscous, free surface problems. Disadvantages: slow for large problems and not well suited for turbulent flow.

8 Finite volume method (FVM) First well-documented use was by Evans and Harlow (1957) at Los Alamos and Gentry, Martin and Daley (1966). Advantage: Was attractive because while variables may not be continuously differentiable across shocks and other discontinuities; mass, momentum and energy are always conserved. FVM enjoys an advantage in memory use and speed for very large problems, higher speed flows, turbulent flows, and source term dominated flows (like combustion). Late 70 s, early 80 s saw development of body-fitted grids. By early 90 s, unstructured grid methods had appeared. Advantages: basic FV control volume balance does not limit cell shape; mass, momentum, energy conserved even on coarse grids; efficient, iterative solvers well developed. Disadvantages: false diffusion when simple numerics are used. 7

9 Finite volume: basic methodology Divide the domain into control volumes. Integrate the differential equation over the control volume and apply the divergence theorem. To evaluate derivative terms, values at the control volume faces are needed: have to make an assumption about how the value varies. Result is a set of linear algebraic equations: one for each control volume. Solve iteratively or simultaneously.

10 Cells and nodes Using finite volume method, the solution domain is subdivided into a finite number of small control volumes (cells) by a grid. The grid defines the boundaries of the control volumes while the computational node lies at the center of the control volume. The advantage of FVM is that the integral conservation is satisfied exactly over the control volume. 9

11 Typical control volume The net flux through the control volume boundary is the sum of integrals over the four control volume faces (six in 3D). The control volumes do not overlap. The value of the integrand is not available at the control volume faces and is determined by interpolation. 10

12 The Finite Volume Method for Diffusion Problems

13 Finite Volume method Consider the 1D diffusion (conduction) equation with source term S Another form, where is the diffusion coefficient and S is the source term. Boundary values of at points A and B are prescribed. An example of this type of process, one-dimensional heat conduction in a rod.

14 Step 1: Grid generation The first step in the finite volume method is to divide the domain into discrete control volumes. Place a number of nodal points in the space between A and B. The boundaries (or faces) of control volumes are positioned mid-way between adjacent nodes. Thus each node is surrounded by a control volume or cell. It is common practice to set up control volumes near the edge of the domain in such a way that the physical boundaries coincide with the control volume boundaries. A general nodal point is identified by P and its neighbours in a one-dimensional geometry, the nodes to the west and east, are identified by W and E respectively. The west side face of the control volume is referred to by 'w' and the east side control volume face by e. The distances between the nodes W and P, and between nodes P and E, are identified by x WP and x PE respectively. Similarly the distances between face w and point P and between P and face e are denoted by x wp and x Pe The control volume width is x = x we

15 Step 2: Discretisation The key step of the finite volume method is the integration of the governing equation (or equations) over a control volume to yield a discretised equation at its nodal point P. Integrate over the control volume, from west to east face = 0 Here A is the cross-sectional area of the control volume face, V is the volume and S is the average value of source S over the control volume. It is a very attractive feature of the finite volume method that the discretised equation has a clear physical interpretation. Above equation states that the diffusive flux of leaving the east face minus the diffusive flux of entering the west face is equal to the generation of, i.e. it constitutes a balance equation for over the control volume.

16 Step 2: Discretisation In order to derive useful forms of the discretised equations, the interface diffusion coefficient and the gradient d /dx at east ( e ) and west ('w') are required. The values of the property and the diffusion coefficient are defined and evaluated at nodal points. To calculate gradients (and hence fluxes) at the control volume faces an approximate distribution of properties between nodal points is used. Linear approximations seem to be the obvious and simplest way of calculating interface values and the gradients. This practice is called central differencing. In a uniform grid linearly interpolated values for e and w are given by And the diffusive flux terms are evaluated as

17 Step 2: Discretisation In practical situations, the source term S may be a function of the dependent variable. In such cases the finite volume method approximates the source term by means of a linear form: Therefore, equation become Rearranging, Identifying the coefficients of W and E as A W and A E and the coefficient of P as A P, the above equation can be written as Where, Discretised form of diffusion equation

18 Step 3: Solution of equations Discretised equations of the form above must be set up at each of the nodal points in order to solve a problem. For control volumes that are adjacent to the domain boundaries the general discretised equation above is modified to incorporate boundary conditions. The resulting system of linear algebraic equations is then solved to obtain the distribution of the property at nodal points. Any suitable matrix solution technique may be used Matrix result into tridiagonal systems. TDMA is used.

19 Worked examples: one-dimensional steady state diffusion Consider the problem of source-free heat conduction in an insulated rod whose ends are maintained at constant temperatures of 100 C and 500 C respectively. The onedimensional problem sketched in figure below is governed by equation given below. Calculate the steady state temperature distribution in the rod using Finite Volume Method and compare the results with exact analytical solution. Thermal conductivity k equals 1000 W/m/K, cross-sectional area A is 10 x 10-3 m 2, use dx = 0.1 m (1)

20 Solution Divide the length of the rod into five equal control volumes as shown in Figure below. This gives dx = 0.1 m. The grid consists of five nodes. For each one of nodes 2, 3 and 4 temperature values to the east and west are available as nodal values. Consequently, discretised equations can be readily written for control volumes surrounding these nodes: The thermal conductivity (k e = k w = k), node spacing ( x) and cross-sectional area (A e = A W = A) are constants. Therefore the discretised equation for nodal points 2, 3 and 4 is

21 Solution With, S U and S P are zero in this case since there is no source term in the governing equation Nodes 1 and 5 are boundary nodes, and therefore require special attention. Integration of equation (1) over the control volume surrounding point 1 gives (2) Re-arrange, (3)

22 Solution Comparing equation 3 with equation 4 it can be easily identified that the fixed temperature boundary condition enters the calculation as a source term (S U + S P T P ) with S U = (2kA/ x)t A and Sp = -2kA/ x and that the link to the (west) boundary side has been suppressed by setting coefficient a W to zero. (4) (3) Equation 3 may be cast in the same linear form to yield the discretised equation for boundary node 1: With,

23 Solution The control volume surrounding node 5 can be treated in a similar manner. Its discretised equation is given by Re-arrange, The discretised equation for boundary node 5 is Where,

24 Solution The discretisation process has yielded one equation for each of the nodal points 1 to 5. Substitution of numerical values gives ka/ x = 100 and the coefficients of each discretised equation can easily be worked out. Their values are given in Table The resulting set of algebraic equations for this example is

25 Solution This set of equations can be re-arranged as For T A = 100 and T B = 500 the solution can obtained by using, for example, Gaussian elimination: The exact solution is a linear distribution between the specified boundary temperatures: T = 800x Figure shows that the exact solution and the numerical results coincide.

26 Solution

27 Assignment 5 Page 92, CFD Book by Versteeg Heat conduction with source term Figure shows a large plate of thickness L = 2 cm with constant thermal conductivity k = 0.5 W/m/K and uniform heat generation q = 1000 kw/m 3. The faces A and B are at temperatures of 100 C and 200 C respectively. Assuming that the dimensions in the y- and z-directions are so large that temperature gradients are significant in the x-direction only, calculate the steady state temperature distribution using Finite volume Method. Compare the numerical result with the analytical solution. The governing equation is 1. Solve for 5, 10 and 15 nodes 2. Compare the results

28 Assignment 6 Shown in Figure below is a cylindrical fin with uniform cross-sectional area A. The base is at a temperature of 100 C (Tb) and the end is insulated. The fin is exposed to an ambient temperature of 20 C. One-dimensional heat transfer in this situation is governed by where h is the convective heat transfer coefficient, P the perimeter, k the thermal conductivity of the material and T the ambient temperature. Calculate the temperature distribution along the fin and compare the results with the analytical solution given by where n 2 = hp/(ka), L is the length of the fin and x the distance along the fin. Data: L = 1 m, hp/{ka) = 25 m -2 (note ka is constant). Solve for 5, 10 and 15 nodes Compare the results

29 Finite volume method for two-dimensional diffusion problems The methodology used in deriving discretised equations in the one-dimensional case can be easily extended to two-dimensional problems. Two-dimensional grid used for the discretisation

30 Finite volume method for two-dimensional diffusion problems When the above equation is integrated over the control volume we obtain (5) As before this equation represents the balance of the generation of in a control volume and the fluxes through its cell faces. Using the approximations we can write expressions for the flux through control volume faces:

31 Finite volume method for two-dimensional diffusion problems By substituting the above expressions into equation 5 we obtain When the source term is represented in linearised form S V = S U + S P P, the equation can be re-arranged as

32 Finite volume method for two-dimensional diffusion problems Above equation is now cast in the general discretised equation form for interior nodes: Where,

33 Finite volume method for two-dimensional diffusion problems We obtain the distribution of the property in a given two-dimensional situation by writing above discretised equations at each grid node of the subdivided domain. At the boundaries where the temperatures or fluxes are known the discretised equations are modified to incorporate boundary conditions. The boundary side coefficient is set to zero (cutting the link with the boundary) and the flux crossing the boundary is introduced as a source which is appended to any existing S U and S P terms. Subsequently, the resulting set of equations is solved to obtain the twodimensional distribution of the property.

34 Finite volume method for three-dimensional diffusion problems Steady state diffusion in a three-dimensional situation is governed by A cell or control volume in three dimensions and neighboring nodes

35 Finite volume method for three-dimensional diffusion problems Integration of equation above over the control volume shown gives Putting the values at control faces (as in 2D case), we have

36 Finite volume method for three-dimensional diffusion problems Rearranging the coefficients, we have: where Boundary conditions can be introduced by cutting links with the appropriate face(s) and modifying the source term as described earlier

37 General approach In the previous example we saw how the species transport equation could be discretized as a linear equation that can be solved iteratively for all cells in the domain. This is the general approach to solving partial differential equations used in CFD. It is done for all conserved variables (momentum, species, energy, etc.). For the conservation equation for variable φ, the following steps are taken: Integration of conservation equation in each cell. Calculation of face values in terms of cell-centered values. Collection of like terms. The result is the following discretization equation (with nb denoting cell neighbors of cell P):

38 Guiding Principles Freedom of choice gives rise to a variety of discretization. As the number of grid points increased, all formulations are expected to give the same solution. However, an additional requirements is imposed that will enable us to narrow down the number of acceptable formulations. We shall require that even the coarse grid solution should always have Physically realistic behavior Overall balance

39 Guiding Principles Physically realistic behavior A realistic behavior should have the same qualitative trend as the exact variation Example: In heat conduction without source no temperature can lie outside the range of temperature established by the boundary temperature Conservation The requirement of overall balance implies integral conservation over the whole calculation domain heat flux, mass flow rates, momentum fluxes must correctly be balanced in overall for any grid size- not just for a finer grid Constraint Constraint of physical realism and overall balance will be used to guide our choices of profile assumptions and related practices-on the basis of these practice we will develop some basic rule that will enable us to discriminate between available formulations and to invent new ones

40 Four Basic Rules-(1/4) Consistency at control volume faces-same flux expression at the faces common to neighboring CVs

41 Four Basic Rules-(2/4) All coefficients must have same sign say positive. Implies that if neighbor goes up, P also goes up If an increase in E must lead to an increase in P, it follows that a E and a P must have same sign

42 Four Basic Rules-(2/4) But there are numerous formulations that frequently violates this rule. Usually, the consequence is a physically unrealistic solution. The presence of a negative neighbor coefficient can lead to the situation in which an increase in a boundary temperature causes the temperature at the adjacent grid point to decrease.

43 Four Basic Rules-(3/4)

44 Four Basic Rules-(4/4)

45 Four Basic Rules-(4/4)

46 End

Solution Methods. Steady convection-diffusion equation. Lecture 05

Solution Methods. Steady convection-diffusion equation. Lecture 05 Solution Methods Steady convection-diffusion equation Lecture 05 1 Navier-Stokes equation Suggested reading: Gauss divergence theorem Integral form The key step of the finite volume method is to integrate

More information

5. FVM discretization and Solution Procedure

5. FVM discretization and Solution Procedure 5. FVM discretization and Solution Procedure 1. The fluid domain is divided into a finite number of control volumes (cells of a computational grid). 2. Integral form of the conservation equations are discretized

More information

Discretization of Convection Diffusion type equation

Discretization of Convection Diffusion type equation Discretization of Convection Diffusion type equation 10 th Indo German Winter Academy 2011 By, Rajesh Sridhar, Indian Institute of Technology Madras Guides: Prof. Vivek V. Buwa Prof. Suman Chakraborty

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

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

Module 2: Introduction to Finite Volume Method Lecture 14: The Lecture deals with: The Basic Technique. Objectives_template

Module 2: Introduction to Finite Volume Method Lecture 14: The Lecture deals with: The Basic Technique. Objectives_template The Lecture deals with: The Basic Technique file:///d /chitra/nptel_phase2/mechanical/cfd/lecture14/14_1.htm[6/20/2012 4:40:30 PM] The Basic Technique We have introduced the finite difference method. In

More information

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

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

More information

One Dimensional Convection: Interpolation Models for CFD

One Dimensional Convection: Interpolation Models for CFD One Dimensional Convection: Interpolation Models for CFD ME 448/548 Notes Gerald Recktenwald Portland State University Department of Mechanical Engineering gerry@pdx.edu ME 448/548: 1D Convection-Diffusion

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

A finite-volume algorithm for all speed flows

A finite-volume algorithm for all speed flows A finite-volume algorithm for all speed flows F. Moukalled and M. Darwish American University of Beirut, Faculty of Engineering & Architecture, Mechanical Engineering Department, P.O.Box 11-0236, Beirut,

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. #12 Fundamentals of Discretization: Finite Volume Method

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

Essay 4. Numerical Solutions of the Equations of Heat Transfer and Fluid Flow

Essay 4. Numerical Solutions of the Equations of Heat Transfer and Fluid Flow Essay 4 Numerical Solutions of the Equations of Heat Transfer and Fluid Flow 4.1 Introduction In Essay 3, it was shown that heat conduction is governed by a partial differential equation. It will also

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

Introduction to Heat and Mass Transfer. Week 7

Introduction to Heat and Mass Transfer. Week 7 Introduction to Heat and Mass Transfer Week 7 Example Solution Technique Using either finite difference method or finite volume method, we end up with a set of simultaneous algebraic equations in terms

More information

Numerical Solution Techniques in Mechanical and Aerospace Engineering

Numerical Solution Techniques in Mechanical and Aerospace Engineering Numerical Solution Techniques in Mechanical and Aerospace Engineering Chunlei Liang LECTURE 3 Solvers of linear algebraic equations 3.1. Outline of Lecture Finite-difference method for a 2D elliptic PDE

More information

arxiv: v1 [physics.comp-ph] 10 Aug 2015

arxiv: v1 [physics.comp-ph] 10 Aug 2015 Numerical experiments on the efficiency of local grid refinement based on truncation error estimates Alexandros Syrakos a,, Georgios Efthimiou a, John G. Bartzis a, Apostolos Goulas b arxiv:1508.02345v1

More information

FINITE-VOLUME SOLUTION OF DIFFUSION EQUATION AND APPLICATION TO MODEL PROBLEMS

FINITE-VOLUME SOLUTION OF DIFFUSION EQUATION AND APPLICATION TO MODEL PROBLEMS IJRET: International Journal of Research in Engineering and Technology eissn: 39-63 pissn: 3-738 FINITE-VOLUME SOLUTION OF DIFFUSION EQUATION AND APPLICATION TO MODEL PROBLEMS Asish Mitra Reviewer: Heat

More information

AN UNCERTAINTY ESTIMATION EXAMPLE FOR BACKWARD FACING STEP CFD SIMULATION. Abstract

AN UNCERTAINTY ESTIMATION EXAMPLE FOR BACKWARD FACING STEP CFD SIMULATION. Abstract nd Workshop on CFD Uncertainty Analysis - Lisbon, 19th and 0th October 006 AN UNCERTAINTY ESTIMATION EXAMPLE FOR BACKWARD FACING STEP CFD SIMULATION Alfredo Iranzo 1, Jesús Valle, Ignacio Trejo 3, Jerónimo

More information

HEAT TRANSFER FROM FINNED SURFACES

HEAT TRANSFER FROM FINNED SURFACES Fundamentals of Thermal-Fluid Sciences, 3rd Edition Yunus A. Cengel, Robert H. Turner, John M. Cimbala McGraw-Hill, 2008 HEAT TRANSFER FROM FINNED SURFACES Mehmet Kanoglu Copyright The McGraw-Hill Companies,

More information

Chapter 5. The Finite Volume Method for Convection-Diffusion Problems. The steady convection-diffusion equation is

Chapter 5. The Finite Volume Method for Convection-Diffusion Problems. The steady convection-diffusion equation is Chapter 5 The Finite Volume Method for Convection-Diffusion Problems Prepared by: Prof. Dr. I. Sezai Eastern Mediterranean University Mechanical Engineering Department Introduction The steady convection-diffusion

More information

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

Computational Fluid Dynamics Prof. Dr. SumanChakraborty Department of Mechanical Engineering Indian Institute of Technology, Kharagpur Computational Fluid Dynamics Prof. Dr. SumanChakraborty Department of Mechanical Engineering Indian Institute of Technology, Kharagpur Lecture No. #11 Fundamentals of Discretization: Finite Difference

More information

Computation of Unsteady Flows With Moving Grids

Computation of Unsteady Flows With Moving Grids Computation of Unsteady Flows With Moving Grids Milovan Perić CoMeT Continuum Mechanics Technologies GmbH milovan@continuummechanicstechnologies.de Unsteady Flows With Moving Boundaries, I Unsteady flows

More information

Lecture 12: Finite Elements

Lecture 12: Finite Elements Materials Science & Metallurgy Part III Course M6 Computation of Phase Diagrams H. K. D. H. Bhadeshia Lecture 2: Finite Elements In finite element analysis, functions of continuous quantities such as temperature

More information

Solution of the Two-Dimensional Steady State Heat Conduction using the Finite Volume Method

Solution of the Two-Dimensional Steady State Heat Conduction using the Finite Volume Method Ninth International Conference on Computational Fluid Dynamics (ICCFD9), Istanbul, Turkey, July 11-15, 2016 ICCFD9-0113 Solution of the Two-Dimensional Steady State Heat Conduction using the Finite Volume

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

Computation of Incompressible Flows: SIMPLE and related Algorithms

Computation of Incompressible Flows: SIMPLE and related Algorithms Computation of Incompressible Flows: SIMPLE and related Algorithms Milovan Perić CoMeT Continuum Mechanics Technologies GmbH milovan@continuummechanicstechnologies.de SIMPLE-Algorithm I - - - Consider

More information

1. INTRODUCTION TO CFD SPRING 2018

1. INTRODUCTION TO CFD SPRING 2018 1. INTRODUCTION TO CFD SPRING 018 1.1 What is computational fluid dynamics? 1. Basic principles of CFD 1.3 Stages in a CFD simulation 1.4 Fluid-flow equations 1.5 The main discretisation methods Appendices

More information

CRITERIA FOR SELECTION OF FEM MODELS.

CRITERIA FOR SELECTION OF FEM MODELS. CRITERIA FOR SELECTION OF FEM MODELS. Prof. P. C.Vasani,Applied Mechanics Department, L. D. College of Engineering,Ahmedabad- 380015 Ph.(079) 7486320 [R] E-mail:pcv-im@eth.net 1. Criteria for Convergence.

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

1. INTRODUCTION TO CFD SPRING 2019

1. INTRODUCTION TO CFD SPRING 2019 1. INTRODUCTION TO CFD SPRING 2019 1.1 What is computational fluid dynamics? 1.2 Basic principles of CFD 1.3 Stages in a CFD simulation 1.4 Fluid-flow equations 1.5 The main discretisation methods Appendices

More information

This chapter focuses on the study of the numerical approximation of threedimensional

This chapter focuses on the study of the numerical approximation of threedimensional 6 CHAPTER 6: NUMERICAL OPTIMISATION OF CONJUGATE HEAT TRANSFER IN COOLING CHANNELS WITH DIFFERENT CROSS-SECTIONAL SHAPES 3, 4 6.1. INTRODUCTION This chapter focuses on the study of the numerical approximation

More information

CFD Analysis On Thermal Energy Storage In Phase Change Materials Using High Temperature Solution

CFD Analysis On Thermal Energy Storage In Phase Change Materials Using High Temperature Solution CFD Analysis On Thermal Energy Storage In Phase Change Materials Using High Temperature Solution Santosh Chavan 1, M. R. Nagaraj 2 1 PG Student, Thermal Power Engineering, PDA College of Engineering, Gulbarga-585102,

More information

Mathematics Qualifying Exam Study Material

Mathematics Qualifying Exam Study Material Mathematics Qualifying Exam Study Material The candidate is expected to have a thorough understanding of engineering mathematics topics. These topics are listed below for clarification. Not all instructors

More information

Introduction to numerical simulation of fluid flows

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

More information

This section develops numerically and analytically the geometric optimisation of

This section develops numerically and analytically the geometric optimisation of 7 CHAPTER 7: MATHEMATICAL OPTIMISATION OF LAMINAR-FORCED CONVECTION HEAT TRANSFER THROUGH A VASCULARISED SOLID WITH COOLING CHANNELS 5 7.1. INTRODUCTION This section develops numerically and analytically

More information

Draft Notes ME 608 Numerical Methods in Heat, Mass, and Momentum Transfer

Draft Notes ME 608 Numerical Methods in Heat, Mass, and Momentum Transfer Draft Notes ME 608 Numerical Methods in Heat, Mass, and Momentum Transfer Instructor: Jayathi Y. Murthy School of Mechanical Engineering Purdue University Spring 00 c 1998 J.Y. Murthy and S.R. Mathur.

More information

qxbxg. That is, the heat rate within the object is everywhere constant. From Fourier s

qxbxg. That is, the heat rate within the object is everywhere constant. From Fourier s PROBLEM.1 KNOWN: Steady-state, one-dimensional heat conduction through an axisymmetric shape. FIND: Sketch temperature distribution and explain shape of curve. ASSUMPTIONS: (1) Steady-state, one-dimensional

More information

Turbulent Boundary Layers & Turbulence Models. Lecture 09

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

More information

VALIDATION OF ACCURACY AND STABILITY OF NUMERICAL SIMULATION FOR 2-D HEAT TRANSFER SYSTEM BY AN ENTROPY PRODUCTION APPROACH

VALIDATION OF ACCURACY AND STABILITY OF NUMERICAL SIMULATION FOR 2-D HEAT TRANSFER SYSTEM BY AN ENTROPY PRODUCTION APPROACH Brohi, A. A., et al.: Validation of Accuracy and Stability of Numerical Simulation for... THERMAL SCIENCE: Year 017, Vol. 1, Suppl. 1, pp. S97-S104 S97 VALIDATION OF ACCURACY AND STABILITY OF NUMERICAL

More information

MAE 598 Project #1 Jeremiah Dwight

MAE 598 Project #1 Jeremiah Dwight MAE 598 Project #1 Jeremiah Dwight OVERVIEW A simple hot water tank, illustrated in Figures 1 through 3 below, consists of a main cylindrical tank and two small side pipes for the inlet and outlet. All

More information

Multigrid Methods and their application in CFD

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

More information

Chapter 7. Three Dimensional Modelling of Buoyancy-Driven Displacement Ventilation: Point Source

Chapter 7. Three Dimensional Modelling of Buoyancy-Driven Displacement Ventilation: Point Source Chapter 7 Three Dimensional Modelling of Buoyancy-Driven Displacement Ventilation: Point Source 135 7. Three Dimensional Modelling of Buoyancy- Driven Displacement Ventilation: Point Source 7.1 Preamble

More information

Finite Difference Methods (FDMs) 1

Finite Difference Methods (FDMs) 1 Finite Difference Methods (FDMs) 1 1 st - order Approxima9on Recall Taylor series expansion: Forward difference: Backward difference: Central difference: 2 nd - order Approxima9on Forward difference: Backward

More information

We are IntechOpen, the world s leading publisher of Open Access books Built by scientists, for scientists. International authors and editors

We are IntechOpen, the world s leading publisher of Open Access books Built by scientists, for scientists. International authors and editors We are IntechOpen, the world s leading publisher of Open Access books Built by scientists, for scientists 4,000 116,000 120M Open access books available International authors and editors Downloads Our

More information

Due Tuesday, November 23 nd, 12:00 midnight

Due Tuesday, November 23 nd, 12:00 midnight Due Tuesday, November 23 nd, 12:00 midnight This challenging but very rewarding homework is considering the finite element analysis of advection-diffusion and incompressible fluid flow problems. Problem

More information

Numerical Solution Techniques in Mechanical and Aerospace Engineering

Numerical Solution Techniques in Mechanical and Aerospace Engineering Numerical Solution Techniques in Mechanical and Aerospace Engineering Chunlei Liang LECTURE 9 Finite Volume method II 9.1. Outline of Lecture Conservation property of Finite Volume method Apply FVM to

More information

Project #1 Internal flow with thermal convection

Project #1 Internal flow with thermal convection Project #1 Internal flow with thermal convection MAE 494/598, Fall 2017, Project 1 (20 points) Hard copy of report is due at the start of class on the due date. The rules on collaboration will be released

More information

The Finite Difference Method

The Finite Difference Method Chapter 5. The Finite Difference Method This chapter derives the finite difference equations that are used in the conduction analyses in the next chapter and the techniques that are used to overcome computational

More information

CFD in Heat Transfer Equipment Professor Bengt Sunden Division of Heat Transfer Department of Energy Sciences Lund University

CFD in Heat Transfer Equipment Professor Bengt Sunden Division of Heat Transfer Department of Energy Sciences Lund University CFD in Heat Transfer Equipment Professor Bengt Sunden Division of Heat Transfer Department of Energy Sciences Lund University email: bengt.sunden@energy.lth.se CFD? CFD = Computational Fluid Dynamics;

More information

The Finite Volume Mesh

The Finite Volume Mesh FMIA F Moukalled L Mangani M Darwish An Advanced Introduction with OpenFOAM and Matlab This textbook explores both the theoretical foundation of the Finite Volume Method (FVM) and its applications in Computational

More information

Method of Weighted Residual Approach for Thermal Performance Evaluation of a Circular Pin fin: Galerkin Finite element Approach

Method of Weighted Residual Approach for Thermal Performance Evaluation of a Circular Pin fin: Galerkin Finite element Approach ISSN (Print): 2347-671 (An ISO 3297: 27 Certified Organization) Vol. 6, Issue 4, April 217 Method of Weighted Residual Approach for Thermal Performance Evaluation of a Circular Pin fin: Galerkin Finite

More information

1D Heat equation and a finite-difference solver

1D Heat equation and a finite-difference solver 1D Heat equation and a finite-difference solver Guillaume Riflet MARETEC IST 1 The advection-diffusion equation The original concept applied to a property within a control volume from which is derived

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

Chapter 6. Finite Element Method. Literature: (tiny selection from an enormous number of publications)

Chapter 6. Finite Element Method. Literature: (tiny selection from an enormous number of publications) Chapter 6 Finite Element Method Literature: (tiny selection from an enormous number of publications) K.J. Bathe, Finite Element procedures, 2nd edition, Pearson 2014 (1043 pages, comprehensive). Available

More information

Partial Differential Equations

Partial Differential Equations Partial Differential Equations Introduction Deng Li Discretization Methods Chunfang Chen, Danny Thorne, Adam Zornes CS521 Feb.,7, 2006 What do You Stand For? A PDE is a Partial Differential Equation This

More information

Tutorial for the heated pipe with constant fluid properties in STAR-CCM+

Tutorial for the heated pipe with constant fluid properties in STAR-CCM+ Tutorial for the heated pipe with constant fluid properties in STAR-CCM+ For performing this tutorial, it is necessary to have already studied the tutorial on the upward bend. In fact, after getting abilities

More information

FLUID FLOW AND HEAT TRANSFER INVESTIGATION OF PERFORATED HEAT SINK UNDER MIXED CONVECTION 1 Mr. Shardul R Kulkarni, 2 Prof.S.Y.

FLUID FLOW AND HEAT TRANSFER INVESTIGATION OF PERFORATED HEAT SINK UNDER MIXED CONVECTION 1 Mr. Shardul R Kulkarni, 2 Prof.S.Y. FLUID FLOW AND HEAT TRANSFER INVESTIGATION OF PERFORATED HEAT SINK UNDER MIXED CONVECTION 1 Mr. Shardul R Kulkarni, 2 Prof.S.Y.Bhosale 1 Research scholar, 2 Head of department & Asst professor Department

More information

Study of Forced and Free convection in Lid driven cavity problem

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

More information

On A Comparison of Numerical Solution Methods for General Transport Equation on Cylindrical Coordinates

On A Comparison of Numerical Solution Methods for General Transport Equation on Cylindrical Coordinates Appl. Math. Inf. Sci. 11 No. 2 433-439 (2017) 433 Applied Mathematics & Information Sciences An International Journal http://dx.doi.org/10.18576/amis/110211 On A Comparison of Numerical Solution Methods

More information

University of Illinois at Urbana-Champaign College of Engineering

University of Illinois at Urbana-Champaign College of Engineering University of Illinois at Urbana-Champaign College of Engineering CEE 570 Finite Element Methods (in Solid and Structural Mechanics) Spring Semester 03 Quiz # April 8, 03 Name: SOUTION ID#: PS.: A the

More information

Documentation of the Solutions to the SFPE Heat Transfer Verification Cases

Documentation of the Solutions to the SFPE Heat Transfer Verification Cases Documentation of the Solutions to the SFPE Heat Transfer Verification Cases Prepared by a Task Group of the SFPE Standards Making Committee on Predicting the Thermal Performance of Fire Resistive Assemblies

More information

MATHEMATICAL RELATIONSHIP BETWEEN GRID AND LOW PECLET NUMBERS FOR THE SOLUTION OF CONVECTION-DIFFUSION EQUATION

MATHEMATICAL RELATIONSHIP BETWEEN GRID AND LOW PECLET NUMBERS FOR THE SOLUTION OF CONVECTION-DIFFUSION EQUATION 2006-2018 Asian Research Publishing Network (ARPN) All rights reserved wwwarpnjournalscom MATHEMATICAL RELATIONSHIP BETWEEN GRID AND LOW PECLET NUMBERS FOR THE SOLUTION OF CONVECTION-DIFFUSION EQUATION

More information

Available online at ScienceDirect. Procedia Engineering 90 (2014 )

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

More information

EINDHOVEN UNIVERSITY OF TECHNOLOGY Department of Mathematics and Computer Science. CASA-Report March2008

EINDHOVEN UNIVERSITY OF TECHNOLOGY Department of Mathematics and Computer Science. CASA-Report March2008 EINDHOVEN UNIVERSITY OF TECHNOLOGY Department of Mathematics and Computer Science CASA-Report 08-08 March2008 The complexe flux scheme for spherically symmetrie conservation laws by J.H.M. ten Thije Boonkkamp,

More information

Calculating equation coefficients

Calculating equation coefficients Fluid flow Calculating equation coefficients Construction Conservation Equation Surface Conservation Equation Fluid Conservation Equation needs flow estimation needs radiation and convection estimation

More information

Introduction to Heat and Mass Transfer. Week 8

Introduction to Heat and Mass Transfer. Week 8 Introduction to Heat and Mass Transfer Week 8 Next Topic Transient Conduction» Analytical Method Plane Wall Radial Systems Semi-infinite Solid Multidimensional Effects Analytical Method Lumped system analysis

More information

Simulation and improvement of the ventilation of a welding workshop using a Finite volume scheme code

Simulation and improvement of the ventilation of a welding workshop using a Finite volume scheme code 1 st. Annual (National) Conference on Industrial Ventilation-IVC2010 Feb 24-25, 2010, Sharif University of Technology, Tehran, Iran IVC2010 Simulation and improvement of the ventilation of a welding workshop

More information

Finite Element Analysis Prof. Dr. B. N. Rao Department of Civil Engineering Indian Institute of Technology, Madras. Module - 01 Lecture - 16

Finite Element Analysis Prof. Dr. B. N. Rao Department of Civil Engineering Indian Institute of Technology, Madras. Module - 01 Lecture - 16 Finite Element Analysis Prof. Dr. B. N. Rao Department of Civil Engineering Indian Institute of Technology, Madras Module - 01 Lecture - 16 In the last lectures, we have seen one-dimensional boundary value

More information

INTRODUCCION AL ANALISIS DE ELEMENTO FINITO (CAE / FEA)

INTRODUCCION AL ANALISIS DE ELEMENTO FINITO (CAE / FEA) INTRODUCCION AL ANALISIS DE ELEMENTO FINITO (CAE / FEA) Title 3 Column (full page) 2 Column What is Finite Element Analysis? 1 Column Half page The Finite Element Method The Finite Element Method (FEM)

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

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

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

Lecture 4.2 Finite Difference Approximation

Lecture 4.2 Finite Difference Approximation Lecture 4. Finite Difference Approimation 1 Discretization As stated in Lecture 1.0, there are three steps in numerically solving the differential equations. They are: 1. Discretization of the domain by

More information

CHAPTER 8: Thermal Analysis

CHAPTER 8: Thermal Analysis CHAPER 8: hermal Analysis hermal Analysis: calculation of temperatures in a solid body. Magnitude and direction of heat flow can also be calculated from temperature gradients in the body. Modes of heat

More information

Introduction to Heat and Mass Transfer. Week 5

Introduction to Heat and Mass Transfer. Week 5 Introduction to Heat and Mass Transfer Week 5 Critical Resistance Thermal resistances due to conduction and convection in radial systems behave differently Depending on application, we want to either maximize

More information

IMPLEMENTATION OF A PARALLEL AMG SOLVER

IMPLEMENTATION OF A PARALLEL AMG SOLVER IMPLEMENTATION OF A PARALLEL AMG SOLVER Tony Saad May 2005 http://tsaad.utsi.edu - tsaad@utsi.edu PLAN INTRODUCTION 2 min. MULTIGRID METHODS.. 3 min. PARALLEL IMPLEMENTATION PARTITIONING. 1 min. RENUMBERING...

More information

Chapter 5 HIGH ACCURACY CUBIC SPLINE APPROXIMATION FOR TWO DIMENSIONAL QUASI-LINEAR ELLIPTIC BOUNDARY VALUE PROBLEMS

Chapter 5 HIGH ACCURACY CUBIC SPLINE APPROXIMATION FOR TWO DIMENSIONAL QUASI-LINEAR ELLIPTIC BOUNDARY VALUE PROBLEMS Chapter 5 HIGH ACCURACY CUBIC SPLINE APPROXIMATION FOR TWO DIMENSIONAL QUASI-LINEAR ELLIPTIC BOUNDARY VALUE PROBLEMS 5.1 Introduction When a physical system depends on more than one variable a general

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

Additive Manufacturing Module 8

Additive Manufacturing Module 8 Additive Manufacturing Module 8 Spring 2015 Wenchao Zhou zhouw@uark.edu (479) 575-7250 The Department of Mechanical Engineering University of Arkansas, Fayetteville 1 Evaluating design https://www.youtube.com/watch?v=p

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

INTRODUCTION TO FINITE ELEMENT METHODS ON ELLIPTIC EQUATIONS LONG CHEN

INTRODUCTION TO FINITE ELEMENT METHODS ON ELLIPTIC EQUATIONS LONG CHEN INTROUCTION TO FINITE ELEMENT METHOS ON ELLIPTIC EQUATIONS LONG CHEN CONTENTS 1. Poisson Equation 1 2. Outline of Topics 3 2.1. Finite ifference Method 3 2.2. Finite Element Method 3 2.3. Finite Volume

More information

Integration, differentiation, and root finding. Phys 420/580 Lecture 7

Integration, differentiation, and root finding. Phys 420/580 Lecture 7 Integration, differentiation, and root finding Phys 420/580 Lecture 7 Numerical integration Compute an approximation to the definite integral I = b Find area under the curve in the interval Trapezoid Rule:

More information

On the transient modelling of impinging jets heat transfer. A practical approach

On the transient modelling of impinging jets heat transfer. A practical approach Turbulence, Heat and Mass Transfer 7 2012 Begell House, Inc. On the transient modelling of impinging jets heat transfer. A practical approach M. Bovo 1,2 and L. Davidson 1 1 Dept. of Applied Mechanics,

More information

Introduction. Finite and Spectral Element Methods Using MATLAB. Second Edition. C. Pozrikidis. University of Massachusetts Amherst, USA

Introduction. Finite and Spectral Element Methods Using MATLAB. Second Edition. C. Pozrikidis. University of Massachusetts Amherst, USA Introduction to Finite and Spectral Element Methods Using MATLAB Second Edition C. Pozrikidis University of Massachusetts Amherst, USA (g) CRC Press Taylor & Francis Group Boca Raton London New York CRC

More information

High Order Accurate Runge Kutta Nodal Discontinuous Galerkin Method for Numerical Solution of Linear Convection Equation

High Order Accurate Runge Kutta Nodal Discontinuous Galerkin Method for Numerical Solution of Linear Convection Equation High Order Accurate Runge Kutta Nodal Discontinuous Galerkin Method for Numerical Solution of Linear Convection Equation Faheem Ahmed, Fareed Ahmed, Yongheng Guo, Yong Yang Abstract This paper deals with

More information

Computation for the Backward Facing Step Test Case with an Open Source Code

Computation for the Backward Facing Step Test Case with an Open Source Code Computation for the Backward Facing Step Test Case with an Open Source Code G.B. Deng Equipe de Modélisation Numérique Laboratoire de Mécanique des Fluides Ecole Centrale de Nantes 1 Rue de la Noë, 44321

More information

Basics of Discretization Methods

Basics of Discretization Methods Basics of Discretization Methods In the finite difference approach, the continuous problem domain is discretized, so that the dependent variables are considered to exist only at discrete points. Derivatives

More information

Module 2 : Convection. Lecture 12 : Derivation of conservation of energy

Module 2 : Convection. Lecture 12 : Derivation of conservation of energy Module 2 : Convection Lecture 12 : Derivation of conservation of energy Objectives In this class: Start the derivation of conservation of energy. Utilize earlier derived mass and momentum equations for

More information

Computer Aided Design of Thermal Systems (ME648)

Computer Aided Design of Thermal Systems (ME648) Computer Aided Design of Thermal Systems (ME648) PG/Open Elective Credits: 3-0-0-9 Updated Syallabus: Introduction. Basic Considerations in Design. Modelling of Thermal Systems. Numerical Modelling and

More information

Calculation of Sound Fields in Flowing Media Using CAPA and Diffpack

Calculation of Sound Fields in Flowing Media Using CAPA and Diffpack Calculation of Sound Fields in Flowing Media Using CAPA and Diffpack H. Landes 1, M. Kaltenbacher 2, W. Rathmann 3, F. Vogel 3 1 WisSoft, 2 Univ. Erlangen 3 inutech GmbH Outline Introduction Sound in Flowing

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

Chapter 3: Steady Heat Conduction. Dr Ali Jawarneh Department of Mechanical Engineering Hashemite University

Chapter 3: Steady Heat Conduction. Dr Ali Jawarneh Department of Mechanical Engineering Hashemite University Chapter 3: Steady Heat Conduction Dr Ali Jawarneh Department of Mechanical Engineering Hashemite University Objectives When you finish studying this chapter, you should be able to: Understand the concept

More information

Open boundary conditions in numerical simulations of unsteady incompressible flow

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

More information

(Refer Slide Time: 01:11) So, in this particular module series we will focus on finite difference methods.

(Refer Slide Time: 01:11) So, in this particular module series we will focus on finite difference methods. Computational Electromagnetics and Applications Professor Krish Sankaran Indian Institute of Technology, Bombay Lecture 01 Finite Difference Methods - 1 Good Morning! So, welcome to the new lecture series

More information

16. Solution of elliptic partial differential equation

16. Solution of elliptic partial differential equation 16. Solution of elliptic partial differential equation Recall in the first lecture of this course. Assume you know how to use a computer to compute; but have not done any serious numerical computations

More information

A Hybrid Method for the Wave Equation. beilina

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

More information

Time stepping methods

Time stepping methods Time stepping methods ATHENS course: Introduction into Finite Elements Delft Institute of Applied Mathematics, TU Delft Matthias Möller (m.moller@tudelft.nl) 19 November 2014 M. Möller (DIAM@TUDelft) Time

More information

Convective Heat and Mass Transfer Prof. A. W. Date Department of Mechanical Engineering Indian Institute of Technology, Bombay

Convective Heat and Mass Transfer Prof. A. W. Date Department of Mechanical Engineering Indian Institute of Technology, Bombay Convective Heat and Mass Transfer Prof. A. W. Date Department of Mechanical Engineering Indian Institute of Technology, Bombay Module No.# 01 Lecture No. # 41 Natural Convection BLs So far we have considered

More information

Overview of Workshop on CFD Uncertainty Analysis. Patrick J. Roache. Executive Summary

Overview of Workshop on CFD Uncertainty Analysis. Patrick J. Roache. Executive Summary Workshop on CFD Uncertainty Analysis, Lisbon, October 2004 1 Overview of Workshop on CFD Uncertainty Analysis Patrick J. Roache Executive Summary The subject Workshop aimed at evaluation of CFD Uncertainty

More information