Table of Contents. II. PDE classification II.1. Motivation and Examples. II.2. Classification. II.3. Well-posedness according to Hadamard

Size: px
Start display at page:

Download "Table of Contents. II. PDE classification II.1. Motivation and Examples. II.2. Classification. II.3. Well-posedness according to Hadamard"

Transcription

1 Table of Contents II. PDE classification II.. Motivation and Examples II.2. Classification II.3. Well-posedness according to Hadamard Chapter II (ContentChapterII)

2 Crashtest: Reality Simulation Ford Crown Victoria Removal of components Surface discretization Volume discretization complete model Result of simulation Chapter II (motivation eng) 2

3 Biomechanics msbm/, FE Crash Test Dummy Simulation of injuries after traffic accidents Left: Brain of a rat Right: Simulated deformation of the cortex caused by a traumatic brain injury Chapter II (motivation 2eng) 3

4 Fluid Mechanics: Virtual Wind Tunnel Wing surface Section of the 3D grid Pressure distribution Profile Chapter II (motivation 3eng) 4

5 Earthquake Simulation T. Furumura, Journal of the Earth Simulator 3, 25 Chapter II (motivation 4eng) 5

6 Structural mechanics: Stability of Buildings Chapter II (motivation 5eng) 6

7 Linear Elasticity Determine the deformation field u R d satisfying the Lamé equations divσ(u(x)) = f(x), for x Ω R d and additional boundary conditions on Γ := Ω. f(x) R d : density of volume forces σ(u) R d d : stress tensor σ(u) := λtr(ε(u))id+2µε(u) ε(u) R d d : strain tensor ε(u) := 2 ( u+( u) ) λ,µ R Lamé parameter which can be computed from the elasticity module E and the Poisson s ratio ν of the material. Chapter II (einleitung3eng) 7

8 Linear Elasticity History Cauchy made several contributions to the elasticity theory. For instance, he developed the Cauchy stress tensor of a cube which can completely describe the tension in one point of an elastic body. Augustin Cauchy ( ) Using the Cauchy number, one can draw conclusions about the similarity of elasticity of two bodies. The Cauchy number is the ratio of inertial forces to elastic forces when a body is subject to acoustic oscillations. Chapter II (einleitung39eng) 8

9 Lamé Parameters Plane Strain / Plane Stress In 3 dimensions (d=3): λ = Eν (+ν)( 2ν), µ = E 2(+ν) In 2 dimensions (d=2): Plane Strain λ = Eν (+ν)( 2ν), µ = E 2(+ν) Plane Stress λ = Eν ( ν 2 ), µ = E 2(+ν) The plain stress state is valid for modules with a constant thickness in one direction which is much smaller than the remaining dimensions. Chapter II (einleitung32eng) 9

10 Example Linear Elasticity Plane Strain Profile of a cantilever Force F on the upper side (Neumann data) fixed on the ground (Dirichlet data) Solve for deformation F Chapter II (einleitung33eng)

11 Example: Pressure on a Tube Plane Strain.2 Flow through a tube E = Nm 2, ν =.3, Inner radius r i =.m, Outer radius r a =.2m Pressure on the inside p = 6 Nm 2 Outer side fixed Solve for deformation x 3 Color: abs(u,v) Displacement: (u,v) Chapter II (einleitung34eng)

12 Navier Stokes Equation Navier Stokes equations are a system of second order partial differential equations (PDEs) composed of the momentum theorem and the continuity equation. Their main area of application lies within the fluid mechanics where they are used to describe the flows of liquids and gases. We want to determine the velocity field u R d, d {2,3}, and the pressure p R, satisfying the system of partial differential equations div(ν u)+ (u )u+ p = f div u = and additional boundary conditions (on Γ := Ω) in Ω R d. f(x) R d,x Ω: Body force ν > : Kinematic viscosity Chapter II (einleitung36eng) 2

13 Navier Stokes equations History Claude Navier ( ) The theorem of momentum for newtonian fluids, e.g. for water, was formulated by Navier and Stokes independent from each other during the 9 th century. Even though the equations were derived by Saint Venant two years before Stokes, the name Navier Stokes equations became established. To this day, there is no proof of the well-posedness of the general 3D Navier Stokes equations. George Stokes (89 93) Chapter II (einleitung38eng) 3

14 Navier Stokes equations Example Simulation of a turbulent flow using the Navier Stokes equations. The flow is depicted at the initial and the final stage of the simulation. Chapter II (einleitung37eng) 4

15 Classification A linear second order differential operator with invertible coefficient matrix A(x) L = n i,j= 2 a ij (x) + x i x j n i= b i (x) x i +c(x), A(x) := (a ij (x)) i,j n. is elliptic in x: All n eigenvalues of have the same sign. is parabolic in x: One eigenvalue equals. All other n eigenvalues have the same sign. Additionally, rank(a(x), b(x)) = n holds, with b(x) = (b (x),...,b n (x)) T. is hyperbolic in x: n eigenvalues have the same sign, the other eigenvalue has the opposite sign. The linear, second order PDE ist elliptic/parabolic/hyperbolic on Ω R n, (Ω open), if it is elliptic/parabolic/hyperbolic for all x Ω. Note that x i can be both a spatial and a temporal coordinate, i.e. n = 4 for a 3d and time-dependent problem. Chapter II (einleitung2eng) 5

16 Elliptic partial differential equations Prototype: Laplace operator = d i= 2 x 2 i, A =... Additionally, boundary data on the boundary Γ := Ω of the domain Ω R d need to be imposed:. Dirichlet boundary conditions: u = f in Ω, u = g on Γ 2. Neumann boundary conditions: u = f in Ω, 3. Robin boundary conditions: u = f in Ω, u n = p on Γ u +u = r on Γ n Chapter II (einleitung3eng) 6

17 Elliptic partial differential equations Dirichlet boundary conditions Dirichlet boundary value problem: u= f in Ω u= g on Γ := Ω Ω unit square (,) (,) f(x,y) = 2π 2 sin(2πx)sin(4πy) g(x,y) = exact solution u(x, y) = sin(2πx) sin(4πy) Chapter II (einleitung5eng) 7

18 Dirichlet boundary conditions - example Laplace operator Color: u Height: u Exact solution u(x, y) = sin(2πx) sin(4πy) of the dirichlet boundary value problem Chapter II (einleitung6eng) 8

19 Elliptic partial differential equations Neumann boundary conditions Neumann boundary value problem: Ω unit square (,) (,) u= f in Ω u = g on Γ := Ω n f(x,y) = ( 2x)y 2 (2y 3)+( 2y)x 2 (2x 3) g(x,y) = exact solution u(x,y) = 6 x2 (2x 3)y 2 (2y 3) Chapter II (einleitung8eng) 9

20 Neumann boundary conditions - example Compatibility condition Ω f dx = Ω gds Chapter II (einleitung9eng) 2

21 Elliptic partial differential equations Mixed boundary conditions Example u = in Ω u = on n on 2 on u = 3 on 4 on Chapter II (einleitung2eng) 2

22 Mixed boundary conditions - example Chapter II (einleitung2eng) 22

23 Elliptic partial differential equations Robin boundary conditions Robin boundary value problem: u n Ω unit square (,) (,) f(x,y) = g(x, y) = sin(2πx) cos(4πy) u= f in Ω +u= g on Γ := Ω Chapter II (einleitung22eng) 23

24 Robin boundary conditions - example Chapter II (einleitung23eng) 24

25 Parabolic differential equations Prototype: Heat equation L = t, A =... To obtain a solution u(t,x) for t t and x Ω R d, in addition to the boundary conditions, an initial condition is required: t u u =f for x Ω, t t, e.g. Dirichlet BC: u(t,x) = g(t) for x Γ D, t t, or Neumann BC: u n (t,x) = p(t) for x Γ N, t t, u(t,x) :=u (x) for x Ω Chapter II (einleitung4eng) 25

26 Parabolic differential equation Prototype: Heat transfer equation example t u u = f for x Ω, t t = Ω square (,) (,) f = u = on Ω initial condition u(t,x) = u (x) = { if x B.4 () else Chapter II (einleitung24eng) 26

27 Heat transfer equation - example t = t = t = t = The parabolic operator describes a diffusion process and yields a smooth solution. Local numerical oscillations are also smoothed out Chapter II (einleitung25eng) 27

28 Hyperbolic differential equations Prototype: Wave equation L = 2 t 2, A =... To obtain a solution u(t,x) for t t and x Ω R d, boundary conditions as well as initial conditions need to be imposed: Boundary conditions: Γ := Ω = Γ D Γ N with Γ N Γ D = u = g on Γ D, u n = p on Γ N for t t, Initial conditions: u(t,x) = u (x) and t u(t,x) = u (x) for x Ω. Chapter II (einleitung5eng) 28

29 Hyperbolic differential equations Prototype: Wave equation tt u u = for x Ω, t t = Ω square (,) (,) u = on the left and right boundary u n = on the upper and lower boundary Initial conditions u(t,x) = u (x) = arctan(cos( π 2 x )) t u (x) = u (x) = 3sin(πx)exp(sin( π 2 x 2)) Chapter II (einleitung26eng) 29

30 Wave equation - example t = t = t = t = The hyperbolic operator describes a wave propagation. Unfortunately, local numerical oscillations are propagated as well. Numerical solutions can be tricky and the methods must be robust. Chapter II (einleitung27eng) 3

31 Well-posedness in the sense of Hadamard A problem is called well-posed in the sense of Hadamard iff. the problem has a solution 2. the solution is unique J. Hadamard ( ) 3. the solution depends continuously on the given data (right hand side, initial and/or boundary conditions, ) Chapter II (einleitung43eng) 3

INTRODUCTION TO PDEs

INTRODUCTION TO PDEs INTRODUCTION TO PDEs In this course we are interested in the numerical approximation of PDEs using finite difference methods (FDM). We will use some simple prototype boundary value problems (BVP) and initial

More information

Lecture Introduction

Lecture Introduction Lecture 1 1.1 Introduction The theory of Partial Differential Equations (PDEs) is central to mathematics, both pure and applied. The main difference between the theory of PDEs and the theory of Ordinary

More information

LECTURE # 0 BASIC NOTATIONS AND CONCEPTS IN THE THEORY OF PARTIAL DIFFERENTIAL EQUATIONS (PDES)

LECTURE # 0 BASIC NOTATIONS AND CONCEPTS IN THE THEORY OF PARTIAL DIFFERENTIAL EQUATIONS (PDES) LECTURE # 0 BASIC NOTATIONS AND CONCEPTS IN THE THEORY OF PARTIAL DIFFERENTIAL EQUATIONS (PDES) RAYTCHO LAZAROV 1 Notations and Basic Functional Spaces Scalar function in R d, d 1 will be denoted by u,

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

PDEs, part 1: Introduction and elliptic PDEs

PDEs, part 1: Introduction and elliptic PDEs PDEs, part 1: Introduction and elliptic PDEs Anna-Karin Tornberg Mathematical Models, Analysis and Simulation Fall semester, 2013 Partial di erential equations The solution depends on several variables,

More information

NDT&E Methods: UT. VJ Technologies CAVITY INSPECTION. Nondestructive Testing & Evaluation TPU Lecture Course 2015/16.

NDT&E Methods: UT. VJ Technologies CAVITY INSPECTION. Nondestructive Testing & Evaluation TPU Lecture Course 2015/16. CAVITY INSPECTION NDT&E Methods: UT VJ Technologies NDT&E Methods: UT 6. NDT&E: Introduction to Methods 6.1. Ultrasonic Testing: Basics of Elasto-Dynamics 6.2. Principles of Measurement 6.3. The Pulse-Echo

More information

M.Sc. in Meteorology. Numerical Weather Prediction

M.Sc. in Meteorology. Numerical Weather Prediction M.Sc. in Meteorology UCD Numerical Weather Prediction Prof Peter Lynch Meteorology & Climate Centre School of Mathematical Sciences University College Dublin Second Semester, 2005 2006. In this section

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

ENGI 4430 PDEs - d Alembert Solutions Page 11.01

ENGI 4430 PDEs - d Alembert Solutions Page 11.01 ENGI 4430 PDEs - d Alembert Solutions Page 11.01 11. Partial Differential Equations Partial differential equations (PDEs) are equations involving functions of more than one variable and their partial derivatives

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

AM 205: lecture 14. Last time: Boundary value problems Today: Numerical solution of PDEs

AM 205: lecture 14. Last time: Boundary value problems Today: Numerical solution of PDEs AM 205: lecture 14 Last time: Boundary value problems Today: Numerical solution of PDEs ODE BVPs A more general approach is to formulate a coupled system of equations for the BVP based on a finite difference

More information

INVERSE VISCOSITY BOUNDARY VALUE PROBLEM FOR THE STOKES EVOLUTIONARY EQUATION

INVERSE VISCOSITY BOUNDARY VALUE PROBLEM FOR THE STOKES EVOLUTIONARY EQUATION INVERSE VISCOSITY BOUNDARY VALUE PROBLEM FOR THE STOKES EVOLUTIONARY EQUATION Sebastián Zamorano Aliaga Departamento de Ingeniería Matemática Universidad de Chile Workshop Chile-Euskadi 9-10 December 2014

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

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

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

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

Optimal thickness of a cylindrical shell under dynamical loading

Optimal thickness of a cylindrical shell under dynamical loading Optimal thickness of a cylindrical shell under dynamical loading Paul Ziemann Institute of Mathematics and Computer Science, E.-M.-A. University Greifswald, Germany e-mail paul.ziemann@uni-greifswald.de

More information

Mathematica. 1? Birkhauser. Continuum Mechanics using. Fundamentals, Methods, and Applications. Antonio Romano Addolorata Marasco.

Mathematica. 1? Birkhauser. Continuum Mechanics using. Fundamentals, Methods, and Applications. Antonio Romano Addolorata Marasco. Antonio Romano Addolorata Marasco Continuum Mechanics using Mathematica Fundamentals, Methods, and Applications Second Edition TECHNISCHE INFORM ATIONSB IBLIOTHEK UNIVERSITATSBtBLIOTHEK HANNOVER 1? Birkhauser

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

Numerical Methods for PDEs

Numerical Methods for PDEs Numerical Methods for PDEs Partial Differential Equations (Lecture 1, Week 1) Markus Schmuck Department of Mathematics and Maxwell Institute for Mathematical Sciences Heriot-Watt University, Edinburgh

More information

Chapter 5 Types of Governing Equations. Chapter 5: Governing Equations

Chapter 5 Types of Governing Equations. Chapter 5: Governing Equations Chapter 5 Types of Governing Equations Types of Governing Equations (1) Physical Classification-1 Equilibrium problems: (1) They are problems in which a solution of a given PDE is desired in a closed domain

More information

Introduction of Partial Differential Equations and Boundary Value Problems

Introduction of Partial Differential Equations and Boundary Value Problems Introduction of Partial Differential Equations and Boundary Value Problems 2009 Outline Definition Classification Where PDEs come from? Well-posed problem, solutions Initial Conditions and Boundary Conditions

More information

Numerical Analysis and Computer Science DN2255 Spring 2009 p. 1(8)

Numerical Analysis and Computer Science DN2255 Spring 2009 p. 1(8) Numerical Analysis and Computer Science DN2255 Spring 2009 p. 1(8) Contents Important concepts, definitions, etc...2 Exact solutions of some differential equations...3 Estimates of solutions to differential

More information

13 PDEs on spatially bounded domains: initial boundary value problems (IBVPs)

13 PDEs on spatially bounded domains: initial boundary value problems (IBVPs) 13 PDEs on spatially bounded domains: initial boundary value problems (IBVPs) A prototypical problem we will discuss in detail is the 1D diffusion equation u t = Du xx < x < l, t > finite-length rod u(x,

More information

Lucio Demeio Dipartimento di Ingegneria Industriale e delle Scienze Matematiche

Lucio Demeio Dipartimento di Ingegneria Industriale e delle Scienze Matematiche Scuola di Dottorato THE WAVE EQUATION Lucio Demeio Dipartimento di Ingegneria Industriale e delle Scienze Matematiche Lucio Demeio - DIISM wave equation 1 / 44 1 The Vibrating String Equation 2 Second

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

Classification of partial differential equations and their solution characteristics

Classification of partial differential equations and their solution characteristics 9 TH INDO GERMAN WINTER ACADEMY 2010 Classification of partial differential equations and their solution characteristics By Ankita Bhutani IIT Roorkee Tutors: Prof. V. Buwa Prof. S. V. R. Rao Prof. U.

More information

3D Elasticity Theory

3D Elasticity Theory 3D lasticity Theory Many structural analysis problems are analysed using the theory of elasticity in which Hooke s law is used to enforce proportionality between stress and strain at any deformation level.

More information

Numerical Methods for Partial Differential Equations: an Overview.

Numerical Methods for Partial Differential Equations: an Overview. Numerical Methods for Partial Differential Equations: an Overview math652_spring2009@colorstate PDEs are mathematical models of physical phenomena Heat conduction Wave motion PDEs are mathematical models

More information

KINEMATICS OF CONTINUA

KINEMATICS OF CONTINUA KINEMATICS OF CONTINUA Introduction Deformation of a continuum Configurations of a continuum Deformation mapping Descriptions of motion Material time derivative Velocity and acceleration Transformation

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

INDEX 363. Cartesian coordinates 19,20,42, 67, 83 Cartesian tensors 84, 87, 226

INDEX 363. Cartesian coordinates 19,20,42, 67, 83 Cartesian tensors 84, 87, 226 INDEX 363 A Absolute differentiation 120 Absolute scalar field 43 Absolute tensor 45,46,47,48 Acceleration 121, 190, 192 Action integral 198 Addition of systems 6, 51 Addition of tensors 6, 51 Adherence

More information

Numerical Analysis and Methods for PDE I

Numerical Analysis and Methods for PDE I Numerical Analysis and Methods for PDE I A. J. Meir Department of Mathematics and Statistics Auburn University US-Africa Advanced Study Institute on Analysis, Dynamical Systems, and Mathematical Modeling

More information

Numerical Methods in Geophysics. Introduction

Numerical Methods in Geophysics. Introduction : Why numerical methods? simple geometries analytical solutions complex geometries numerical solutions Applications in geophysics seismology geodynamics electromagnetism... in all domains History of computers

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

Lecture 6: Introduction to Partial Differential Equations

Lecture 6: Introduction to Partial Differential Equations Introductory lecture notes on Partial Differential Equations - c Anthony Peirce. Not to be copied, used, or revised without explicit written permission from the copyright owner. 1 Lecture 6: Introduction

More information

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

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

More information

The Finite Element Method for Computational Structural Mechanics

The Finite Element Method for Computational Structural Mechanics The Finite Element Method for Computational Structural Mechanics Martin Kronbichler Applied Scientific Computing (Tillämpad beräkningsvetenskap) January 29, 2010 Martin Kronbichler (TDB) FEM for CSM January

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

CHAPTER 7 SEVERAL FORMS OF THE EQUATIONS OF MOTION

CHAPTER 7 SEVERAL FORMS OF THE EQUATIONS OF MOTION CHAPTER 7 SEVERAL FORMS OF THE EQUATIONS OF MOTION 7.1 THE NAVIER-STOKES EQUATIONS Under the assumption of a Newtonian stress-rate-of-strain constitutive equation and a linear, thermally conductive medium,

More information

Lecture 16: Relaxation methods

Lecture 16: Relaxation methods Lecture 16: Relaxation methods Clever technique which begins with a first guess of the trajectory across the entire interval Break the interval into M small steps: x 1 =0, x 2,..x M =L Form a grid of points,

More information

Math 575-Lecture Viscous Newtonian fluid and the Navier-Stokes equations

Math 575-Lecture Viscous Newtonian fluid and the Navier-Stokes equations Math 575-Lecture 13 In 1845, tokes extended Newton s original idea to find a constitutive law which relates the Cauchy stress tensor to the velocity gradient, and then derived a system of equations. The

More information

Fundamentals of Linear Elasticity

Fundamentals of Linear Elasticity Fundamentals of Linear Elasticity Introductory Course on Multiphysics Modelling TOMASZ G. ZIELIŃSKI bluebox.ippt.pan.pl/ tzielins/ Institute of Fundamental Technological Research of the Polish Academy

More information

CLASSIFICATION AND PRINCIPLE OF SUPERPOSITION FOR SECOND ORDER LINEAR PDE

CLASSIFICATION AND PRINCIPLE OF SUPERPOSITION FOR SECOND ORDER LINEAR PDE CLASSIFICATION AND PRINCIPLE OF SUPERPOSITION FOR SECOND ORDER LINEAR PDE 1. Linear Partial Differential Equations A partial differential equation (PDE) is an equation, for an unknown function u, that

More information

Fundamentals of Fluid Dynamics: Elementary Viscous Flow

Fundamentals of Fluid Dynamics: Elementary Viscous Flow Fundamentals of Fluid Dynamics: Elementary Viscous Flow Introductory Course on Multiphysics Modelling TOMASZ G. ZIELIŃSKI bluebox.ippt.pan.pl/ tzielins/ Institute of Fundamental Technological Research

More information

a x Questions on Classical Solutions 1. Consider an infinite linear elastic plate with a hole as shown. Uniform shear stress

a x Questions on Classical Solutions 1. Consider an infinite linear elastic plate with a hole as shown. Uniform shear stress Questions on Classical Solutions. Consider an infinite linear elastic plate with a hole as shown. Uniform shear stress σ xy = T is applied at infinity. Determine the value of the stress σ θθ on the edge

More information

Module 2: First-Order Partial Differential Equations

Module 2: First-Order Partial Differential Equations Module 2: First-Order Partial Differential Equations The mathematical formulations of many problems in science and engineering reduce to study of first-order PDEs. For instance, the study of first-order

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

Mechanics PhD Preliminary Spring 2017

Mechanics PhD Preliminary Spring 2017 Mechanics PhD Preliminary Spring 2017 1. (10 points) Consider a body Ω that is assembled by gluing together two separate bodies along a flat interface. The normal vector to the interface is given by n

More information

[2] (a) Develop and describe the piecewise linear Galerkin finite element approximation of,

[2] (a) Develop and describe the piecewise linear Galerkin finite element approximation of, 269 C, Vese Practice problems [1] Write the differential equation u + u = f(x, y), (x, y) Ω u = 1 (x, y) Ω 1 n + u = x (x, y) Ω 2, Ω = {(x, y) x 2 + y 2 < 1}, Ω 1 = {(x, y) x 2 + y 2 = 1, x 0}, Ω 2 = {(x,

More information

Computational Fluid Dynamics 2

Computational Fluid Dynamics 2 Seite 1 Introduction Computational Fluid Dynamics 11.07.2016 Computational Fluid Dynamics 2 Turbulence effects and Particle transport Martin Pietsch Computational Biomechanics Summer Term 2016 Seite 2

More information

Fundamental Solutions and Green s functions. Simulation Methods in Acoustics

Fundamental Solutions and Green s functions. Simulation Methods in Acoustics Fundamental Solutions and Green s functions Simulation Methods in Acoustics Definitions Fundamental solution The solution F (x, x 0 ) of the linear PDE L {F (x, x 0 )} = δ(x x 0 ) x R d Is called the fundamental

More information

( ) Notes. Fluid mechanics. Inviscid Euler model. Lagrangian viewpoint. " = " x,t,#, #

( ) Notes. Fluid mechanics. Inviscid Euler model. Lagrangian viewpoint.  =  x,t,#, # Notes Assignment 4 due today (when I check email tomorrow morning) Don t be afraid to make assumptions, approximate quantities, In particular, method for computing time step bound (look at max eigenvalue

More information

WELL POSEDNESS OF PROBLEMS I

WELL POSEDNESS OF PROBLEMS I Finite Element Method 85 WELL POSEDNESS OF PROBLEMS I Consider the following generic problem Lu = f, where L : X Y, u X, f Y and X, Y are two Banach spaces We say that the above problem is well-posed (according

More information

2.29 Numerical Fluid Mechanics Spring 2015 Lecture 9

2.29 Numerical Fluid Mechanics Spring 2015 Lecture 9 Spring 2015 Lecture 9 REVIEW Lecture 8: Direct Methods for solving (linear) algebraic equations Gauss Elimination LU decomposition/factorization Error Analysis for Linear Systems and Condition Numbers

More information

Chapter 3: Stress and Equilibrium of Deformable Bodies

Chapter 3: Stress and Equilibrium of Deformable Bodies Ch3-Stress-Equilibrium Page 1 Chapter 3: Stress and Equilibrium of Deformable Bodies When structures / deformable bodies are acted upon by loads, they build up internal forces (stresses) within them to

More information

Chapter 1: Basic Concepts

Chapter 1: Basic Concepts What is a fluid? A fluid is a substance in the gaseous or liquid form Distinction between solid and fluid? Solid: can resist an applied shear by deforming. Stress is proportional to strain Fluid: deforms

More information

Notes on theory and numerical methods for hyperbolic conservation laws

Notes on theory and numerical methods for hyperbolic conservation laws Notes on theory and numerical methods for hyperbolic conservation laws Mario Putti Department of Mathematics University of Padua, Italy e-mail: mario.putti@unipd.it January 19, 2017 Contents 1 Partial

More information

V (r,t) = i ˆ u( x, y,z,t) + ˆ j v( x, y,z,t) + k ˆ w( x, y, z,t)

V (r,t) = i ˆ u( x, y,z,t) + ˆ j v( x, y,z,t) + k ˆ w( x, y, z,t) IV. DIFFERENTIAL RELATIONS FOR A FLUID PARTICLE This chapter presents the development and application of the basic differential equations of fluid motion. Simplifications in the general equations and common

More information

1 Curvilinear Coordinates

1 Curvilinear Coordinates MATHEMATICA PHYSICS PHYS-2106/3 Course Summary Gabor Kunstatter, University of Winnipeg April 2014 1 Curvilinear Coordinates 1. General curvilinear coordinates 3-D: given or conversely u i = u i (x, y,

More information

Mimetic Finite Difference Methods

Mimetic Finite Difference Methods Mimetic Finite Difference Methods Applications to the Diffusion Equation Asbjørn Nilsen Riseth May 15, 2014 2014-05-15 Mimetic Finite Difference Methods Mimetic Finite Difference Methods Applications to

More information

Partial Differential Equations II

Partial Differential Equations II Partial Differential Equations II CS 205A: Mathematical Methods for Robotics, Vision, and Graphics Justin Solomon CS 205A: Mathematical Methods Partial Differential Equations II 1 / 28 Almost Done! Homework

More information

First order Partial Differential equations

First order Partial Differential equations First order Partial Differential equations 0.1 Introduction Definition 0.1.1 A Partial Deferential equation is called linear if the dependent variable and all its derivatives have degree one and not multiple

More information

ENGI 9420 Lecture Notes 8 - PDEs Page 8.01

ENGI 9420 Lecture Notes 8 - PDEs Page 8.01 ENGI 940 Lecture Notes 8 - PDEs Page 8.01 8. Partial Differential Equations Partial differential equations (PDEs) are equations involving functions of more than one variable and their partial derivatives

More information

Introduction to Computational Fluid Dynamics

Introduction to Computational Fluid Dynamics AML2506 Biomechanics and Flow Simulation Day Introduction to Computational Fluid Dynamics Session Speaker Dr. M. D. Deshpande M.S. Ramaiah School of Advanced Studies - Bangalore 1 Session Objectives At

More information

Module 7: The Laplace Equation

Module 7: The Laplace Equation Module 7: The Laplace Equation In this module, we shall study one of the most important partial differential equations in physics known as the Laplace equation 2 u = 0 in Ω R n, (1) where 2 u := n i=1

More information

Reading: P1-P20 of Durran, Chapter 1 of Lapidus and Pinder (Numerical solution of Partial Differential Equations in Science and Engineering)

Reading: P1-P20 of Durran, Chapter 1 of Lapidus and Pinder (Numerical solution of Partial Differential Equations in Science and Engineering) Chapter 1. Partial Differential Equations Reading: P1-P0 of Durran, Chapter 1 of Lapidus and Pinder (Numerical solution of Partial Differential Equations in Science and Engineering) Before even looking

More information

Existence Theory: Green s Functions

Existence Theory: Green s Functions Chapter 5 Existence Theory: Green s Functions In this chapter we describe a method for constructing a Green s Function The method outlined is formal (not rigorous) When we find a solution to a PDE by constructing

More information

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

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

More information

Math 5587 Lecture 2. Jeff Calder. August 31, Initial/boundary conditions and well-posedness

Math 5587 Lecture 2. Jeff Calder. August 31, Initial/boundary conditions and well-posedness Math 5587 Lecture 2 Jeff Calder August 31, 2016 1 Initial/boundary conditions and well-posedness 1.1 ODE vs PDE Recall that the general solutions of ODEs involve a number of arbitrary constants. Example

More information

Partial Differential Equations

Partial Differential Equations M3M3 Partial Differential Equations Solutions to problem sheet 3/4 1* (i) Show that the second order linear differential operators L and M, defined in some domain Ω R n, and given by Mφ = Lφ = j=1 j=1

More information

Some inverse problems with applications in Elastography: theoretical and numerical aspects

Some inverse problems with applications in Elastography: theoretical and numerical aspects Some inverse problems with applications in Elastography: theoretical and numerical aspects Anna DOUBOVA Dpto. E.D.A.N. - Univ. of Sevilla joint work with E. Fernández-Cara (Universidad de Sevilla) J. Rocha

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

Conservation Laws and Finite Volume Methods

Conservation Laws and Finite Volume Methods Conservation Laws and Finite Volume Methods AMath 574 Winter Quarter, 2011 Randall J. LeVeque Applied Mathematics University of Washington January 3, 2011 R.J. LeVeque, University of Washington AMath 574,

More information

An Introduction to Numerical Methods for Differential Equations. Janet Peterson

An Introduction to Numerical Methods for Differential Equations. Janet Peterson An Introduction to Numerical Methods for Differential Equations Janet Peterson Fall 2015 2 Chapter 1 Introduction Differential equations arise in many disciplines such as engineering, mathematics, sciences

More information

A very short introduction to the Finite Element Method

A very short introduction to the Finite Element Method A very short introduction to the Finite Element Method Till Mathis Wagner Technical University of Munich JASS 2004, St Petersburg May 4, 2004 1 Introduction This is a short introduction to the finite element

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

Chapter 3 Second Order Linear Equations

Chapter 3 Second Order Linear Equations Partial Differential Equations (Math 3303) A Ë@ Õæ Aë áöß @. X. @ 2015-2014 ú GA JË@ É Ë@ Chapter 3 Second Order Linear Equations Second-order partial differential equations for an known function u(x,

More information

Final: Solutions Math 118A, Fall 2013

Final: Solutions Math 118A, Fall 2013 Final: Solutions Math 118A, Fall 2013 1. [20 pts] For each of the following PDEs for u(x, y), give their order and say if they are nonlinear or linear. If they are linear, say if they are homogeneous or

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

Introduction to Partial Differential Equations

Introduction to Partial Differential Equations Introduction to Partial Differential Equations Philippe B. Laval KSU Current Semester Philippe B. Laval (KSU) Key Concepts Current Semester 1 / 25 Introduction The purpose of this section is to define

More information

Mathematical Theory of Non-Newtonian Fluid

Mathematical Theory of Non-Newtonian Fluid Mathematical Theory of Non-Newtonian Fluid 1. Derivation of the Incompressible Fluid Dynamics 2. Existence of Non-Newtonian Flow and its Dynamics 3. Existence in the Domain with Boundary Hyeong Ohk Bae

More information

By drawing Mohr s circle, the stress transformation in 2-D can be done graphically. + σ x σ y. cos 2θ + τ xy sin 2θ, (1) sin 2θ + τ xy cos 2θ.

By drawing Mohr s circle, the stress transformation in 2-D can be done graphically. + σ x σ y. cos 2θ + τ xy sin 2θ, (1) sin 2θ + τ xy cos 2θ. Mohr s Circle By drawing Mohr s circle, the stress transformation in -D can be done graphically. σ = σ x + σ y τ = σ x σ y + σ x σ y cos θ + τ xy sin θ, 1 sin θ + τ xy cos θ. Note that the angle of rotation,

More information

12. Stresses and Strains

12. Stresses and Strains 12. Stresses and Strains Finite Element Method Differential Equation Weak Formulation Approximating Functions Weighted Residuals FEM - Formulation Classification of Problems Scalar Vector 1-D T(x) u(x)

More information

Lecture 1. Finite difference and finite element methods. Partial differential equations (PDEs) Solving the heat equation numerically

Lecture 1. Finite difference and finite element methods. Partial differential equations (PDEs) Solving the heat equation numerically Finite difference and finite element methods Lecture 1 Scope of the course Analysis and implementation of numerical methods for pricing options. Models: Black-Scholes, stochastic volatility, exponential

More information

Basic hydrodynamics. David Gurarie. 1 Newtonian fluids: Euler and Navier-Stokes equations

Basic hydrodynamics. David Gurarie. 1 Newtonian fluids: Euler and Navier-Stokes equations Basic hydrodynamics David Gurarie 1 Newtonian fluids: Euler and Navier-Stokes equations The basic hydrodynamic equations in the Eulerian form consist of conservation of mass, momentum and energy. We denote

More information

SOLVING ELLIPTIC PDES

SOLVING ELLIPTIC PDES university-logo SOLVING ELLIPTIC PDES School of Mathematics Semester 1 2008 OUTLINE 1 REVIEW 2 POISSON S EQUATION Equation and Boundary Conditions Solving the Model Problem 3 THE LINEAR ALGEBRA PROBLEM

More information

1 Separation of Variables

1 Separation of Variables Jim ambers ENERGY 281 Spring Quarter 27-8 ecture 2 Notes 1 Separation of Variables In the previous lecture, we learned how to derive a PDE that describes fluid flow. Now, we will learn a number of analytical

More information

The Shape of a Rain Drop as determined from the Navier-Stokes equation John Caleb Speirs Classical Mechanics PHGN 505 December 12th, 2011

The Shape of a Rain Drop as determined from the Navier-Stokes equation John Caleb Speirs Classical Mechanics PHGN 505 December 12th, 2011 The Shape of a Rain Drop as determined from the Navier-Stokes equation John Caleb Speirs Classical Mechanics PHGN 505 December 12th, 2011 Derivation of Navier-Stokes Equation 1 The total stress tensor

More information

Mathematical Tripos Part IA Lent Term Example Sheet 1. Calculate its tangent vector dr/du at each point and hence find its total length.

Mathematical Tripos Part IA Lent Term Example Sheet 1. Calculate its tangent vector dr/du at each point and hence find its total length. Mathematical Tripos Part IA Lent Term 205 ector Calculus Prof B C Allanach Example Sheet Sketch the curve in the plane given parametrically by r(u) = ( x(u), y(u) ) = ( a cos 3 u, a sin 3 u ) with 0 u

More information

Lecture 18 Finite Element Methods (FEM): Functional Spaces and Splines. Songting Luo. Department of Mathematics Iowa State University

Lecture 18 Finite Element Methods (FEM): Functional Spaces and Splines. Songting Luo. Department of Mathematics Iowa State University Lecture 18 Finite Element Methods (FEM): Functional Spaces and Splines Songting Luo Department of Mathematics Iowa State University MATH 481 Numerical Methods for Differential Equations Draft Songting

More information

Chapter 3 Variational Formulation & the Galerkin Method

Chapter 3 Variational Formulation & the Galerkin Method Institute of Structural Engineering Page 1 Chapter 3 Variational Formulation & the Galerkin Method Institute of Structural Engineering Page 2 Today s Lecture Contents: Introduction Differential formulation

More information

Vorticity and Dynamics

Vorticity and Dynamics Vorticity and Dynamics In Navier-Stokes equation Nonlinear term ω u the Lamb vector is related to the nonlinear term u 2 (u ) u = + ω u 2 Sort of Coriolis force in a rotation frame Viscous term ν u = ν

More information

PEAT SEISMOLOGY Lecture 2: Continuum mechanics

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

More information

u xx + u yy = 0. (5.1)

u xx + u yy = 0. (5.1) Chapter 5 Laplace Equation The following equation is called Laplace equation in two independent variables x, y: The non-homogeneous problem u xx + u yy =. (5.1) u xx + u yy = F, (5.) where F is a function

More information

Numerical Heat and Mass Transfer

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

More information

Turbulence Modeling I!

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

More information

UNIVERSITY of LIMERICK

UNIVERSITY of LIMERICK UNIVERSITY of LIMERICK OLLSCOIL LUIMNIGH Faculty of Science and Engineering END OF SEMESTER ASSESSMENT PAPER MODULE CODE: MA4607 SEMESTER: Autumn 2012-13 MODULE TITLE: Introduction to Fluids DURATION OF

More information

Fluid Extensions for Optical Flow and Diffusion-based Image Registration

Fluid Extensions for Optical Flow and Diffusion-based Image Registration Fluid Extensions for Optical Flow and Diffusion-based Image Registration Jens-Peer Kuska 1, Patrick Scheibe 2, Ulf-Dietrich Braumann 2 1 Interdisciplinary Centre for Bioinformatics, University Leipzig,

More information

An analytical method for the inverse Cauchy problem of Lame equation in a rectangle

An analytical method for the inverse Cauchy problem of Lame equation in a rectangle Journal of Physics: Conference Series PAPER OPEN ACCESS An analytical method for the inverse Cauchy problem of Lame equation in a rectangle To cite this article: Yu Grigor ev 218 J. Phys.: Conf. Ser. 991

More information