Elements of Matlab and Simulink Lecture 7

Size: px
Start display at page:

Download "Elements of Matlab and Simulink Lecture 7"

Transcription

1 Elements of Matlab and Simulink Lecture 7 Emanuele Ruffaldi 12th May 2009 Copyright 2009,Emanuele Ruffaldi. This work is licensed under the Creative Commons Attribution-ShareAlike License.

2 PARTIAL DIFFERENTIAL EQUATIONS

3 Introducing PDE Ordinary Differential Equation Derivatives respect a single independent variable Solution is a function with arbitrary constants Partial Differential Equation Differential relationship of multiple variables Solution is an arbitrary function Solution determined by fixing boundary conditions Notation

4 Elements of a PDE Equation Domain Boundary Conditions

5 Heat Equation Heat (or diffusion) equation: models the diffusion of temperature from an initially concentrated distribution u_t = u_xx Example of solution is: u(x,t) = 1/sqrt(t) exp(-x^2/4*t) Verify using MATLAB Symbolic Toolbox >> Example lecture7_diffuse

6 Boundary Problem The Dirichlet problem is the general problem of finding a function u which solves a PDE for which the values are known on the boundary of a given region Given a PDE over R N Given a function f that has values over a boundary region of Ω Find a function u solving PDE that is differentiable twice in the interior and once on the boundary and assumes the values of f on the boundary The Neumann problem involves a boundary condition relative to a derivative of the target function Expressed as u_n

7 Heat Equation 2D Heat Equation 2D: diffusion of a quantity along the space and time u_t = u_xx + u_yy The general formulation is u_t = div grad u Example Metal block with a rectangular crack. The left side is heated at 100 degrees, the right side heat is flowing to air at constant rate. The others sides are insulated u = 100 (Dirichlet condition) u_n = -10 on the right side (Neumann condition) u_n = 0 on the other boundaries (Neumann condition)

8 Linear Advection Equation Linear advection equation: models the constant movement of an initial distribution of u with a speed of c along x axis. Shape is preserved u_t = c u_x For any function q a solution is q(w) where w = x+ct u(x,t) = q(w) = q(x+ct) >> Example lecture7_advection

9 Wave Equation Linear Wave u_tt = c^2 u_xx A typical solution is u(x,t)=sin(x+ct) Spherical Wave u_tt = c^2 (u_rr + 2/r u_r) If we put in evidence (ur) the solution is the same as above u(t,r) = 1/r [F(r-ct)+G(r+ct)] >> Example lecture7_wave

10 Laplace Equation Laplace Equation u_xx + u_yy = 0 Poisson Equation u_xx + u_yy = g(x,y,z) Helmholt s Equation u_xx + u_yy + f(x,y) u = g(x,y,z) Require boundary conditions for resolution

11 Basics of FEM How we can solve PDE numerically when no analytical solution is available? The Finite Element Method is the most common solution 1. Decompose the Domain in subspaces 2. Approximate the Function with piecewise linear function defined inside each subspace 3. Find the numerical solution for every subspace given the conditions FDM is the Finite Difference Method is possible but it works better with rectangular domains

12 FEM 1D Space discretization Interpolation Function Linear Combination (Basis)

13 FEM 2D Air Silicon Generalized approach by decomposing the domain in unit elements

14 Families of PDE and use Elliptic and Parabolic Steady and unsteady heat transfer in solids Flows in porous media and diffusion problems Electrostatics of dielectric and conductive media Potential flow Hyperbolic Transient and harmonic wave propagation in acoustics and electromagnetics Transverse motions of membranes Eigenvalue Determining natural vibration states in membranes and structural mechanics problems

15 MATLAB Partial Differential Equation Toolbox Solves some families of PDE: elliptics, parabolic, hyperbolic and eigenvalue PDE Toolbox works in the easiest way with 2D Boundary User Interface (pdetool) and Command line Steps 1. Define the Domain 2. Define the Boundary function 3. Solve 4. Plot results

16 Expressing the Geometry The boundary is expressed by Constructive Solid Geometry Set composition of fundamental entities The CSG allows to compose basic entities Graphical editing (pdetool) -initmesh and decsg -Understand CSG expression

17 Geometry as Mesh The FEM resolution uses a triangular mesh for the spatial discretization of the problem The Constructive Geometry produces a closed surface that is later transformed in Mesh Refine mesh for improving details on borders or surface features (number of triangles increases) Jiggle mesh (quality improves) Draw Mode Mesh Mode

18 Expressing the Boundary Conditions Two types of Boundary Conditions Dirichlet h u=r Neumann n c grad(u) + qu = g e.g. n c grad(u) = 0 means no flux Coefficients in bold can be specified with PDE tool Export Decomposed geometry and Boundary into Workspace variables

19 Resolution of PDE Solver function depend on the type of problem u1=parabolic(u0,tlist,b,p,e,t,c,a,f,d) u0 is the initial condition (sized as size(p,2)) tlist is the time in which let system evolve b boundary p,e,t geometry [c,a,f,d] parameters of Automatic Refinement of problem [u,p,e,t]=adaptmesh(g,b,c,a,f,options) The parabolic equation can be solved keeping time fixed and starting at given condition Time Discretization (stages) Method of lines Allows PDEs in Simulink

20 Heat Equation 2D Example Metal block with a rectangular crack. The left side is heated at 100 degrees, the right side heat is flowing to air at constant rate. The others sides are insulated u = 100 (left side) u_n = -10 on the right side u_n = 0 on the other boundaries u_t = u_xx + u_yy Create Domain Set Boundary conditions Set PDE Solve Test >> Example lecture7_heat2d_pde.m with pdetool

21 PDE for Simulink Simulink Solves ODE equations Use Method of Line for making the PDE an ODE problem We are interested in using the dynamic resolution of a PDE as part of our simulation Update the PDE parameters and inputs along time Integration performed by Simulink If using Discrete simulation we can let MATLAB do the math States One for every node PDE Problem Simulink Block Input Time depending Outputs Statitsics (max/min) Value at node

22 PDE in Simulink Practical We use S-Functions Level-2 Block Initialization The output is the state of the PDE that depends on the number of nodes of the Geometry Derivatives Update the Derivatives from the Method of Lines Output Computation Return statistics about the states, and eventually return sampled values from some nodes

23 Matrix Form of the FEM Basic Matrix Formulation Dirichlet Neumann Integrated Equation

24 Thermal Regulation Problem If the diffusion is fast there is no need for space information What if we want to use the exact position of the Thermostat? PDE is Parabolic Simulink just needs the Elliptic

25 Thermal Regulation PDE Geometry Boundary Walls: n grad(t)=0 Glass: n grad(t)=q (u(1)-t) Where u(1) is exterior temperature, T is the internal temperature and q is the thermal conductivity Equation T' = div( K grad(t) ) + Th u(2) u(2) is the heater on or off Th is the function of heat flow from the heater based on its position

26 Thermal Regulation Simulink The solution for this integration is an S-Function written as M-file Parameters Coordinates of Heater xh,yh and Radius Node of the Thermostat Initial Temperature T0 Heater Temperature Th Input State of the Heater External Temperature Output State of the Heater Maximum Temperature in Room Temperature at Thermostat

27 References Books An Introduction to Partial Differential Equations with MATLAB,Coleman M., CRC Press, 2005 Introduction to Partial Differential Equations with MATLAB, Cooper J.M., Birkhause, 1998 Beginners Guide to Simulation for Physical Engineering: Practical Usage of MATLAB and PDEase, Yutaka Abe, 1999 Courses Introduction to Partial Differential Equations, Doug Moore, 2003 Introduction to Partial Differential Equations, Showalter, Oregon State University MAE502 Partial Differential Equations in Engineering, ASU,2009

11.3 MATLAB for Partial Differential Equations

11.3 MATLAB for Partial Differential Equations 276 3. Generate the shape functions N (i) j = a (i) j where i =1, 2, 3,..., m and j =1, 2, 3,..., m. + b (i) j x + c(i) j y (11.2.17) 4. Compute the integrals for matrix elements α ij and vector elements

More information

Partial Differential Equation Toolbox User s Guide. R2013a

Partial Differential Equation Toolbox User s Guide. R2013a Partial Differential Equation Toolbox User s Guide R2013a How to Contact MathWorks www.mathworks.com Web comp.soft-sys.matlab Newsgroup www.mathworks.com/contact_ts.html Technical Support suggest@mathworks.com

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

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

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

MAE/MSE502 Partial Differential Equations in Engineering. Spring 2019 Mon/Wed 6:00-7:15 PM Classroom: CAVC 101

MAE/MSE502 Partial Differential Equations in Engineering. Spring 2019 Mon/Wed 6:00-7:15 PM Classroom: CAVC 101 MAE/MSE502 Partial Differential Equations in Engineering Spring 2019 Mon/Wed 6:00-7:15 PM Classroom: CAVC 101 Instructor: Huei-Ping Huang, hp.huang@asu.edu Office: ERC 359 Office hours: Monday 3-4 PM,

More information

Solving Pure Torsion Problem and Modelling Radionuclide Migration Using Radial Basis Functions

Solving Pure Torsion Problem and Modelling Radionuclide Migration Using Radial Basis Functions International Workshop on MeshFree Methods 3 1 Solving Pure Torsion Problem and Modelling Radionuclide Migration Using Radial Basis Functions Leopold Vrankar (1), Goran Turk () and Franc Runovc (3) Abstract:

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

Discretization of PDEs and Tools for the Parallel Solution of the Resulting Systems

Discretization of PDEs and Tools for the Parallel Solution of the Resulting Systems Discretization of PDEs and Tools for the Parallel Solution of the Resulting Systems Stan Tomov Innovative Computing Laboratory Computer Science Department The University of Tennessee Wednesday April 4,

More information

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

Introduction to PDEs and Numerical Methods: Exam 1

Introduction to PDEs and Numerical Methods: Exam 1 Prof Dr Thomas Sonar, Institute of Analysis Winter Semester 2003/4 17122003 Introduction to PDEs and Numerical Methods: Exam 1 To obtain full points explain your solutions thoroughly and self-consistently

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

Comparison of an Analytical Method and Matlab to Model Electromagnetic Distribution in a Trough

Comparison of an Analytical Method and Matlab to Model Electromagnetic Distribution in a Trough Comparison of an Analytical Method and Matlab to Model Electromagnetic Distribution in a Trough JJ Bruyns University of Johannesburg, South Africa Jacob@uj.ac.za JC Greeff Tshwane University of Technology

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

Multiphysics Modeling

Multiphysics Modeling 11 Multiphysics Modeling This chapter covers the use of FEMLAB for multiphysics modeling and coupled-field analyses. It first describes the various ways of building multiphysics models. Then a step-by-step

More information

Spotlight on Laplace s Equation

Spotlight on Laplace s Equation 16 Spotlight on Laplace s Equation Reference: Sections 1.1,1.2, and 1.5. Laplace s equation is the undriven, linear, second-order PDE 2 u = (1) We defined diffusivity on page 587. where 2 is the Laplacian

More information

Chapter 12 Partial Differential Equations

Chapter 12 Partial Differential Equations Chapter 12 Partial Differential Equations Advanced Engineering Mathematics Wei-Ta Chu National Chung Cheng University wtchu@cs.ccu.edu.tw 1 2 12.1 Basic Concepts of PDEs Partial Differential Equation A

More information

MAE502/MSE502 Partial Differential Equations in Engineering. Spring 2012 Mon/Wed 5:00-6:15 PM

MAE502/MSE502 Partial Differential Equations in Engineering. Spring 2012 Mon/Wed 5:00-6:15 PM MAE502/MSE502 Partial Differential Equations in Engineering Spring 2012 Mon/Wed 5:00-6:15 PM Instructor: Huei-Ping Huang, hp.huang@asu.edu (Huei rhymes with "way") Office: ERC 359 Office hours: Monday

More information

WILEY. Differential Equations with MATLAB (Third Edition) Brian R. Hunt Ronald L. Lipsman John E. Osborn Jonathan M. Rosenberg

WILEY. Differential Equations with MATLAB (Third Edition) Brian R. Hunt Ronald L. Lipsman John E. Osborn Jonathan M. Rosenberg Differential Equations with MATLAB (Third Edition) Updated for MATLAB 2011b (7.13), Simulink 7.8, and Symbolic Math Toolbox 5.7 Brian R. Hunt Ronald L. Lipsman John E. Osborn Jonathan M. Rosenberg All

More information

Math 126 Winter 2012: Rough lecture notes

Math 126 Winter 2012: Rough lecture notes Math 126 Winter 2012: Rough lecture notes Alex Barnett, Dartmouth College March 1, 2012 1 Introduction Numerical mathematics is at the intersection of analysis (devising and proving theorems), computation

More information

Scientific Computing: An Introductory Survey

Scientific Computing: An Introductory Survey Scientific Computing: An Introductory Survey Chapter 11 Partial Differential Equations Prof. Michael T. Heath Department of Computer Science University of Illinois at Urbana-Champaign Copyright c 2002.

More information

Applied Linear Algebra in Geoscience Using MATLAB

Applied Linear Algebra in Geoscience Using MATLAB Applied Linear Algebra in Geoscience Using MATLAB Contents Getting Started Creating Arrays Mathematical Operations with Arrays Using Script Files and Managing Data Two-Dimensional Plots Programming in

More information

Introduction to PARTIAL DIFFERENTIAL EQUATIONS THIRD EDITION

Introduction to PARTIAL DIFFERENTIAL EQUATIONS THIRD EDITION Introduction to PARTIAL DIFFERENTIAL EQUATIONS THIRD EDITION K. SANKARA RAO Formerly Professor Department of Mathematics Anna University, Chennai New Delhi-110001 2011 INTRODUCTION TO PARTIAL DIFFERENTIAL

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

Index. C 2 ( ), 447 C k [a,b], 37 C0 ( ), 618 ( ), 447 CD 2 CN 2

Index. C 2 ( ), 447 C k [a,b], 37 C0 ( ), 618 ( ), 447 CD 2 CN 2 Index advection equation, 29 in three dimensions, 446 advection-diffusion equation, 31 aluminum, 200 angle between two vectors, 58 area integral, 439 automatic step control, 119 back substitution, 604

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

Numerical Solution for Two Dimensional Laplace Equation with Dirichlet Boundary Conditions

Numerical Solution for Two Dimensional Laplace Equation with Dirichlet Boundary Conditions IOSR Journal of Mathematics (IOSR-JM) e-issn: 2278-5728,p-ISSN: 2319-765X, Volume 6, Issue 4 (May. - Jun. 2013), PP 66-75 Numerical Solution for Two Dimensional Laplace Equation with Dirichlet Boundary

More information

CHAPTER 2. COULOMB S LAW AND ELECTRONIC FIELD INTENSITY. 2.3 Field Due to a Continuous Volume Charge Distribution

CHAPTER 2. COULOMB S LAW AND ELECTRONIC FIELD INTENSITY. 2.3 Field Due to a Continuous Volume Charge Distribution CONTENTS CHAPTER 1. VECTOR ANALYSIS 1. Scalars and Vectors 2. Vector Algebra 3. The Cartesian Coordinate System 4. Vector Cartesian Coordinate System 5. The Vector Field 6. The Dot Product 7. The Cross

More information

where is the Laplace operator and is a scalar function.

where is the Laplace operator and is a scalar function. Elliptic PDEs A brief discussion of two important elliptic PDEs. In mathematics, Laplace's equation is a second-order partial differential equation named after Pierre-Simon Laplace who first studied its

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

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

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

More information

Table 17 1 Some general field equation terms. Heat Power. Current Source. 0 0 Boundary Current Porous Media Flow. Flow Source

Table 17 1 Some general field equation terms. Heat Power. Current Source. 0 0 Boundary Current Porous Media Flow. Flow Source 17 Related Analogies 17.1 Basic Concepts The differential equation used in a finite element study in one discipline often appears in a different discipline, but with a different physical meaning for the

More information

A new 9-point sixth-order accurate compact finite difference method for the Helmholtz equation

A new 9-point sixth-order accurate compact finite difference method for the Helmholtz equation A new 9-point sixth-order accurate compact finite difference method for the Helmholtz equation Majid Nabavi, M. H. Kamran Siddiqui, Javad Dargahi Department of Mechanical and Industrial Engineering, Concordia

More information

A simple Galerkin boundary element method for three-dimensional crack problems in functionally graded materials

A simple Galerkin boundary element method for three-dimensional crack problems in functionally graded materials Materials Science Forum Vols. 492-493 (2005) pp 367-372 Online available since 2005/Aug/15 at www.scientific.net (2005) Trans Tech Publications, Switzerland doi:10.4028/www.scientific.net/msf.492-493.367

More information

NUMERICAL MODELING OF TRANSIENT ACOUSTIC FIELD USING FINITE ELEMENT METHOD

NUMERICAL MODELING OF TRANSIENT ACOUSTIC FIELD USING FINITE ELEMENT METHOD POZNAN UNIVE RSITY OF TE CHNOLOGY ACADE MIC JOURNALS No 73 Electrical Engineering 213 Lukáš KOUDELA* Jindřich JANSA* Pavel KARBAN* NUMERICAL MODELING OF TRANSIENT ACOUSTIC FIELD USING FINITE ELEMENT METHOD

More information

Math 124A October 11, 2011

Math 124A October 11, 2011 Math 14A October 11, 11 Viktor Grigoryan 6 Wave equation: solution In this lecture we will solve the wave equation on the entire real line x R. This corresponds to a string of infinite length. Although

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 Two: Numerical Methods for Elliptic PDEs. 1 Finite Difference Methods for Elliptic PDEs

Chapter Two: Numerical Methods for Elliptic PDEs. 1 Finite Difference Methods for Elliptic PDEs Chapter Two: Numerical Methods for Elliptic PDEs Finite Difference Methods for Elliptic PDEs.. Finite difference scheme. We consider a simple example u := subject to Dirichlet boundary conditions ( ) u

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

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

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

1 Solution of Electrostatics Problems with COM- SOL

1 Solution of Electrostatics Problems with COM- SOL 1 Solution of Electrostatics Problems with COM- SOL This section gives examples demonstrating how Comsol can be used to solve some simple electrostatics problems. 1.1 Laplace s Equation We start with a

More information

PDE Solvers for Fluid Flow

PDE Solvers for Fluid Flow PDE Solvers for Fluid Flow issues and algorithms for the Streaming Supercomputer Eran Guendelman February 5, 2002 Topics Equations for incompressible fluid flow 3 model PDEs: Hyperbolic, Elliptic, Parabolic

More information

ELECTROMAGNETISM. Volume 2. Applications Magnetic Diffusion and Electromagnetic Waves ASHUTOSH PRAMANIK

ELECTROMAGNETISM. Volume 2. Applications Magnetic Diffusion and Electromagnetic Waves ASHUTOSH PRAMANIK ELECTROMAGNETISM Volume 2 Applications Magnetic Diffusion and Electromagnetic Waves ASHUTOSH PRAMANIK Professor Emeritus, College of Engineering, Pune Formerly of Corporate Research and Development Division,

More information

Problems of Corner Singularities

Problems of Corner Singularities Stuttgart 98 Problems of Corner Singularities Monique DAUGE Institut de Recherche MAthématique de Rennes Problems of Corner Singularities 1 Vertex and edge singularities For a polyhedral domain Ω and a

More information

Electromagnetic wave propagation. ELEC 041-Modeling and design of electromagnetic systems

Electromagnetic wave propagation. ELEC 041-Modeling and design of electromagnetic systems Electromagnetic wave propagation ELEC 041-Modeling and design of electromagnetic systems EM wave propagation In general, open problems with a computation domain extending (in theory) to infinity not bounded

More information

Finite Difference Method for PDE. Y V S S Sanyasiraju Professor, Department of Mathematics IIT Madras, Chennai 36

Finite Difference Method for PDE. Y V S S Sanyasiraju Professor, Department of Mathematics IIT Madras, Chennai 36 Finite Difference Method for PDE Y V S S Sanyasiraju Professor, Department of Mathematics IIT Madras, Chennai 36 1 Classification of the Partial Differential Equations Consider a scalar second order partial

More information

Introduction to Partial Differential Equations

Introduction to Partial Differential Equations Introduction to Partial Differential Equations Partial differential equations arise in a number of physical problems, such as fluid flow, heat transfer, solid mechanics and biological processes. These

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

Numerical Solution Techniques in Mechanical and Aerospace Engineering

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

More information

Altered Jacobian Newton Iterative Method for Nonlinear Elliptic Problems

Altered Jacobian Newton Iterative Method for Nonlinear Elliptic Problems Altered Jacobian Newton Iterative Method for Nonlinear Elliptic Problems Sanjay K Khattri Abstract We present an Altered Jacobian Newton Iterative Method for solving nonlinear elliptic problems Effectiveness

More information

Finite Element Modules for Enhancing Undergraduate Transport Courses: Application to Fuel Cell Fundamentals

Finite Element Modules for Enhancing Undergraduate Transport Courses: Application to Fuel Cell Fundamentals Finite Element Modules for Enhancing Undergraduate Transport Courses: Application to Fuel Cell Fundamentals Originally published in 007 American Society for Engineering Education Conference Proceedings

More information

Compact Local Stencils Employed With Integrated RBFs For Fourth-Order Differential Problems

Compact Local Stencils Employed With Integrated RBFs For Fourth-Order Differential Problems Copyright 2011 Tech Science Press SL, vol.6, no.2, pp.93-107, 2011 Compact Local Stencils Employed With Integrated RBFs For Fourth-Order Differential Problems T.-T. Hoang-Trieu 1, N. Mai-Duy 1 and T. Tran-Cong

More information

Lecture6. Partial Differential Equations

Lecture6. Partial Differential Equations EP219 ecture notes - prepared by- Assoc. Prof. Dr. Eser OĞAR 2012-Spring ecture6. Partial Differential Equations 6.1 Review of Differential Equation We have studied the theoretical aspects of the solution

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

Chapter 10. Applied projects on Differential Equations

Chapter 10. Applied projects on Differential Equations . Chapter 10. Applied projects on Differential Equations The following projects have been used for a long time in a first advanced course on Numerical Solution of Differential Equations at KTH, Stockholm.

More information

Lecture 9 Approximations of Laplace s Equation, Finite Element Method. Mathématiques appliquées (MATH0504-1) B. Dewals, C.

Lecture 9 Approximations of Laplace s Equation, Finite Element Method. Mathématiques appliquées (MATH0504-1) B. Dewals, C. Lecture 9 Approximations of Laplace s Equation, Finite Element Method Mathématiques appliquées (MATH54-1) B. Dewals, C. Geuzaine V1.2 23/11/218 1 Learning objectives of this lecture Apply the finite difference

More information

Partial Differential Equations and Image Processing. Eshed Ohn-Bar

Partial Differential Equations and Image Processing. Eshed Ohn-Bar Partial Differential Equations and Image Processing Eshed Ohn-Bar OBJECTIVES In this presentation you will 1) Learn what partial differential equations are and where do they arise 2) Learn how to discretize

More information

Second-Order Linear ODEs (Textbook, Chap 2)

Second-Order Linear ODEs (Textbook, Chap 2) Second-Order Linear ODEs (Textbook, Chap ) Motivation Recall from notes, pp. 58-59, the second example of a DE that we introduced there. d φ 1 1 φ = φ 0 dx λ λ Q w ' (a1) This equation represents conservation

More information

2.29 Numerical Fluid Mechanics Spring 2015 Lecture 13

2.29 Numerical Fluid Mechanics Spring 2015 Lecture 13 REVIEW Lecture 12: Spring 2015 Lecture 13 Grid-Refinement and Error estimation Estimation of the order of convergence and of the discretization error Richardson s extrapolation and Iterative improvements

More information

Mathématiques appliquées (MATH0504-1) B. Dewals, Ch. Geuzaine

Mathématiques appliquées (MATH0504-1) B. Dewals, Ch. Geuzaine Lecture 2 The wave equation Mathématiques appliquées (MATH0504-1) B. Dewals, Ch. Geuzaine V1.0 28/09/2018 1 Learning objectives of this lecture Understand the fundamental properties of the wave equation

More information

An inverse problem for a system of steady-state reaction-diffusion equations on a porous domain using a collage-based approach

An inverse problem for a system of steady-state reaction-diffusion equations on a porous domain using a collage-based approach Journal of Physics: Conference Series PAPER OPEN ACCESS An inverse problem for a system of steady-state reaction-diffusion equations on a porous domain using a collage-based approach To cite this article:

More information

ADAM PIŁAT Department of Automatics, AGH University of Science and Technology Al. Mickiewicza 30, Cracow, Poland

ADAM PIŁAT Department of Automatics, AGH University of Science and Technology Al. Mickiewicza 30, Cracow, Poland Int. J. Appl. Math. Comput. Sci., 2004, Vol. 14, No. 4, 497 501 FEMLAB SOFTWARE APPLIED TO ACTIVE MAGNETIC BEARING ANALYSIS ADAM PIŁAT Department of Automatics, AGH University of Science and Technology

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

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

FDM for parabolic equations

FDM for parabolic equations FDM for parabolic equations Consider the heat equation where Well-posed problem Existence & Uniqueness Mass & Energy decreasing FDM for parabolic equations CNFD Crank-Nicolson + 2 nd order finite difference

More information

Mathematics Qualifying Exam Study Material

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

More information

Calculation of Sound Fields in Flowing Media Using CAPA and Diffpack

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

More information

Numerically Solving Partial Differential Equations

Numerically Solving Partial Differential Equations Numerically Solving Partial Differential Equations Michael Lavell Department of Applied Mathematics and Statistics Abstract The physics describing the fundamental principles of fluid dynamics can be written

More information

Multigrid Method for 2D Helmholtz Equation using Higher Order Finite Difference Scheme Accelerated by Krylov Subspace

Multigrid Method for 2D Helmholtz Equation using Higher Order Finite Difference Scheme Accelerated by Krylov Subspace 201, TextRoad Publication ISSN: 2090-27 Journal of Applied Environmental and Biological Sciences www.textroad.com Multigrid Method for 2D Helmholtz Equation using Higher Order Finite Difference Scheme

More information

DISCRETE MAXIMUM PRINCIPLES in THE FINITE ELEMENT SIMULATIONS

DISCRETE MAXIMUM PRINCIPLES in THE FINITE ELEMENT SIMULATIONS DISCRETE MAXIMUM PRINCIPLES in THE FINITE ELEMENT SIMULATIONS Sergey Korotov BCAM Basque Center for Applied Mathematics http://www.bcamath.org 1 The presentation is based on my collaboration with several

More information

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

Table of Contents. II. PDE classification II.1. Motivation and Examples. II.2. Classification. II.3. Well-posedness according to Hadamard Table of Contents II. PDE classification II.. Motivation and Examples II.2. Classification II.3. Well-posedness according to Hadamard Chapter II (ContentChapterII) Crashtest: Reality Simulation http:www.ara.comprojectssvocrownvic.htm

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

AND NONLINEAR SCIENCE SERIES. Partial Differential. Equations with MATLAB. Matthew P. Coleman. CRC Press J Taylor & Francis Croup

AND NONLINEAR SCIENCE SERIES. Partial Differential. Equations with MATLAB. Matthew P. Coleman. CRC Press J Taylor & Francis Croup CHAPMAN & HALL/CRC APPLIED MATHEMATICS AND NONLINEAR SCIENCE SERIES An Introduction to Partial Differential Equations with MATLAB Second Edition Matthew P Coleman Fairfield University Connecticut, USA»C)

More information

The One Dimensional Heat Equation

The One Dimensional Heat Equation The One Dimensional Heat Equation Adam Abrahamsen and David Richards May 22, 2002 Abstract In this document we will study the flow of heat in one dimension through a small thin rod. We will use the derivation

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

Finite Elements. Colin Cotter. January 15, Colin Cotter FEM

Finite Elements. Colin Cotter. January 15, Colin Cotter FEM Finite Elements January 15, 2018 Why Can solve PDEs on complicated domains. Have flexibility to increase order of accuracy and match the numerics to the physics. has an elegant mathematical formulation

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

Partial Differential Equations and the Finite Element Method

Partial Differential Equations and the Finite Element Method Partial Differential Equations and the Finite Element Method Pavel Solin The University of Texas at El Paso Academy of Sciences ofthe Czech Republic iwiley- INTERSCIENCE A JOHN WILEY & SONS, INC, PUBLICATION

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

Relevant self-assessment exercises: [LIST SELF-ASSESSMENT EXERCISES HERE]

Relevant self-assessment exercises: [LIST SELF-ASSESSMENT EXERCISES HERE] Chapter 6 Finite Volume Methods In the previous chapter we have discussed finite difference methods for the discretization of PDEs. In developing finite difference methods we started from the differential

More information

Partial Differential Equations. Examples of PDEs

Partial Differential Equations. Examples of PDEs Partial Differential Equations Almost all the elementary and numerous advanced parts of theoretical physics are formulated in terms of differential equations (DE). Newton s Laws Maxwell equations Schrodinger

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

FINITE ELEMENT SOLUTION OF POISSON S EQUATION IN A HOMOGENEOUS MEDIUM

FINITE ELEMENT SOLUTION OF POISSON S EQUATION IN A HOMOGENEOUS MEDIUM International Research Journal of Engineering and Technology (IRJET) e-issn: 2395-0056 Volume: 02 Issue: 09 Dec-2015 p-issn: 2395-0072 www.irjet.net FINITE ELEMENT SOLUTION OF POISSON S EQUATION IN A HOMOGENEOUS

More information

Module 1: Introduction to Finite Difference Method and Fundamentals of CFD Lecture 1: Finite Difference Method

Module 1: Introduction to Finite Difference Method and Fundamentals of CFD Lecture 1: Finite Difference Method file:///d:/chitra/nptel_phase2/mechanical/cfd/lecture1/1_1.htm 1 of 1 6/19/2012 4:29 PM The Lecture deals with: Classification of Partial Differential Equations Boundary and Initial Conditions Finite Differences

More information

21 Laplace s Equation and Harmonic Functions

21 Laplace s Equation and Harmonic Functions 2 Laplace s Equation and Harmonic Functions 2. Introductory Remarks on the Laplacian operator Given a domain Ω R d, then 2 u = div(grad u) = in Ω () is Laplace s equation defined in Ω. If d = 2, in cartesian

More information

Lecture 2. Introduction to FEM. What it is? What we are solving? Potential formulation Why? Boundary conditions

Lecture 2. Introduction to FEM. What it is? What we are solving? Potential formulation Why? Boundary conditions Introduction to FEM What it is? What we are solving? Potential formulation Why? Boundary conditions Lecture 2 Notation Typical notation on the course: Bolded quantities = matrices (A) and vectors (a) Unit

More information

KINGS COLLEGE OF ENGINEERING DEPARTMENT OF MATHEMATICS ACADEMIC YEAR / EVEN SEMESTER QUESTION BANK

KINGS COLLEGE OF ENGINEERING DEPARTMENT OF MATHEMATICS ACADEMIC YEAR / EVEN SEMESTER QUESTION BANK KINGS COLLEGE OF ENGINEERING MA5-NUMERICAL METHODS DEPARTMENT OF MATHEMATICS ACADEMIC YEAR 00-0 / EVEN SEMESTER QUESTION BANK SUBJECT NAME: NUMERICAL METHODS YEAR/SEM: II / IV UNIT - I SOLUTION OF EQUATIONS

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

Introduction to Partial Differential Equation - I. Quick overview

Introduction to Partial Differential Equation - I. Quick overview Introduction to Partial Differential Equation - I. Quick overview To help explain the correspondence between a PDE and a real world phenomenon, we will use t to denote time and (x, y, z) to denote the

More information

Partial Differential Equations

Partial Differential Equations Partial Differential Equations Analytical Solution Techniques J. Kevorkian University of Washington Wadsworth & Brooks/Cole Advanced Books & Software Pacific Grove, California C H A P T E R 1 The Diffusion

More information

One dimensional steady state diffusion, with and without source. Effective transfer coefficients

One dimensional steady state diffusion, with and without source. Effective transfer coefficients One dimensional steady state diffusion, with and without source. Effective transfer coefficients 2 mars 207 For steady state situations t = 0) and if convection is not present or negligible the transport

More information

Chapter 1 Mathematical Foundations

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

More information

Numerical Computation of Sturm-Liouville Problem with Robin Boundary Condition

Numerical Computation of Sturm-Liouville Problem with Robin Boundary Condition Numerical Computation of Sturm-Liouville Problem with Robin Boundary Condition Theddeus T. Akano, Omotayo A. Fakinlede Abstract The modelling of physical phenomena, such as the earth s free oscillations,

More information

AMS 529: Finite Element Methods: Fundamentals, Applications, and New Trends

AMS 529: Finite Element Methods: Fundamentals, Applications, and New Trends AMS 529: Finite Element Methods: Fundamentals, Applications, and New Trends Lecture 25: Introduction to Discontinuous Galerkin Methods Xiangmin Jiao SUNY Stony Brook Xiangmin Jiao Finite Element Methods

More information

Advanced numerical methods for nonlinear advectiondiffusion-reaction. Peter Frolkovič, University of Heidelberg

Advanced numerical methods for nonlinear advectiondiffusion-reaction. Peter Frolkovič, University of Heidelberg Advanced numerical methods for nonlinear advectiondiffusion-reaction equations Peter Frolkovič, University of Heidelberg Content Motivation and background R 3 T Numerical modelling advection advection

More information

APPLIED PARTIAL DIFFERENTIAL EQUATIONS

APPLIED PARTIAL DIFFERENTIAL EQUATIONS APPLIED PARTIAL DIFFERENTIAL EQUATIONS AN I N T R O D U C T I O N ALAN JEFFREY University of Newcastle-upon-Tyne ACADEMIC PRESS An imprint of Elsevier Science Amsterdam Boston London New York Oxford Paris

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

BOUNDARY-VALUE PROBLEMS IN RECTANGULAR COORDINATES

BOUNDARY-VALUE PROBLEMS IN RECTANGULAR COORDINATES 1 BOUNDARY-VALUE PROBLEMS IN RECTANGULAR COORDINATES 1.1 Separable Partial Differential Equations 1. Classical PDEs and Boundary-Value Problems 1.3 Heat Equation 1.4 Wave Equation 1.5 Laplace s Equation

More information

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

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

More information