DUE: WEDS MARCH 26TH 2018

Size: px
Start display at page:

Download "DUE: WEDS MARCH 26TH 2018"

Transcription

1 HOMEWORK # 2: FINITE DIFFERENCES MAPPING AND TWO DIMENSIONAL PROBLEMS DUE: WEDS MARCH 26TH 2018 NOTE: In this homework, you will choose ONE of the following three questions to perform and hand-in. Each question has a bonus component. In the introduction of each question, the mathematical and coding difficulty is estimated. You may use this to determine which problem to solve. All questions have the same points allotment and the same amount of bonus points available. 1. Question # 1: Beam Bending Notes: This question is mathematically quite intense (most intense mathematical problem); however, it is less Matlab/computationally challenging as others since you already have worked on a code for beam bending for uniform node distributions. The mathematical challenge is due to deriving the 4th-order PDE mapping equation for the problem. You are encouraged to watch and work through the mapping Video 11 prior to starting this question ( In this question we revisit the beam bending problem to examine the impact of mesh/discretization refinement on the accuracy of the solution. The problem considers a constant cross section (I = const.) and constant material properties (E = const.) beam with a non-uniform mesh (varying dx) distribution along the length of the beam. The ultimate idea is to see whether clustering nodes at different locations along the beam can help to reduce the error when the same number of grid points are used in a beam bending calculation. The governing equation in the physical domain is the fourth order beam partial differential equation: (1) (EI) 4 w x 4 = q(x) With the following boundary conditions in the physical domain: (2) w w (x = 0) = 0; x (x = L) = 0; w(x = 0) = 0; w(x = L) = 0 x 1

2 2 DUE: WEDS MARCH 26TH 2018 Figure 1. The beam physical domain, and boundary conditions. In all but the bonus question, the following expression will be used to map from the computational space, ξ = [0, 1], to the physical space x: (3) x(ξ) = ( ( )) cos π 3ξ cos( π 8 ) cos( 7π 8 ) cos( π 8 ) The following properties will be assumed: The beam will have a constant cross section with I = m 4 The beam will have a length, L = 1m The beam is aluminum, E = Pa q(x) = 55 N/m. Please answer the following questions (hand-in a paper copy of answers, code will be uploaded via turnitin). (1) On separate graphs, plot the beam nodes in both the physical and computational spaces. (2) Calculate the first, second, third and fourth derivative of the mapping function with respect to the computational variable ξ, i.e., dx dξ, d2 x, d3 x dξ 2 dξ 3 and d4 x dξ 4. (3) Download and run the 1-D string mapping equation from the course website and modify this code to solve the string problem using the mapping expression for this question. Verify your implementation of this change is correct. (4) Derive the beam bending equation that will be used/solved in the computational domain for an arbitrary distribution of nodes in the physical domain. Please factor the final answer so that the equation has the form: A 4 w ξ 4 +B 3 w ξ 3 +C 2 w ξ 2 +D w ξ = q(ξ). NOTE: This question/equation derivation is the bulk of the effort for this question (and the equation is pretty messy) so, please take care.

3 HOMEWORK # 2: FINITE DIFFERENCES MAPPING AND TWO DIMENSIONAL PROBLEMS 3 (5) Please provide both the continuous and discrete representation for the boundary condition in computational domain (i.e. map the relevant boundary conditions to the computational domain). (6) Write the psuedo code for your Matlab solver clearly show how and where the domain mapping components will be incorporated into the code. (7) Write/modify (from HW#1) your beam bending computer code to solve this mapped problem (in Matlab or other programming language). Remember that the beam has constant cross section and constant material properties. (8) Show that your mapping version of the code matches theoretically calculated deflections (you can find the theoretical solution to this problem online or in a solid mechanics textbook) and calculate and plot the error convergence (clearly state what norm you are using and how you are computing the error). If you find that you are not getting the right answer and you suspect your mapping, you can try simpler polynomial mappings to isolate any potential bugs such as: x(ξ) = (ξ+0.5) , or x(ξ) = (ξ+0.5) , or x(ξ) = (ξ+0.5) (9) BONUS: Implement finite difference expressions to calculate the mapping derivatives/parameters and determine the best/optimal distribution of nodes in the physical space to minimize the beam bending max deflection error. Use 41 nodes to represent the beam.

4 4 DUE: WEDS MARCH 26TH Question # 2: Non-Rectangular Domain Membrane Deflection Notes: This question is moderate Matlab and moderate math difficulty. You are encouraged to watch the 2D finite difference mapping theory videos (Video 12 & 13) prior to starting this question. Note you may also want to download and use the code on the website as a starting point (note: this code is not perfect, so you ll need to understand it). In this question you will solve the transverse deflection of an annular and elliptical membrane due to uniform pressure loading. In the physical space, the governing differential equation is: (4) 2 w = 2 w x w = f(x, y) = 1 y2 The geometry is defined using the following equations: MajorAxis(ξ) = (MajorAxisMax MajorAxisMin)ξ + MajorAxisMin MinorAxis(ξ) = (MinorAxisMax MinorAxisMin)ξ + MinorAxisMin x(ξ, η) = M ajoraxis(ξ) cos(2πη) y(ξ, η) = M inoraxis(ξ) sin(2πη) The following diagram shows the geometry in the physical vs. computational spaces: Figure 2. The membrane mapping problem the elliptical bundt cake pan.

5 HOMEWORK # 2: FINITE DIFFERENCES MAPPING AND TWO DIMENSIONAL PROBLEMS 5 The boundary conditions are shown in figure 3. Dirichlet boundary conditions (deflection = 0, which can be mathematically expressed as: w(x, y) = 0) are applied to the outer boundaries of the domain. The top and bottom boundaries are such that continuity of the solution is applied there (a periodic boundary condition, w upper = w lower ). Figure 3. The membrane boundary conditions (physical and computational domains). Please answer the following questions (hand-in a paper copy of answers, code will be uploaded via turnitin). (1) Setup the computational domain in Matlab such that ξ = [0, 1] and η = [0, 1]. Show that when the mapping equations are applied that the computational domain maps to the correct physical domain (i.e., plot the mesh/vertices in the computational and physical spaces). (2) Determine the relevant expressions for the first and second derivatives of the mapping equations with respect to the computational domain variables. E.g.: dx dξ, d 2 x dξdη., etc. (3) Write the partial differential equation that will be solved in the computational domain to solve the physical membrane deflection problem. (4) Clearly present the relevant finite difference expressions (for the unknown membrane deflection terms) that will be used as well as draw an illustration of the nodal computational stencil for a point i, j inside the domain. (5) Clearly show the entries that will be inserted into row i of the matrix for a difference equation centered at node, i, j, inside the domain (not a boundary node). (6) Starting with the polar coordinates poisson equation, 2 w = 2 w + 1 w r 2 r r w = r 2 θ 2 1, derive/determine the analytical solution of the membrane deflection for a circular annular physical space with an inner radius, R inner = 1 and an outer radius,

6 6 DUE: WEDS MARCH 26TH 2018 R outer = 4. Plot the deflection as a function of the radial location in the annular section. Note: since the problem is axially symmetric, any dn dθ terms are zero. n (7) Write a psuedo code for solving the membrane problem in computational space for different annular domains defined by inner and outer ellipses. (8) Write your matlab code and check that it works. (9) Plot your error convergence based on the comparison of your computed solution to the analytical solution you derived. Clearly describe the calculation of the error so that it is clear what is being shown in the convergence plot. (10) Experiment: Assuming that the inner boundary of the domain is a unit radius circle (MajorAxisMin = 1 and MinorAxisMin = 1), and the outer major and minor radii vary, surf plot the maximum deflection of the membrane for different outer boundary major and minor axis radii (MajorAxisMax = [1.2, 1.4,..., 6] and MinorAxisMax = [1.2, 1.4,..., 6]). Use a mesh that has 41 nodes in the ξ and η directions. (11) Bonus: Rewrite the mapping portion of the code so that it uses finite difference expressions based on the computational vs. physical meshes to calculate the mapping. Run the same computations as the prior experiment with numerical mappings and show the error between the analytically and computationally calculated mappings.

7 HOMEWORK # 2: FINITE DIFFERENCES MAPPING AND TWO DIMENSIONAL PROBLEMS 7 3. Question # 3: Stokes or Creeping Flow in a Cavity 2-Dimensional Rectangular Grid Finite Differences Note : This problem is mathematically the easiest, but is likely the most challenging of the three from a Matlab coding perspective partly because of the staggered grids used as well as the PDE being s system of three equations. In this problem you are tasked to solve a classical viscous flow fluid dynamics problem the Stokes flow for a classical test case, the cavity driven flow. In a cavity driven flow the top boundary has a unit x-velocity while the other boundaries are set to have a no slip condition ( v = 0). The domain is assumed to have unit dimensions in each direction. A staggered grid is employed in the MAC method we use to solve this problem. This means it will be convenient to setup ghost nodes outside of the domain to help with prescribing boundary conditions at the actual boundary. This is especially relevant for the pressure values. Figure 4. The domain in which the Stokes flow will be solved. The fluid domain is shown in blue shading. The boundary conditions are shown. The governing equations for incompressible fluid dynamics are the incompressible Navier- Stokes equations. In this case, the system of three equations comprise the x and y

8 8 DUE: WEDS MARCH 26TH 2018 momentum equations and the continuity or conservation of mass equation: ( u ρ t + u u x + v u ) = P ( 2 ) y x + µ u x u (5) y 2 + f x ( v ρ t + u v x + v v ) = P ( 2 ) y y + µ v x v (6) y 2 + f y u (7) x + v = 0 y We will assume that the flow is steady and the viscous terms dominate flow behavior. When we simplify the Navier Stokes equations we arrive at the steady state Stokes or creeping flow equations which are described as a system of three linear PDEs: ( 2 ) u (8) µ + P (9) (10) µ x u y 2 ( 2 v x v y 2 ) + P y u x + v y x = f x = f y = 0 To simplify matters, we assume that the fluid has no volume forcing terms (f x = 0 and f y = 0). We also assume for simplicity that the viscosity µ = 0. The result is a slightly simpler system of partial differential equations: ( 2 ) (11) u x u y 2 + P x = 0 ( 2 ) v x v (12) y 2 + P = 0 y u (13) x + v = 0 y For this problem we use a Marker and Cell (MAC) finite difference equation approach to discretize the equations. The MAC method discretizes the velocities at the midpoints of cell faces and the pressure at the center of the cells as shown in figure 5. Based on these grids, the equations can be discretized using finite difference expressions as shown in figure 6 (based on the grid shown). The grid spacing is assumes to be uniform in all directions, i.e., x = y = h. The x-momentum equation once discretized becomes: (14) 4u i,j u i,j 1 u i,j+1 u i 1,j u i+1,j x 2 + p i,j p i,j 1 x = 0

9 HOMEWORK # 2: FINITE DIFFERENCES MAPPING AND TWO DIMENSIONAL PROBLEMS 9 Figure 5. The three different meshes or grids used in the MAC solution method. (left) the u-velocity (velocity in the x-direction) is determined at vertical midpoint locations of the base grid (center) The v-velocity (velocity in the y-direction) is determined at the horizontal midpoint locations of the base grid (right) The pressure is determined at the cell center locations. The result is a grid that is offset in each direction. The y-momentum equation becomes: (15) 4v i,j v i,j 1 v i,j+1 v i 1,j v i+1,j x 2 + p i+1,j p i,j x = 0 The continuity or conservation of mass equation is: (16) u i,j u i 1,j. + v i,j v i,j 1 x x The boundary conditions are applied with the assistance of the ghost nodes on the outside of the domain. = 0 Please answer the following questions (hand-in a paper copy of answers, code will be uploaded via turnitin). (1) Show/write/draw how you will relate the i, j index to the global node number to each discrete equation (i.e., each node of the u, v and p grids). Note, you may wish to number the nodes/equations such that they directly correspond to the equation rows in the A-Matrix. (2) Show/write/draw how/where each of the three governing equations will be assembled to form an A-matrix.

10 10 DUE: WEDS MARCH 26TH 2018 (3) Indicate how you will implement the boundary conditions. Note, you will need to prescribe the pressure at one point to be a known value - the suggestion is to set pressure equal to zero on one of the boundary nodes. (4) Write the pseudo code for this problem implementation. (5) Write the Matlab code and compare the results of the Matlab code to those shown in figure 7. (6) Demonstrate the error convergence for your code. What is the accuracy of your code with respect to the grid refinement? (7) Bonus: Modify your code to accommodate curved/stretched grids. Calculate the viscous flow around a circle. You may find it most convenient to simulate a half circle, ie. the top of bottom half of a circle. Compare your result with the theoretical solution for the Stokes flow over a sphere.

11 HOMEWORK # 2: FINITE DIFFERENCES MAPPING AND TWO DIMENSIONAL PROBLEMS 11 Figure 6. The three equations apply to the grids shown. (left) The x- momentum equation (center) The y-momentum equation (right) The conservation of mass equation.

12 12 DUE: WEDS MARCH 26TH 2018 Figure 7. The solution to the cavity driven stokes flow equation. (top left) The magnitude of velocity in the cavity (top right) The velocity field in the cavity (bottom left) The x-velocity as measured on the vertical centerline (bottom right) The y-velocity as measured on the horizontal centerline.

Numerical Methods for PDEs Homework 2

Numerical Methods for PDEs Homework 2 22.520 Numerical Methods for PDEs Homework 2 Instructor : Prof. D. Willis Email: david willis@uml.edu In this homework problem you will investigate finite difference methods on rectangular and nonrectangular

More information

Homework 4 in 5C1212; Part A: Incompressible Navier- Stokes, Finite Volume Methods

Homework 4 in 5C1212; Part A: Incompressible Navier- Stokes, Finite Volume Methods Homework 4 in 5C11; Part A: Incompressible Navier- Stokes, Finite Volume Methods Consider the incompressible Navier Stokes in two dimensions u x + v y = 0 u t + (u ) x + (uv) y + p x = 1 Re u + f (1) v

More information

CIV-E1060 Engineering Computation and Simulation Examination, December 12, 2017 / Niiranen

CIV-E1060 Engineering Computation and Simulation Examination, December 12, 2017 / Niiranen CIV-E16 Engineering Computation and Simulation Examination, December 12, 217 / Niiranen This examination consists of 3 problems rated by the standard scale 1...6. Problem 1 Let us consider a long and tall

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

The dependence of the cross-sectional shape on the hydraulic resistance of microchannels

The dependence of the cross-sectional shape on the hydraulic resistance of microchannels 3-weeks course report, s0973 The dependence of the cross-sectional shape on the hydraulic resistance of microchannels Hatim Azzouz a Supervisor: Niels Asger Mortensen and Henrik Bruus MIC Department of

More information

Two-Dimensional Unsteady Flow in a Lid Driven Cavity with Constant Density and Viscosity ME 412 Project 5

Two-Dimensional Unsteady Flow in a Lid Driven Cavity with Constant Density and Viscosity ME 412 Project 5 Two-Dimensional Unsteady Flow in a Lid Driven Cavity with Constant Density and Viscosity ME 412 Project 5 Jingwei Zhu May 14, 2014 Instructor: Surya Pratap Vanka 1 Project Description The objective of

More information

Block-Structured Adaptive Mesh Refinement

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

More information

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

Solving Differential Equations on 2-D Geometries with Matlab

Solving Differential Equations on 2-D Geometries with Matlab Solving Differential Equations on 2-D Geometries with Matlab Joshua Wall Drexel University Philadelphia, PA 19104 (Dated: April 28, 2014) I. INTRODUCTION Here we introduce the reader to solving partial

More information

MOMENTS OF INERTIA FOR AREAS, RADIUS OF GYRATION OF AN AREA, & MOMENTS OF INTERTIA BY INTEGRATION

MOMENTS OF INERTIA FOR AREAS, RADIUS OF GYRATION OF AN AREA, & MOMENTS OF INTERTIA BY INTEGRATION MOMENTS OF INERTIA FOR AREAS, RADIUS OF GYRATION OF AN AREA, & MOMENTS OF INTERTIA BY INTEGRATION Today s Objectives: Students will be able to: a) Define the moments of inertia (MoI) for an area. b) Determine

More information

Video 15: PDE Classification: Elliptic, Parabolic and Hyperbolic March Equations 11, / 20

Video 15: PDE Classification: Elliptic, Parabolic and Hyperbolic March Equations 11, / 20 Video 15: : Elliptic, Parabolic and Hyperbolic Equations March 11, 2015 Video 15: : Elliptic, Parabolic and Hyperbolic March Equations 11, 2015 1 / 20 Table of contents 1 Video 15: : Elliptic, Parabolic

More information

LEAST-SQUARES FINITE ELEMENT MODELS

LEAST-SQUARES FINITE ELEMENT MODELS LEAST-SQUARES FINITE ELEMENT MODELS General idea of the least-squares formulation applied to an abstract boundary-value problem Works of our group Application to Poisson s equation Application to flows

More information

14.1. Multiple Integration. Iterated Integrals and Area in the Plane. Iterated Integrals. Iterated Integrals. MAC2313 Calculus III - Chapter 14

14.1. Multiple Integration. Iterated Integrals and Area in the Plane. Iterated Integrals. Iterated Integrals. MAC2313 Calculus III - Chapter 14 14 Multiple Integration 14.1 Iterated Integrals and Area in the Plane Objectives Evaluate an iterated integral. Use an iterated integral to find the area of a plane region. Copyright Cengage Learning.

More information

Chapter 5 Structural Elements: The truss & beam elements

Chapter 5 Structural Elements: The truss & beam elements Institute of Structural Engineering Page 1 Chapter 5 Structural Elements: The truss & beam elements Institute of Structural Engineering Page 2 Chapter Goals Learn how to formulate the Finite Element Equations

More information

3 2 6 Solve the initial value problem u ( t) 3. a- If A has eigenvalues λ =, λ = 1 and corresponding eigenvectors 1

3 2 6 Solve the initial value problem u ( t) 3. a- If A has eigenvalues λ =, λ = 1 and corresponding eigenvectors 1 Math Problem a- If A has eigenvalues λ =, λ = 1 and corresponding eigenvectors 1 3 6 Solve the initial value problem u ( t) = Au( t) with u (0) =. 3 1 u 1 =, u 1 3 = b- True or false and why 1. if A is

More information

Problem Set 4 Issued: Wednesday, March 18, 2015 Due: Wednesday, April 8, 2015

Problem Set 4 Issued: Wednesday, March 18, 2015 Due: Wednesday, April 8, 2015 MASSACHUSETTS INSTITUTE OF TECHNOLOGY DEPARTMENT OF MECHANICAL ENGINEERING CAMBRIDGE, MASSACHUSETTS 0139.9 NUMERICAL FLUID MECHANICS SPRING 015 Problem Set 4 Issued: Wednesday, March 18, 015 Due: Wednesday,

More information

Shell Balances in Fluid Mechanics

Shell Balances in Fluid Mechanics Shell Balances in Fluid Mechanics R. Shankar Subramanian Department of Chemical and Biomolecular Engineering Clarkson University When fluid flow occurs in a single direction everywhere in a system, shell

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

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

Supplementary Information for Engineering and Analysis of Surface Interactions in a Microfluidic Herringbone Micromixer

Supplementary Information for Engineering and Analysis of Surface Interactions in a Microfluidic Herringbone Micromixer Supplementary Information for Engineering and Analysis of Surface Interactions in a Microfluidic Herringbone Micromixer Thomas P. Forbes and Jason G. Kralj National Institute of Standards and Technology,

More information

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

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

More information

Scientific Computing I

Scientific Computing I Scientific Computing I Module 8: An Introduction to Finite Element Methods Tobias Neckel Winter 2013/2014 Module 8: An Introduction to Finite Element Methods, Winter 2013/2014 1 Part I: Introduction to

More information

Lehrstuhl Informatik V. Lehrstuhl Informatik V. 1. solve weak form of PDE to reduce regularity properties. Lehrstuhl Informatik V

Lehrstuhl Informatik V. Lehrstuhl Informatik V. 1. solve weak form of PDE to reduce regularity properties. Lehrstuhl Informatik V Part I: Introduction to Finite Element Methods Scientific Computing I Module 8: An Introduction to Finite Element Methods Tobias Necel Winter 4/5 The Model Problem FEM Main Ingredients Wea Forms and Wea

More information

Introduction. J.M. Burgers Center Graduate Course CFD I January Least-Squares Spectral Element Methods

Introduction. J.M. Burgers Center Graduate Course CFD I January Least-Squares Spectral Element Methods Introduction In this workshop we will introduce you to the least-squares spectral element method. As you can see from the lecture notes, this method is a combination of the weak formulation derived from

More information

Due Tuesday, September 21 st, 12:00 midnight

Due Tuesday, September 21 st, 12:00 midnight Due Tuesday, September 21 st, 12:00 midnight The first problem discusses a plane truss with inclined supports. You will need to modify the MatLab software from homework 1. The next 4 problems consider

More information

x j r i V i,j+1/2 r Ci,j Ui+1/2,j U i-1/2,j Vi,j-1/2

x j r i V i,j+1/2 r Ci,j Ui+1/2,j U i-1/2,j Vi,j-1/2 Merging of drops to form bamboo waves Yuriko Y. Renardy and Jie Li Department of Mathematics and ICAM Virginia Polytechnic Institute and State University Blacksburg, VA -, U.S.A. May, Abstract Topological

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

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

1 Exercise: Linear, incompressible Stokes flow with FE

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

More information

CHAPTER THREE SYMMETRIC BENDING OF CIRCLE PLATES

CHAPTER THREE SYMMETRIC BENDING OF CIRCLE PLATES CHAPTER THREE SYMMETRIC BENDING OF CIRCLE PLATES * Governing equations in beam and plate bending ** Solution by superposition 1.1 From Beam Bending to Plate Bending 1.2 Governing Equations For Symmetric

More information

Motion in Two Dimensions: Centripetal Acceleration

Motion in Two Dimensions: Centripetal Acceleration Motion in Two Dimensions: Centripetal Acceleration Name: Group Members: Date: TA s Name: Apparatus: Rotating platform, long string, liquid accelerometer, meter stick, masking tape, stopwatch Objectives:

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

AMS subject classifications. Primary, 65N15, 65N30, 76D07; Secondary, 35B45, 35J50

AMS subject classifications. Primary, 65N15, 65N30, 76D07; Secondary, 35B45, 35J50 A SIMPLE FINITE ELEMENT METHOD FOR THE STOKES EQUATIONS LIN MU AND XIU YE Abstract. The goal of this paper is to introduce a simple finite element method to solve the Stokes equations. This method is in

More information

The purpose of this lecture is to present a few applications of conformal mappings in problems which arise in physics and engineering.

The purpose of this lecture is to present a few applications of conformal mappings in problems which arise in physics and engineering. Lecture 16 Applications of Conformal Mapping MATH-GA 451.001 Complex Variables The purpose of this lecture is to present a few applications of conformal mappings in problems which arise in physics and

More information

AREAS, RADIUS OF GYRATION

AREAS, RADIUS OF GYRATION Chapter 10 MOMENTS of INERTIA for AREAS, RADIUS OF GYRATION Today s Objectives: Students will be able to: a) Define the moments of inertia (MoI) for an area. b) Determine the MoI for an area by integration.

More information

Finite Element Method-Part II Isoparametric FE Formulation and some numerical examples Lecture 29 Smart and Micro Systems

Finite Element Method-Part II Isoparametric FE Formulation and some numerical examples Lecture 29 Smart and Micro Systems Finite Element Method-Part II Isoparametric FE Formulation and some numerical examples Lecture 29 Smart and Micro Systems Introduction Till now we dealt only with finite elements having straight edges.

More information

Game Physics. Game and Media Technology Master Program - Utrecht University. Dr. Nicolas Pronost

Game Physics. Game and Media Technology Master Program - Utrecht University. Dr. Nicolas Pronost Game and Media Technology Master Program - Utrecht University Dr. Nicolas Pronost Soft body physics Soft bodies In reality, objects are not purely rigid for some it is a good approximation but if you hit

More information

Fluid Dynamics Exercises and questions for the course

Fluid Dynamics Exercises and questions for the course Fluid Dynamics Exercises and questions for the course January 15, 2014 A two dimensional flow field characterised by the following velocity components in polar coordinates is called a free vortex: u r

More information

Semi-analytical solution of Poisson's equation in bounded domain

Semi-analytical solution of Poisson's equation in bounded domain Semi-analytical solution of Poisson's equation in bounded domain Author Song, Hao, Tao, L. Published 21 Journal Title ANZIAM Journal Copyright Statement 21 Australian Mathematical Society. The attached

More information

Solutions for the Practice Final - Math 23B, 2016

Solutions for the Practice Final - Math 23B, 2016 olutions for the Practice Final - Math B, 6 a. True. The area of a surface is given by the expression d, and since we have a parametrization φ x, y x, y, f x, y with φ, this expands as d T x T y da xy

More information

FINITE GRID SOLUTION FOR NON-RECTANGULAR PLATES

FINITE GRID SOLUTION FOR NON-RECTANGULAR PLATES th International Conference on Earthquake Geotechnical Engineering June 5-8, 7 Paper No. 11 FINITE GRID SOLUTION FOR NON-RECTANGULAR PLATES A.Halim KARAŞĐN 1, Polat GÜLKAN ABSTRACT Plates on elastic foundations

More information

Conic Sections and Polar Graphing Lab Part 1 - Circles

Conic Sections and Polar Graphing Lab Part 1 - Circles MAC 1114 Name Conic Sections and Polar Graphing Lab Part 1 - Circles 1. What is the standard equation for a circle with center at the origin and a radius of k? 3. Consider the circle x + y = 9. a. What

More information

A Simple Weak-Field Coupling Benchmark Test of the Electromagnetic-Thermal-Structural Solution Capabilities of LS-DYNA Using Parallel Current Wires

A Simple Weak-Field Coupling Benchmark Test of the Electromagnetic-Thermal-Structural Solution Capabilities of LS-DYNA Using Parallel Current Wires 13 th International LS-DYNA Users Conference Session: Electromagnetic A Simple Weak-Field Coupling Benchmark Test of the Electromagnetic-Thermal-Structural Solution Capabilities of LS-DYNA Using Parallel

More information

Numerical methods for PDEs FEM convergence, error estimates, piecewise polynomials

Numerical methods for PDEs FEM convergence, error estimates, piecewise polynomials Platzhalter für Bild, Bild auf Titelfolie hinter das Logo einsetzen Numerical methods for PDEs FEM convergence, error estimates, piecewise polynomials Dr. Noemi Friedman Contents of the course Fundamentals

More information

Math 175 Common Exam 2A Spring 2018

Math 175 Common Exam 2A Spring 2018 Math 175 Common Exam 2A Spring 2018 Part I: Short Form The first seven (7) pages are short answer. You don t need to show work. Partial credit will be rare and small. 1. (8 points) Suppose f(x) is a function

More information

Numerical methods for the Navier- Stokes equations

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

More information

Chapter 9: Differential Analysis

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

More information

Solution of Differential Equation by Finite Difference Method

Solution of Differential Equation by Finite Difference Method NUMERICAL ANALYSIS University of Babylon/ College of Engineering/ Mechanical Engineering Dep. Lecturer : Dr. Rafel Hekmat Class : 3 rd B.Sc Solution of Differential Equation by Finite Difference Method

More information

MAAE 2202 A. Come to the PASS workshop with your mock exam complete. During the workshop you can work with other students to review your work.

MAAE 2202 A. Come to the PASS workshop with your mock exam complete. During the workshop you can work with other students to review your work. It is most beneficial to you to write this mock final exam UNDER EXAM CONDITIONS. This means: Complete the exam in 3 hours. Work on your own. Keep your textbook closed. Attempt every question. After the

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

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

fluid mechanics as a prominent discipline of application for numerical

fluid mechanics as a prominent discipline of application for numerical 1. fluid mechanics as a prominent discipline of application for numerical simulations: experimental fluid mechanics: wind tunnel studies, laser Doppler anemometry, hot wire techniques,... theoretical fluid

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

Gauge finite element method for incompressible flows

Gauge finite element method for incompressible flows INTERNATIONAL JOURNAL FOR NUMERICAL METHODS IN FLUIDS Int. J. Numer. Meth. Fluids 2000; 34: 701 710 Gauge finite element method for incompressible flows Weinan E a, *,1 and Jian-Guo Liu b,2 a Courant Institute

More information

FREE BOUNDARY PROBLEMS IN FLUID MECHANICS

FREE BOUNDARY PROBLEMS IN FLUID MECHANICS FREE BOUNDARY PROBLEMS IN FLUID MECHANICS ANA MARIA SOANE AND ROUBEN ROSTAMIAN We consider a class of free boundary problems governed by the incompressible Navier-Stokes equations. Our objective is to

More information

Chapter 9: Differential Analysis of Fluid Flow

Chapter 9: Differential Analysis of Fluid Flow of Fluid Flow Objectives 1. Understand how the differential equations of mass and momentum conservation are derived. 2. Calculate the stream function and pressure field, and plot streamlines for a known

More information

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 2014 Quiz #2 April 14, 2014 Name: SOLUTION ID#: PS1.:

More information

MATH20411 PDEs and Vector Calculus B

MATH20411 PDEs and Vector Calculus B MATH2411 PDEs and Vector Calculus B Dr Stefan Güttel Acknowledgement The lecture notes and other course materials are based on notes provided by Dr Catherine Powell. SECTION 1: Introctory Material MATH2411

More information

Adaptive C1 Macroelements for Fourth Order and Divergence-Free Problems

Adaptive C1 Macroelements for Fourth Order and Divergence-Free Problems Adaptive C1 Macroelements for Fourth Order and Divergence-Free Problems Roy Stogner Computational Fluid Dynamics Lab Institute for Computational Engineering and Sciences University of Texas at Austin March

More information

LibMesh Experience and Usage

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

More information

Extending the Patched-Conic Approximation to the Restricted Four-Body Problem

Extending the Patched-Conic Approximation to the Restricted Four-Body Problem Monografías de la Real Academia de Ciencias de Zaragoza 3, 133 146, (6). Extending the Patched-Conic Approximation to the Restricted Four-Body Problem Thomas R. Reppert Department of Aerospace and Ocean

More information

Page 1. Neatly print your name: Signature: (Note that unsigned exams will be given a score of zero.)

Page 1. Neatly print your name: Signature: (Note that unsigned exams will be given a score of zero.) Page 1 Neatly print your name: Signature: (Note that unsigned exams will be given a score of zero.) Circle your lecture section (-1 point if not circled, or circled incorrectly): Prof. Vlachos Prof. Ardekani

More information

Analysis of Catalyst Support Ring in a pressure vessel based on ASME Section VIII Division 2 using ANSYS software

Analysis of Catalyst Support Ring in a pressure vessel based on ASME Section VIII Division 2 using ANSYS software IJSRD - International Journal for Scientific Research & Development Vol. 1, Issue 3, 2013 ISSN (online): 2321-0613 Analysis of Catalyst Support Ring in a pressure vessel based on ASME Section VIII Division

More information

NUMERICAL AND EXPERIMENTAL INVESTIGATION OF THE TEMPERATURE DISTRIBUTION INSIDE OIL-COOLED TRANSFORMER WINDINGS

NUMERICAL AND EXPERIMENTAL INVESTIGATION OF THE TEMPERATURE DISTRIBUTION INSIDE OIL-COOLED TRANSFORMER WINDINGS NUMERICAL AND EXPERIMENTAL INVESTIGATION OF THE TEMPERATURE DISTRIBUTION INSIDE OIL-COOLED TRANSFORMER WINDINGS N. Schmidt 1* and S. Tenbohlen 1 and S. Chen 2 and C. Breuer 3 1 University of Stuttgart,

More information

POTENTIAL THEORY AND HEAT CONDUCTION DIRICHLET S PROBLEM

POTENTIAL THEORY AND HEAT CONDUCTION DIRICHLET S PROBLEM Chapter 6 POTENTIAL THEORY AND HEAT CONDUCTION DIRICHLET S PROBLEM M. Ragheb 9/19/13 6.1 INTRODUCTION The solution of the Dirichlet problem is one of the easiest approaches to grasp using Monte Carlo methodologies.

More information

SOLUTIONS TO HOMEWORK ASSIGNMENT #2, Math 253

SOLUTIONS TO HOMEWORK ASSIGNMENT #2, Math 253 SOLUTIONS TO HOMEWORK ASSIGNMENT #, Math 5. Find the equation of a sphere if one of its diameters has end points (, 0, 5) and (5, 4, 7). The length of the diameter is (5 ) + ( 4 0) + (7 5) = =, so the

More information

Research Article. Slip flow and heat transfer through a rarefied nitrogen gas between two coaxial cylinders

Research Article. Slip flow and heat transfer through a rarefied nitrogen gas between two coaxial cylinders Available online wwwjocprcom Journal of Chemical and Pharmaceutical Research, 216, 8(8):495-51 Research Article ISSN : 975-7384 CODEN(USA) : JCPRC5 Slip flow and heat transfer through a rarefied nitrogen

More information

Design and Modeling of Fluid Power Systems ME 597/ABE Lecture 7

Design and Modeling of Fluid Power Systems ME 597/ABE Lecture 7 Systems ME 597/ABE 591 - Lecture 7 Dr. Monika Ivantysynova MAHA Professor Fluid Power Systems MAHA Fluid Power Research Center Purdue University Content of 6th lecture The lubricating gap as a basic design

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

PHY321 Homework Set 10

PHY321 Homework Set 10 PHY321 Homework Set 10 1. [5 pts] A small block of mass m slides without friction down a wedge-shaped block of mass M and of opening angle α. Thetriangular block itself slides along a horizontal floor,

More information

Scientific Computing I

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

More information

MATH 20B MIDTERM #2 REVIEW

MATH 20B MIDTERM #2 REVIEW MATH 20B MIDTERM #2 REVIEW FORMAT OF MIDTERM #2 The format will be the same as the practice midterms. There will be six main questions worth 0 points each. These questions will be similar to problems you

More information

ME 309 Fluid Mechanics Fall 2010 Exam 2 1A. 1B.

ME 309 Fluid Mechanics Fall 2010 Exam 2 1A. 1B. Fall 010 Exam 1A. 1B. Fall 010 Exam 1C. Water is flowing through a 180º bend. The inner and outer radii of the bend are 0.75 and 1.5 m, respectively. The velocity profile is approximated as C/r where C

More information

A finite difference Poisson solver for irregular geometries

A finite difference Poisson solver for irregular geometries ANZIAM J. 45 (E) ppc713 C728, 2004 C713 A finite difference Poisson solver for irregular geometries Z. Jomaa C. Macaskill (Received 8 August 2003, revised 21 January 2004) Abstract The motivation for this

More information

General elastic beam with an elastic foundation

General elastic beam with an elastic foundation General elastic beam with an elastic foundation Figure 1 shows a beam-column on an elastic foundation. The beam is connected to a continuous series of foundation springs. The other end of the foundation

More information

Riemann Integration. James K. Peterson. February 2, Department of Biological Sciences and Department of Mathematical Sciences Clemson University

Riemann Integration. James K. Peterson. February 2, Department of Biological Sciences and Department of Mathematical Sciences Clemson University Riemann Integration James K. Peterson Department of Biological Sciences and Department of Mathematical Sciences Clemson University February 2, 2017 Outline 1 Riemann Sums 2 Riemann Sums In MatLab 3 Graphing

More information

Orbital Mixing In Comsol Using Coriolis and Centrifugal Forces. Written by Shawn Lillie Supervised by Dr. Bruce Finlayson

Orbital Mixing In Comsol Using Coriolis and Centrifugal Forces. Written by Shawn Lillie Supervised by Dr. Bruce Finlayson Orbital Mixing In Comsol Using Coriolis and Centrifugal Forces Written by Shawn Lillie Supervised by Dr. Bruce Finlayson University of Washington Department of Chemical Engineering Undergraduate Research

More information

Practice Problems for Exam 3 (Solutions) 1. Let F(x, y) = xyi+(y 3x)j, and let C be the curve r(t) = ti+(3t t 2 )j for 0 t 2. Compute F dr.

Practice Problems for Exam 3 (Solutions) 1. Let F(x, y) = xyi+(y 3x)j, and let C be the curve r(t) = ti+(3t t 2 )j for 0 t 2. Compute F dr. 1. Let F(x, y) xyi+(y 3x)j, and let be the curve r(t) ti+(3t t 2 )j for t 2. ompute F dr. Solution. F dr b a 2 2 F(r(t)) r (t) dt t(3t t 2 ), 3t t 2 3t 1, 3 2t dt t 3 dt 1 2 4 t4 4. 2. Evaluate the line

More information

LibMesh Experience and Usage

LibMesh Experience and Usage LibMesh Experience and Usage John W. Peterson peterson@cfdlab.ae.utexas.edu Univ. of Texas at Austin January 12, 2007 1 Introduction 2 Weighted Residuals 3 Poisson Equation 4 Other Examples 5 Essential

More information

Classical Mechanics III (8.09) Fall 2014 Assignment 7

Classical Mechanics III (8.09) Fall 2014 Assignment 7 Classical Mechanics III (8.09) Fall 2014 Assignment 7 Massachusetts Institute of Technology Physics Department Due Wed. November 12, 2014 Mon. November 3, 2014 6:00pm (This assignment is due on the Wednesday

More information

Green s Theorem. MATH 311, Calculus III. J. Robert Buchanan. Fall Department of Mathematics. J. Robert Buchanan Green s Theorem

Green s Theorem. MATH 311, Calculus III. J. Robert Buchanan. Fall Department of Mathematics. J. Robert Buchanan Green s Theorem Green s Theorem MATH 311, alculus III J. obert Buchanan Department of Mathematics Fall 2011 Main Idea Main idea: the line integral around a positively oriented, simple closed curve is related to a double

More information

BEAM DEFLECTION THE ELASTIC CURVE

BEAM DEFLECTION THE ELASTIC CURVE BEAM DEFLECTION Samantha Ramirez THE ELASTIC CURVE The deflection diagram of the longitudinal axis that passes through the centroid of each cross-sectional area of a beam. Supports that apply a moment

More information

2012 MECHANICS OF SOLIDS

2012 MECHANICS OF SOLIDS R10 SET - 1 II B.Tech II Semester, Regular Examinations, April 2012 MECHANICS OF SOLIDS (Com. to ME, AME, MM) Time: 3 hours Max. Marks: 75 Answer any FIVE Questions All Questions carry Equal Marks ~~~~~~~~~~~~~~~~~~~~~~

More information

Finite Difference Methods for Boundary Value Problems

Finite Difference Methods for Boundary Value Problems Finite Difference Methods for Boundary Value Problems October 2, 2013 () Finite Differences October 2, 2013 1 / 52 Goals Learn steps to approximate BVPs using the Finite Difference Method Start with two-point

More information

Soft Bodies. Good approximation for hard ones. approximation breaks when objects break, or deform. Generalization: soft (deformable) bodies

Soft Bodies. Good approximation for hard ones. approximation breaks when objects break, or deform. Generalization: soft (deformable) bodies Soft-Body Physics Soft Bodies Realistic objects are not purely rigid. Good approximation for hard ones. approximation breaks when objects break, or deform. Generalization: soft (deformable) bodies Deformed

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

Riemann Integration. Outline. James K. Peterson. February 2, Riemann Sums. Riemann Sums In MatLab. Graphing Riemann Sums

Riemann Integration. Outline. James K. Peterson. February 2, Riemann Sums. Riemann Sums In MatLab. Graphing Riemann Sums Riemann Integration James K. Peterson Department of Biological Sciences and Department of Mathematical Sciences Clemson University February 2, 2017 Outline Riemann Sums Riemann Sums In MatLab Graphing

More information

(1:1) 1. The gauge formulation of the Navier-Stokes equation We start with the incompressible Navier-Stokes equation 8 >< >: u t +(u r)u + rp = 1 Re 4

(1:1) 1. The gauge formulation of the Navier-Stokes equation We start with the incompressible Navier-Stokes equation 8 >< >: u t +(u r)u + rp = 1 Re 4 Gauge Finite Element Method for Incompressible Flows Weinan E 1 Courant Institute of Mathematical Sciences New York, NY 10012 Jian-Guo Liu 2 Temple University Philadelphia, PA 19122 Abstract: We present

More information

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

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

More information

Solving Partial Differential Equations Numerically. Miklós Bergou with: Gary Miller, David Cardoze, Todd Phillips, Mark Olah

Solving Partial Differential Equations Numerically. Miklós Bergou with: Gary Miller, David Cardoze, Todd Phillips, Mark Olah Solving Partial Dierential Equations Numerically Miklós Bergou with: Gary Miller, David Cardoze, Todd Phillips, Mark Olah Overview What are partial dierential equations? How do we solve them? (Example)

More information

25.2. Applications of PDEs. Introduction. Prerequisites. Learning Outcomes

25.2. Applications of PDEs. Introduction. Prerequisites. Learning Outcomes Applications of PDEs 25.2 Introduction In this Section we discuss briefly some of the most important PDEs that arise in various branches of science and engineering. We shall see that some equations can

More information

A Simple Compact Fourth-Order Poisson Solver on Polar Geometry

A Simple Compact Fourth-Order Poisson Solver on Polar Geometry Journal of Computational Physics 182, 337 345 (2002) doi:10.1006/jcph.2002.7172 A Simple Compact Fourth-Order Poisson Solver on Polar Geometry Ming-Chih Lai Department of Applied Mathematics, National

More information

Bilinear Quadrilateral (Q4): CQUAD4 in GENESIS

Bilinear Quadrilateral (Q4): CQUAD4 in GENESIS Bilinear Quadrilateral (Q4): CQUAD4 in GENESIS The Q4 element has four nodes and eight nodal dof. The shape can be any quadrilateral; we ll concentrate on a rectangle now. The displacement field in terms

More information

You can learn more about the services offered by the teaching center by visiting

You can learn more about the services offered by the teaching center by visiting MAC 232 Exam 3 Review Spring 209 This review, produced by the Broward Teaching Center, contains a collection of questions which are representative of the type you may encounter on the exam. Other resources

More information

Review all the activities leading to Midterm 3. Review all the problems in the previous online homework sets (8+9+10).

Review all the activities leading to Midterm 3. Review all the problems in the previous online homework sets (8+9+10). MA109, Activity 34: Review (Sections 3.6+3.7+4.1+4.2+4.3) Date: Objective: Additional Assignments: To prepare for Midterm 3, make sure that you can solve the types of problems listed in Activities 33 and

More information

Marching on the BL equations

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

More information

Parabolic Flow in Parallel Plate Channel ME 412 Project 4

Parabolic Flow in Parallel Plate Channel ME 412 Project 4 Parabolic Flow in Parallel Plate Channel ME 412 Project 4 Jingwei Zhu April 12, 2014 Instructor: Surya Pratap Vanka 1 Project Description The objective of this project is to develop and apply a computer

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

Fast Direct Solver for Poisson Equation in a 2D Elliptical Domain

Fast Direct Solver for Poisson Equation in a 2D Elliptical Domain Fast Direct Solver for Poisson Equation in a 2D Elliptical Domain Ming-Chih Lai Department of Applied Mathematics National Chiao Tung University 1001, Ta Hsueh Road, Hsinchu 30050 Taiwan Received 14 October

More information

Numerical Solutions of Partial Differential Equations

Numerical Solutions of Partial Differential Equations Numerical Solutions of Partial Differential Equations Dr. Xiaozhou Li xiaozhouli@uestc.edu.cn School of Mathematical Sciences University of Electronic Science and Technology of China Introduction Overview

More information