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

Size: px
Start display at page:

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

Transcription

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

2 Overview What are partial dierential equations? How do we solve them? (Example) Numerical integration Doing this quickly

3 Partial Dierential Equations Equation involving unctions and their partial derivatives Example: Wave Equation We wish to know ψ, which is unction o many variables Typically, no analytical solution possible t v z y x + + ψ ψ ψ ψ

4 Problem Domain Want to solve problem or speciic domain : bounded open domain in space R n Γ: boundary o I domain -D, we have ollowing: Γ

5 Navier-Stokes Equation Model o incompressible luid low Governed by equation: u + t u 0 ( u ) u 0 u P u ν u + a in (0,T] ρ in (0,T] on Γ (0,T] 0 ( x) u at t 0 u: luid velocity P: pressure ρ: mass density ν: dynamic viscosity a: acceleration due to external orce

6 Simpliying Navier-Stokes: Just Stokes Assume steady low: ( u ) u u 0 u u 0 u ν 0 0 P u ρ Neglect convection: P ν u ρ + a + a in in on Γ in in on Γ

7 Solving Stokes Equation ν u u 0 u 0 on Γ Space o possible unctions V that could be solutions to velocity u Choose any v V, multiply both sides o Stokes Equation and integrate, resulting in: ν udx v in in v dx

8 Solving Stokes Equation Apply Green s Theorem and boundary conditions to obtain: ν u vdx For notational convenience, this is written as: u, v (, v) vdx

9 Discretize the domain Create mesh by partitioning domain into inite elements (curved Bezier triangles) Create subspace V h o V o piecewise polynomial unctions with basis unction deined at each node ϕ v ( x) set o basis unctions ( x) v ( ) ( ) h x ηiϕi x h V h M i

10 Linear Equations Since V h V, u h V so we can say that in order or u h to be a solution to Stokes equation, we need u h, v (, v) v Vh In particular, must be true or basis unctions, so writing u h in terms o basis unctions, we have: M i η ( ) ϕ j M ϕ, ϕ,,..., i i j j

11 Solution to Problem Aη b A η b ij ϕ, ϕ i [ η,..., η ] [(, ϕ ),...,(, ϕ )] T Knowing coeicients η i means we know solution u h This is a system o M linear equations with M unknowns, can be solved with various numerical methods j M T M

12 Integration Computing stiness matrix and load vector requires lots o integrals ϕ i, ϕ j, (,ϕ i ) These are done numerically via quadratures: 0 y 0 ( x) dx 0 n i w ( x, y) dxdy ( x, y ) Choose Gauss points and weights to give high order accuracy i ( x ) n i i w i i i

13 Full Navier-Stokes Equation Requires our types o integrals and g are basis unctions on curved triangles Map rom K simplex to curved triangles: F : K Bezier β α α g g g g

14 Mapping K to Bezier Mapping requires 6 control points, deined by b i s are Bezier basis unction (polynomials) Jacobian is deined in standard way 6 i c i b i F y F x F y F x F J y y x x

15 Integrals on K β α α g g g g det det det det K K K T T K J J J J J J J J J β α α β ψ α ψ α ψ φ ψ φ ψ φ

16 Need or speed Each type o integral is done on each triangle, or each combination o basis unctions Ater each time step, mesh moves (Lagrangian), so integrals need to be done or each timestep Speed and accuracy are required

17 Speedup: Cacheing Cache K basis unctions, so only Jacobian needs to be evaluated or each element Basis unctions cached at Gauss points, so unctions are essentially just arrays o values Cache Jacobian or each element as well, since it is reused in every integral Large speedup versus recomputation each time

18 Idea: Expand integrals Jacobian determinant can be written in terms o Bezier basis unctions with coeicients given by control points 6 g φ ψ det J n i K i K φ ψ b Integrals in this sum no longer depend on control points Precompute integrals, compute coeicients only i

19 Reusing old values Ater each time step, large portions o mesh unchanged I Jacobian o element is close enough to old value, reuse old integrals Speedup depends on measure o close enough and how much mesh changes

20 Example movie

21 Questions?

Transport Properties: Momentum Transport, Viscosity

Transport Properties: Momentum Transport, Viscosity Transport Properties: Momentum Transport, Viscosity 13th February 2011 1 Introduction Much as mass(material) is transported within luids (gases and liquids), linear momentum is also associated with transport,

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

Chem 406 Biophysical Chemistry Lecture 1 Transport Processes, Sedimentation & Diffusion

Chem 406 Biophysical Chemistry Lecture 1 Transport Processes, Sedimentation & Diffusion Chem 406 Biophysical Chemistry Lecture 1 Transport Processes, Sedimentation & Diusion I. Introduction A. There are a group o biophysical techniques that are based on transport processes. 1. Transport processes

More information

OE4625 Dredge Pumps and Slurry Transport. Vaclav Matousek October 13, 2004

OE4625 Dredge Pumps and Slurry Transport. Vaclav Matousek October 13, 2004 OE465 Vaclav Matousek October 13, 004 1 Dredge Vermelding Pumps onderdeel and Slurry organisatie Transport OE465 Vaclav Matousek October 13, 004 Dredge Vermelding Pumps onderdeel and Slurry organisatie

More information

FLUID MECHANICS. Lecture 7 Exact solutions

FLUID MECHANICS. Lecture 7 Exact solutions FLID MECHANICS Lecture 7 Eact solutions 1 Scope o Lecture To present solutions or a ew representative laminar boundary layers where the boundary conditions enable eact analytical solutions to be obtained.

More information

39.1 Gradually Varied Unsteady Flow

39.1 Gradually Varied Unsteady Flow 39.1 Gradually Varied Unsteady Flow Gradually varied unsteady low occurs when the low variables such as the low depth and velocity do not change rapidly in time and space. Such lows are very common in

More information

Asymptote. 2 Problems 2 Methods

Asymptote. 2 Problems 2 Methods Asymptote Problems Methods Problems Assume we have the ollowing transer unction which has a zero at =, a pole at = and a pole at =. We are going to look at two problems: problem is where >> and problem

More information

Chapter 2 Lecture 7 Longitudinal stick fixed static stability and control 4 Topics

Chapter 2 Lecture 7 Longitudinal stick fixed static stability and control 4 Topics hapter 2 Lecture 7 Longitudinal stick ixed static stability and control 4 Topics 2.4.6 Revised expression or mcgt 2.4.7 mαt in stick-ixed case 2.5 ontributions o uselage to mcg and mα 2.5.1 ontribution

More information

Fluctuationlessness Theorem and its Application to Boundary Value Problems of ODEs

Fluctuationlessness Theorem and its Application to Boundary Value Problems of ODEs Fluctuationlessness Theorem and its Application to Boundary Value Problems o ODEs NEJLA ALTAY İstanbul Technical University Inormatics Institute Maslak, 34469, İstanbul TÜRKİYE TURKEY) nejla@be.itu.edu.tr

More information

An Immersed Interface Method for the Incompressible Navier-Stokes Equations in Irregular Domains

An Immersed Interface Method for the Incompressible Navier-Stokes Equations in Irregular Domains An Immersed Interace Method or the Incompressible Navier-Stokes Equations in Irregular Domains Duc-Vinh Le, Boo Cheong Khoo, Jaime Peraire Singapore-MIT Alliance Department o Mechanical Engineering, National

More information

Mechanical Engineering Research Journal BUOYANT FLOW OF NANOFLUID FOR HEAT-MASS TRANSFER THROUGH A THIN LAYER

Mechanical Engineering Research Journal BUOYANT FLOW OF NANOFLUID FOR HEAT-MASS TRANSFER THROUGH A THIN LAYER Dept. o Mech. Eng. CUET Published Online March 2015 (http://www.cuet.ac.bd/merj/index.html) Mechanical Engineering Research Journal Vol. 9, pp. 712, 2013 M E R J ISSN: 1990-5491 BUOYANT FLOW OF NANOFLUID

More information

! " k x 2k$1 # $ k x 2k. " # p $ 1! px! p " p 1 # !"#$%&'"()'*"+$",&-('./&-/. !"#$%&'()"*#%+!'",' -./#")'.,&'+.0#.1)2,'!%)2%! !"#$%&'"%(")*$+&#,*$,#

!  k x 2k$1 # $ k x 2k.  # p $ 1! px! p  p 1 # !#$%&'()'*+$,&-('./&-/. !#$%&'()*#%+!',' -./#)'.,&'+.0#.1)2,'!%)2%! !#$%&'%()*$+&#,*$,# "#$%&'()"*#%+'",' -./#")'.,&'+.0#.1)2,' %)2% "#$%&'"()'*"+$",&-('./&-/. Taylor Series o a unction at x a is " # a k " # " x a# k k0 k It is a Power Series centered at a. Maclaurin Series o a unction is

More information

Controlling the Heat Flux Distribution by Changing the Thickness of Heated Wall

Controlling the Heat Flux Distribution by Changing the Thickness of Heated Wall J. Basic. Appl. Sci. Res., 2(7)7270-7275, 2012 2012, TextRoad Publication ISSN 2090-4304 Journal o Basic and Applied Scientiic Research www.textroad.com Controlling the Heat Flux Distribution by Changing

More information

Physics 5153 Classical Mechanics. Solution by Quadrature-1

Physics 5153 Classical Mechanics. Solution by Quadrature-1 October 14, 003 11:47:49 1 Introduction Physics 5153 Classical Mechanics Solution by Quadrature In the previous lectures, we have reduced the number o eective degrees o reedom that are needed to solve

More information

Topic02_PDE. 8/29/2006 topic02_pde 1. Computational Fluid Dynamics (AE/ME 339) MAE Dept., UMR

Topic02_PDE. 8/29/2006 topic02_pde 1. Computational Fluid Dynamics (AE/ME 339) MAE Dept., UMR MEAE 9 Computational Fluid Dnamics Topic0_ 89006 topic0_ Partial Dierential Equations () (CLW: 7., 7., 7.4) s can be linear or nonlinear Order : Determined b the order o the highest derivative. Linear,

More information

Polynomials, Linear Factors, and Zeros. Factor theorem, multiple zero, multiplicity, relative maximum, relative minimum

Polynomials, Linear Factors, and Zeros. Factor theorem, multiple zero, multiplicity, relative maximum, relative minimum Polynomials, Linear Factors, and Zeros To analyze the actored orm o a polynomial. To write a polynomial unction rom its zeros. Describe the relationship among solutions, zeros, - intercept, and actors.

More information

OPTIMALLY STAGGERED FINNED CIRCULAR AND ELLIPTIC TUBES IN FORCED CONVECTION

OPTIMALLY STAGGERED FINNED CIRCULAR AND ELLIPTIC TUBES IN FORCED CONVECTION OPTIMALLY STAGGERED FINNED CIRCULAR AND ELLIPTIC TUBES IN FORCED CONVECTION R. S. Matos a, T. A. Laursen b, J. V. C. Vargas a, and A. Bejan c, a Universidade Federal do Paraná Departamento de Engenharia

More information

Comments on Magnetohydrodynamic Unsteady Flow of A Non- Newtonian Fluid Through A Porous Medium

Comments on Magnetohydrodynamic Unsteady Flow of A Non- Newtonian Fluid Through A Porous Medium Comments on Magnetohydrodynamic Unsteady Flow o A Non- Newtonian Fluid Through A Porous Medium Mostaa A.A.Mahmoud Department o Mathematics, Faculty o Science, Benha University (358), Egypt Abstract The

More information

The Ascent Trajectory Optimization of Two-Stage-To-Orbit Aerospace Plane Based on Pseudospectral Method

The Ascent Trajectory Optimization of Two-Stage-To-Orbit Aerospace Plane Based on Pseudospectral Method Available online at www.sciencedirect.com ScienceDirect Procedia Engineering 00 (014) 000 000 www.elsevier.com/locate/procedia APISAT014, 014 Asia-Paciic International Symposium on Aerospace Technology,

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

Math 2412 Activity 1(Due by EOC Sep. 17)

Math 2412 Activity 1(Due by EOC Sep. 17) Math 4 Activity (Due by EOC Sep. 7) Determine whether each relation is a unction.(indicate why or why not.) Find the domain and range o each relation.. 4,5, 6,7, 8,8. 5,6, 5,7, 6,6, 6,7 Determine whether

More information

A REPORT ON PERFORMANCE OF ANNULAR FINS HAVING VARYING THICKNESS

A REPORT ON PERFORMANCE OF ANNULAR FINS HAVING VARYING THICKNESS VOL., NO. 8, APRIL 6 ISSN 89-668 ARPN Journal o Engineering and Applied Sciences 6-6 Asian Research Publishing Networ (ARPN). All rights reserved. A REPORT ON PERFORMANCE OF ANNULAR FINS HAVING VARYING

More information

Filtration. Praktikum Mechanical Engineering. Spring semester ML F16 Tel.:

Filtration. Praktikum Mechanical Engineering. Spring semester ML F16 Tel.: Praktikum Mechanical Engineering Spring semester 2018 Filtration Supervisor: Davide Stucchi ML F16 stucchid@ptl.mavt.ethz.ch Tel.: 044 632 25 05 1 1 Table o Contents 1 TABLE OF CONTENTS... 2 2 INTRODUCTION...

More information

Global Weak Solution of Planetary Geostrophic Equations with Inviscid Geostrophic Balance

Global Weak Solution of Planetary Geostrophic Equations with Inviscid Geostrophic Balance Global Weak Solution o Planetary Geostrophic Equations with Inviscid Geostrophic Balance Jian-Guo Liu 1, Roger Samelson 2, Cheng Wang 3 Communicated by R. Temam) Abstract. A reormulation o the planetary

More information

ELEG 3143 Probability & Stochastic Process Ch. 4 Multiple Random Variables

ELEG 3143 Probability & Stochastic Process Ch. 4 Multiple Random Variables Department o Electrical Engineering University o Arkansas ELEG 3143 Probability & Stochastic Process Ch. 4 Multiple Random Variables Dr. Jingxian Wu wuj@uark.edu OUTLINE 2 Two discrete random variables

More information

CONVECTIVE HEAT TRANSFER CHARACTERISTICS OF NANOFLUIDS. Convective heat transfer analysis of nanofluid flowing inside a

CONVECTIVE HEAT TRANSFER CHARACTERISTICS OF NANOFLUIDS. Convective heat transfer analysis of nanofluid flowing inside a Chapter 4 CONVECTIVE HEAT TRANSFER CHARACTERISTICS OF NANOFLUIDS Convective heat transer analysis o nanoluid lowing inside a straight tube o circular cross-section under laminar and turbulent conditions

More information

2015 American Journal of Engineering Research (AJER)

2015 American Journal of Engineering Research (AJER) American Journal o Engineering Research (AJER) 2015 American Journal o Engineering Research (AJER) e-issn: 2320-0847 p-issn : 2320-0936 Volume-4, Issue-7, pp-33-40.ajer.org Research Paper Open Access The

More information

HYDROMAGNETIC DIVERGENT CHANNEL FLOW OF A VISCO- ELASTIC ELECTRICALLY CONDUCTING FLUID

HYDROMAGNETIC DIVERGENT CHANNEL FLOW OF A VISCO- ELASTIC ELECTRICALLY CONDUCTING FLUID Rita Choudhury et al. / International Journal o Engineering Science and Technology (IJEST) HYDROAGNETIC DIVERGENT CHANNEL FLOW OF A VISCO- ELASTIC ELECTRICALLY CONDUCTING FLUID RITA CHOUDHURY Department

More information

(One Dimension) Problem: for a function f(x), find x 0 such that f(x 0 ) = 0. f(x)

(One Dimension) Problem: for a function f(x), find x 0 such that f(x 0 ) = 0. f(x) Solving Nonlinear Equations & Optimization One Dimension Problem: or a unction, ind 0 such that 0 = 0. 0 One Root: The Bisection Method This one s guaranteed to converge at least to a singularity, i not

More information

Non-newtonian Rabinowitsch Fluid Effects on the Lubrication Performances of Sine Film Thrust Bearings

Non-newtonian Rabinowitsch Fluid Effects on the Lubrication Performances of Sine Film Thrust Bearings International Journal o Mechanical Engineering and Applications 7; 5(): 6-67 http://www.sciencepublishinggroup.com/j/ijmea doi:.648/j.ijmea.75.4 ISSN: -X (Print); ISSN: -48 (Online) Non-newtonian Rabinowitsch

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

10. Joint Moments and Joint Characteristic Functions

10. Joint Moments and Joint Characteristic Functions 10. Joint Moments and Joint Characteristic Functions Following section 6, in this section we shall introduce various parameters to compactly represent the inormation contained in the joint p.d. o two r.vs.

More information

Analysis of Non-Thermal Equilibrium in Porous Media

Analysis of Non-Thermal Equilibrium in Porous Media Analysis o Non-Thermal Equilibrium in Porous Media A. Nouri-Borujerdi, M. Nazari 1 School o Mechanical Engineering, Shari University o Technology P.O Box 11365-9567, Tehran, Iran E-mail: anouri@shari.edu

More information

Back Matter Index The McGraw Hill Companies, 2004

Back Matter Index The McGraw Hill Companies, 2004 INDEX A Absolute viscosity, 294 Active zone, 468 Adjoint, 452 Admissible functions, 132 Air, 294 ALGOR, 12 Amplitude, 389, 391 Amplitude ratio, 396 ANSYS, 12 Applications fluid mechanics, 293 326. See

More information

0,0 B 5,0 C 0, 4 3,5. y x. Recitation Worksheet 1A. 1. Plot these points in the xy plane: A

0,0 B 5,0 C 0, 4 3,5. y x. Recitation Worksheet 1A. 1. Plot these points in the xy plane: A Math 13 Recitation Worksheet 1A 1 Plot these points in the y plane: A 0,0 B 5,0 C 0, 4 D 3,5 Without using a calculator, sketch a graph o each o these in the y plane: A y B 3 Consider the unction a Evaluate

More information

Constitutive models. Constitutive model: determines P in terms of deformation

Constitutive models. Constitutive model: determines P in terms of deformation Constitutive models Constitutive model: determines P in terms of deformation Elastic material: P depends only on current F Hyperelastic material: work is independent of path strain energy density function

More information

DUE: WEDS MARCH 26TH 2018

DUE: WEDS MARCH 26TH 2018 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

More information

Description of a One-Dimensional Numerical Model of an Active Magnetic Regenerator Refrigerator

Description of a One-Dimensional Numerical Model of an Active Magnetic Regenerator Refrigerator This is a 1D model o an active magnetic regenerative rerigerator (AMRR) that was developed in MATLAB. The model uses cycle inputs such as the luid mass low and magnetic ield proiles, luid and regenerator

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

A Hybrid Method for the Wave Equation. beilina

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

More information

Computational Methods for Domains with! Complex Boundaries-I!

Computational Methods for Domains with! Complex Boundaries-I! http://www.nd.edu/~gtrggva/cfd-course/ Computational Methods or Domains with Comple Boundaries-I Grétar Trggvason Spring For most engineering problems it is necessar to deal with comple geometries, consisting

More information

Answer Key-Math 11- Optional Review Homework For Exam 2

Answer Key-Math 11- Optional Review Homework For Exam 2 Answer Key-Math - Optional Review Homework For Eam 2. Compute the derivative or each o the ollowing unctions: Please do not simpliy your derivatives here. I simliied some, only in the case that you want

More information

The Poisson summation formula, the sampling theorem, and Dirac combs

The Poisson summation formula, the sampling theorem, and Dirac combs The Poisson summation ormula, the sampling theorem, and Dirac combs Jordan Bell jordanbell@gmailcom Department o Mathematics, University o Toronto April 3, 24 Poisson summation ormula et S be the set o

More information

Shock Capturing for Discontinuous Galerkin Methods using Finite Volume Sub-cells

Shock Capturing for Discontinuous Galerkin Methods using Finite Volume Sub-cells Abstract We present a shock capturing procedure for high order Discontinuous Galerkin methods, by which shock regions are refined in sub-cells and treated by finite volume techniques Hence, our approach

More information

Multipole-Based Preconditioners for Sparse Linear Systems.

Multipole-Based Preconditioners for Sparse Linear Systems. Multipole-Based Preconditioners for Sparse Linear Systems. Ananth Grama Purdue University. Supported by the National Science Foundation. Overview Summary of Contributions Generalized Stokes Problem Solenoidal

More information

Christoffel symbols and Gauss Theorema Egregium

Christoffel symbols and Gauss Theorema Egregium Durham University Pavel Tumarkin Epiphany 207 Dierential Geometry III, Solutions 5 (Week 5 Christoel symbols and Gauss Theorema Egregium 5.. Show that the Gauss curvature K o the surace o revolution locally

More information

An Overview of Fluid Animation. Christopher Batty March 11, 2014

An Overview of Fluid Animation. Christopher Batty March 11, 2014 An Overview of Fluid Animation Christopher Batty March 11, 2014 What distinguishes fluids? What distinguishes fluids? No preferred shape. Always flows when force is applied. Deforms to fit its container.

More information

ON AN ESTIMATION OF THE DAMPING PROPERTIES OF WOVEN FABRIC COMPOSITES

ON AN ESTIMATION OF THE DAMPING PROPERTIES OF WOVEN FABRIC COMPOSITES ON AN ESTIMATION OF THE DAMPING PROPERTIES OF WOVEN FABRIC COMPOSITES Masaru Zao 1, Tetsusei Kurashii 1, Yasumasa Naanishi 2 and Kin ya Matsumoto 2 1 Department o Management o Industry and Technology,

More information

BOUNDARY LAYER ANALYSIS ALONG A STRETCHING WEDGE SURFACE WITH MAGNETIC FIELD IN A NANOFLUID

BOUNDARY LAYER ANALYSIS ALONG A STRETCHING WEDGE SURFACE WITH MAGNETIC FIELD IN A NANOFLUID Proceedings o the International Conerence on Mechanical Engineering and Reneable Energy 7 (ICMERE7) 8 December, 7, Chittagong, Bangladesh ICMERE7-PI- BOUNDARY LAYER ANALYSIS ALONG A STRETCHING WEDGE SURFACE

More information

Buoyancy Driven Heat Transfer of Water-Based CuO Nanofluids in a Tilted Enclosure with a Heat Conducting Solid Cylinder on its Center

Buoyancy Driven Heat Transfer of Water-Based CuO Nanofluids in a Tilted Enclosure with a Heat Conducting Solid Cylinder on its Center July 4-6 2012 London U.K. Buoyancy Driven Heat Transer o Water-Based CuO Nanoluids in a Tilted Enclosure with a Heat Conducting Solid Cylinder on its Center Ahmet Cihan Kamil Kahveci and Çiğdem Susantez

More information

Heat-fluid Coupling Simulation of Wet Friction Clutch

Heat-fluid Coupling Simulation of Wet Friction Clutch 3rd International Conerence on Mechatronics, Robotics and Automation (ICMRA 2015) Heat-luid Coupling Simulation o Wet Friction Clutch Tengjiao Lin 1,a *, Qing Wang 1, b, Quancheng Peng 1,c and Yan Xie

More information

Differentiation. The main problem of differential calculus deals with finding the slope of the tangent line at a point on a curve.

Differentiation. The main problem of differential calculus deals with finding the slope of the tangent line at a point on a curve. Dierentiation The main problem o dierential calculus deals with inding the slope o the tangent line at a point on a curve. deinition() : The slope o a curve at a point p is the slope, i it eists, o the

More information

Review of Prerequisite Skills for Unit # 2 (Derivatives) U2L2: Sec.2.1 The Derivative Function

Review of Prerequisite Skills for Unit # 2 (Derivatives) U2L2: Sec.2.1 The Derivative Function UL1: Review o Prerequisite Skills or Unit # (Derivatives) Working with the properties o exponents Simpliying radical expressions Finding the slopes o parallel and perpendicular lines Simpliying rational

More information

Code No: RT41033 R13 Set No. 1 IV B.Tech I Semester Regular Examinations, November - 2016 FINITE ELEMENT METHODS (Common to Mechanical Engineering, Aeronautical Engineering and Automobile Engineering)

More information

Wave regimes and mass transfer in two-layer falling films

Wave regimes and mass transfer in two-layer falling films Wave regimes and mass transer in two-layer alling ilms by GÖKÇEN ÇEKİÇ A thesis submitted to The University o Birmingham or the degree o Doctor o Philosophy School o Mathematics The University o Birmingham

More information

Lecture 25: Heat and The 1st Law of Thermodynamics Prof. WAN, Xin

Lecture 25: Heat and The 1st Law of Thermodynamics Prof. WAN, Xin General Physics I Lecture 5: Heat and he 1st Law o hermodynamics Pro. WAN, Xin xinwan@zju.edu.cn http://zimp.zju.edu.cn/~xinwan/ Latent Heat in Phase Changes Latent Heat he latent heat o vaporization or

More information

Algorithms for fluid-structure interaction problems

Algorithms for fluid-structure interaction problems 9 Algorithms or luid-structure interaction problems Miguel A. Fernández, Jean-Frédéric Gerbeau Fluid-structure coupled problems and their analysis have been addressed in the previous chapters particularly

More information

FLOW CHARACTERISTICS OF HFC-134a IN AN ADIABATIC HELICAL CAPILLARY TUBE

FLOW CHARACTERISTICS OF HFC-134a IN AN ADIABATIC HELICAL CAPILLARY TUBE E HEFAT7 5 th International Conerence on Heat Transer, Fluid Mechanics and Thermodynamics Sun City, South Arica Paper number: KM1 FLOW CHARACTERISTICS OF HFC-1a IN AN ADIABATIC HELICAL CAPILLARY TUBE Khan

More information

examples of equations: what and why intrinsic view, physical origin, probability, geometry

examples of equations: what and why intrinsic view, physical origin, probability, geometry Lecture 1 Introduction examples of equations: what and why intrinsic view, physical origin, probability, geometry Intrinsic/abstract F ( x, Du, D u, D 3 u, = 0 Recall algebraic equations such as linear

More information

Efficient FEM-multigrid solver for granular material

Efficient FEM-multigrid solver for granular material Efficient FEM-multigrid solver for granular material S. Mandal, A. Ouazzi, S. Turek Chair for Applied Mathematics and Numerics (LSIII), TU Dortmund STW user committee meeting Enschede, 25th September,

More information

Scientific Computing WS 2017/2018. Lecture 18. Jürgen Fuhrmann Lecture 18 Slide 1

Scientific Computing WS 2017/2018. Lecture 18. Jürgen Fuhrmann Lecture 18 Slide 1 Scientific Computing WS 2017/2018 Lecture 18 Jürgen Fuhrmann juergen.fuhrmann@wias-berlin.de Lecture 18 Slide 1 Lecture 18 Slide 2 Weak formulation of homogeneous Dirichlet problem Search u H0 1 (Ω) (here,

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

Second Order Slip Flow of Cu-Water Nanofluid Over a Stretching Sheet With Heat Transfer

Second Order Slip Flow of Cu-Water Nanofluid Over a Stretching Sheet With Heat Transfer Second Order Slip Flow o Cu-Water Nanoluid Over a Stretching Sheet With Heat Transer RAJESH SHARMA AND ANUAR ISHAK School o Mathematical Sciences, Faculty o Science and Technology Universiti Kebangsaan

More information

Example: When describing where a function is increasing, decreasing or constant we use the x- axis values.

Example: When describing where a function is increasing, decreasing or constant we use the x- axis values. Business Calculus Lecture Notes (also Calculus With Applications or Business Math II) Chapter 3 Applications o Derivatives 31 Increasing and Decreasing Functions Inormal Deinition: A unction is increasing

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 Variational Problems of the Dirichlet BVP of the Poisson Equation 1 For the homogeneous

More information

NUMERICAL STUDY ON THE EFFECT OF INCLINATION ANGLE ON HEAT TRANSFER PERFORMANCE IN BACK-WARD FACING STEP UTILIZING NANOFLUID

NUMERICAL STUDY ON THE EFFECT OF INCLINATION ANGLE ON HEAT TRANSFER PERFORMANCE IN BACK-WARD FACING STEP UTILIZING NANOFLUID NUMERICAL STUDY ON THE EFFECT OF INCLINATION ANGLE ON HEAT TRANSFER PERFORMANCE IN BACK-WARD FACING STEP UTILIZING NANOFLUID Saleh Etaig*, Etaig.Mahmoud@Northumbria.ac.uk Reaz Hasan, Reaz.Hasan@Northumria.ac.uk

More information

Partitioned Methods for Multifield Problems

Partitioned Methods for Multifield Problems C Partitioned Methods for Multifield Problems Joachim Rang, 6.7.2016 6.7.2016 Joachim Rang Partitioned Methods for Multifield Problems Seite 1 C One-dimensional piston problem fixed wall Fluid flexible

More information

Overlapping Schwarz preconditioners for Fekete spectral elements

Overlapping Schwarz preconditioners for Fekete spectral elements Overlapping Schwarz preconditioners for Fekete spectral elements R. Pasquetti 1, L. F. Pavarino 2, F. Rapetti 1, and E. Zampieri 2 1 Laboratoire J.-A. Dieudonné, CNRS & Université de Nice et Sophia-Antipolis,

More information

Pressure-correction algorithm to solve Poisson system with constant coefficients for fast two-phase simulations

Pressure-correction algorithm to solve Poisson system with constant coefficients for fast two-phase simulations Center or Turbulence Research Annual Research Bries 2009 367 Pressure-correction algorithm to solve Poisson system with constant coeicients or ast two-phase simulations By D. Kim AND P. Moin 1. Motivation

More information

RESOLUTION MSC.362(92) (Adopted on 14 June 2013) REVISED RECOMMENDATION ON A STANDARD METHOD FOR EVALUATING CROSS-FLOODING ARRANGEMENTS

RESOLUTION MSC.362(92) (Adopted on 14 June 2013) REVISED RECOMMENDATION ON A STANDARD METHOD FOR EVALUATING CROSS-FLOODING ARRANGEMENTS (Adopted on 4 June 203) (Adopted on 4 June 203) ANNEX 8 (Adopted on 4 June 203) MSC 92/26/Add. Annex 8, page THE MARITIME SAFETY COMMITTEE, RECALLING Article 28(b) o the Convention on the International

More information

Earlier Lecture. Basics of Refrigeration/Liquefaction, coefficient of performance and importance of Carnot COP.

Earlier Lecture. Basics of Refrigeration/Liquefaction, coefficient of performance and importance of Carnot COP. 9 1 Earlier Lecture Basics o Rerigeration/Liqueaction, coeicient o perormance and importance o Carnot COP. Throttling, heat exchanger, compression/expansion systems. Deinition o a rerigerator, liqueier

More information

Fluid Animation. Christopher Batty November 17, 2011

Fluid Animation. Christopher Batty November 17, 2011 Fluid Animation Christopher Batty November 17, 2011 What distinguishes fluids? What distinguishes fluids? No preferred shape Always flows when force is applied Deforms to fit its container Internal forces

More information

Math-3 Lesson 8-5. Unit 4 review: a) Compositions of functions. b) Linear combinations of functions. c) Inverse Functions. d) Quadratic Inequalities

Math-3 Lesson 8-5. Unit 4 review: a) Compositions of functions. b) Linear combinations of functions. c) Inverse Functions. d) Quadratic Inequalities Math- Lesson 8-5 Unit 4 review: a) Compositions o unctions b) Linear combinations o unctions c) Inverse Functions d) Quadratic Inequalities e) Rational Inequalities 1. Is the ollowing relation a unction

More information

Objectives. By the time the student is finished with this section of the workbook, he/she should be able

Objectives. By the time the student is finished with this section of the workbook, he/she should be able FUNCTIONS Quadratic Functions......8 Absolute Value Functions.....48 Translations o Functions..57 Radical Functions...61 Eponential Functions...7 Logarithmic Functions......8 Cubic Functions......91 Piece-Wise

More information

Math 660-Lecture 15: Finite element spaces (I)

Math 660-Lecture 15: Finite element spaces (I) Math 660-Lecture 15: Finite element spaces (I) (Chapter 3, 4.2, 4.3) Before we introduce the concrete spaces, let s first of all introduce the following important lemma. Theorem 1. Let V h consists of

More information

RATIONAL FUNCTIONS. Finding Asymptotes..347 The Domain Finding Intercepts Graphing Rational Functions

RATIONAL FUNCTIONS. Finding Asymptotes..347 The Domain Finding Intercepts Graphing Rational Functions RATIONAL FUNCTIONS Finding Asymptotes..347 The Domain....350 Finding Intercepts.....35 Graphing Rational Functions... 35 345 Objectives The ollowing is a list o objectives or this section o the workbook.

More information

A NUMERICAL STUDY OF SINGLE-PHASE FORCED CONVECTIVE HEAT TRANSFER WITH FLOW FRICTION IN ROUND TUBE HEAT EXCHANGERS

A NUMERICAL STUDY OF SINGLE-PHASE FORCED CONVECTIVE HEAT TRANSFER WITH FLOW FRICTION IN ROUND TUBE HEAT EXCHANGERS www.arpapress.com/volumes/vol6issue4/ijrras_6_4_05.pd A NUMERICAL STUDY OF SINGLE-PHASE FORCED CONVECTIVE HEAT TRANSFER WITH FLOW FRICTION IN ROUND TUBE HEAT EXCHANGERS Pedram Mohajeri Khameneh 1,*, Iraj

More information

3D Numerical Modelling of Convective Heat Transfer through Two-sided Vertical Channel Symmetrically Filled with Metal Foams

3D Numerical Modelling of Convective Heat Transfer through Two-sided Vertical Channel Symmetrically Filled with Metal Foams P Periodica Polytechnica Mechanical Engineering P 60(4), pp. 193-202, 2016 DOI: 10.3311/PPme.8511 Creative Commons Attribution b 3D Numerical Modelling o Convective Heat Transer through Two-sided Vertical

More information

Representation of Coriolis forces and simulation procedures for moving fluid-conveying pipes

Representation of Coriolis forces and simulation procedures for moving fluid-conveying pipes Representation o Coriolis orces and simulation procedures or moving luid-conveying pipes Jörg Gebhardt*, Frank Kassubek** *ABB Corporate Research Center Germany, Department or Automation Device Technologies,

More information

MAGNETOHYDRODYNAMIC GO-WATER NANOFLUID FLOW AND HEAT TRANSFER BETWEEN TWO PARALLEL MOVING DISKS

MAGNETOHYDRODYNAMIC GO-WATER NANOFLUID FLOW AND HEAT TRANSFER BETWEEN TWO PARALLEL MOVING DISKS THERMAL SCIENCE: Year 8, Vol., No. B, pp. 383-39 383 MAGNETOHYDRODYNAMIC GO-WATER NANOFLUID FLOW AND HEAT TRANSFER BETWEEN TWO PARALLEL MOVING DISKS Introduction by Mohammadreza AZIMI and Rouzbeh RIAZI

More information

Solving the Navier-Stokes Equations

Solving the Navier-Stokes Equations FMIA F. Moukalled L. Mangani M. Darwish An Advanced Introduction with OpenFOAM and Matlab This textbook explores both the theoretical oundation o the Finite Volume Method (FVM) and its applications in

More information

Extreme Values of Functions

Extreme Values of Functions Extreme Values o Functions When we are using mathematics to model the physical world in which we live, we oten express observed physical quantities in terms o variables. Then, unctions are used to describe

More information

ENERGY ANALYSIS: CLOSED SYSTEM

ENERGY ANALYSIS: CLOSED SYSTEM ENERGY ANALYSIS: CLOSED SYSTEM A closed system can exchange energy with its surroundings through heat and work transer. In other words, work and heat are the orms that energy can be transerred across the

More information

Characterization of Internal State Variable for fiber fracture in UD Composite

Characterization of Internal State Variable for fiber fracture in UD Composite Characterization o Internal State ariable or iber racture in UD Composite Modris Megnis,, Povl Brondsted 3, Sai A. Rehman 4, Tanveer Ahmad 5 Summary The continuum damage mechanics is used to describe the

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

arxiv: v1 [math.na] 29 Oct 2018

arxiv: v1 [math.na] 29 Oct 2018 A Multirate Approach or Fluid-Structure Interaction Computation with Decoupled Methods Lian Zhang 1, Mingchao Cai 2 Mo Mu 3, arxiv:1810.11933v1 [math.na] 29 Oct 2018 Abstract We investigate a multirate

More information

On an Approximation Result for Piecewise Polynomial Functions. O. Karakashian

On an Approximation Result for Piecewise Polynomial Functions. O. Karakashian BULLETIN OF THE GREE MATHEMATICAL SOCIETY Volume 57, 010 (1 7) On an Approximation Result for Piecewise Polynomial Functions O. arakashian Abstract We provide a new approach for proving approximation results

More information

3. Numerical integration

3. Numerical integration 3. Numerical integration... 3. One-dimensional quadratures... 3. Two- and three-dimensional quadratures... 3.3 Exact Integrals for Straight Sided Triangles... 5 3.4 Reduced and Selected Integration...

More information

ME FINITE ELEMENT ANALYSIS FORMULAS

ME FINITE ELEMENT ANALYSIS FORMULAS ME 2353 - FINITE ELEMENT ANALYSIS FORMULAS UNIT I FINITE ELEMENT FORMULATION OF BOUNDARY VALUE PROBLEMS 01. Global Equation for Force Vector, {F} = [K] {u} {F} = Global Force Vector [K] = Global Stiffness

More information

A solid-fluid mixture theory of porous media

A solid-fluid mixture theory of porous media A solid-luid mixture theory o porous media I-Shih Liu Instituto de Matemática, Universidade Federal do Rio de Janeiro Abstract The theories o mixtures in the ramework o continuum mechanics have been developed

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

BANDELET IMAGE APPROXIMATION AND COMPRESSION

BANDELET IMAGE APPROXIMATION AND COMPRESSION BANDELET IMAGE APPOXIMATION AND COMPESSION E. LE PENNEC AND S. MALLAT Abstract. Finding eicient geometric representations o images is a central issue to improve image compression and noise removal algorithms.

More information

Adaptive Finite Element Methods Lecture Notes Winter Term 2017/18. R. Verfürth. Fakultät für Mathematik, Ruhr-Universität Bochum

Adaptive Finite Element Methods Lecture Notes Winter Term 2017/18. R. Verfürth. Fakultät für Mathematik, Ruhr-Universität Bochum Adaptive Finite Element Methods Lecture Notes Winter Term 2017/18 R. Verfürth Fakultät für Mathematik, Ruhr-Universität Bochum Contents Chapter I. Introduction 7 I.1. Motivation 7 I.2. Sobolev and finite

More information

Stokes and Darcy equations, Robin-Robin domain decomposition, geometrical

Stokes and Darcy equations, Robin-Robin domain decomposition, geometrical A PARALLEL ROBIN-ROBIN DOMAIN DECOMPOSITION METHOD FOR THE STOKES-DARCY SYSTEM WENBIN CHEN, MAX GUNZBURGER, FEI HUA, AND XIAOMING WANG Abstract. We propose a new parallel Robin-Robin domain decomposition

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

PARCYCLIC: FINITE ELEMENT MODELING OF EARTHQUAKE LIQUEFACTION RESPONSE ON PARALLEL COMPUTERS

PARCYCLIC: FINITE ELEMENT MODELING OF EARTHQUAKE LIQUEFACTION RESPONSE ON PARALLEL COMPUTERS 13 th World Conerence on Earthquake Engineering Vancouver, B.C., Canada August 1-6, 2004 Paper No. 361 PARCYCLIC: FINITE ELEMENT MODELING OF EARTHQUAKE LIQUEFACTION RESPONSE ON PARALLEL COMPUTERS Jun PENG

More information

Ultra Fast Calculation of Temperature Profiles of VLSI ICs in Thermal Packages Considering Parameter Variations

Ultra Fast Calculation of Temperature Profiles of VLSI ICs in Thermal Packages Considering Parameter Variations Ultra Fast Calculation o Temperature Proiles o VLSI ICs in Thermal Packages Considering Parameter Variations Je-Hyoung Park, Virginia Martín Hériz, Ali Shakouri, and Sung-Mo Kang Dept. o Electrical Engineering,

More information

Conservation of Mass. Computational Fluid Dynamics. The Equations Governing Fluid Motion

Conservation of Mass. Computational Fluid Dynamics. The Equations Governing Fluid Motion http://www.nd.edu/~gtryggva/cfd-course/ http://www.nd.edu/~gtryggva/cfd-course/ Computational Fluid Dynamics Lecture 4 January 30, 2017 The Equations Governing Fluid Motion Grétar Tryggvason Outline Derivation

More information

Numerical Solution of Ordinary Differential Equations in Fluctuationlessness Theorem Perspective

Numerical Solution of Ordinary Differential Equations in Fluctuationlessness Theorem Perspective Numerical Solution o Ordinary Dierential Equations in Fluctuationlessness Theorem Perspective NEJLA ALTAY Bahçeşehir University Faculty o Arts and Sciences Beşiktaş, İstanbul TÜRKİYE TURKEY METİN DEMİRALP

More information

Weierstraß-Institut. für Angewandte Analysis und Stochastik. Leibniz-Institut im Forschungsverbund Berlin e. V. Preprint ISSN

Weierstraß-Institut. für Angewandte Analysis und Stochastik. Leibniz-Institut im Forschungsverbund Berlin e. V. Preprint ISSN Weierstraß-Institut ür Angewandte Analysis und Stochastik Leibniz-Institut im Forschungsverbund Berlin e. V. Preprint ISSN 0946 8633 On iterative subdomain methods or the Stokes Darcy problem Alonso Caiazzo

More information