Numerical modeling of rock deformation: 06 FEM Introduction

Size: px
Start display at page:

Download "Numerical modeling of rock deformation: 06 FEM Introduction"

Transcription

1 Numerical modeling of rock deformation: 6 FEM Introduction Stefan Schmalholz schmalholz@erdw.ethz.ch NO E 6 AS 9, Thursday -, NO D

2 Introduction We have learned that geodynamic processes can be described with partial differential equations (PDE s) derived from the concepts of continuum mechanics. These PDE s describing geodynamic processes are often complicated and non-linear and closed-form analytical solutions do not eist. Therefore, the PDE s are transformed into a system of linear equations which can be solved by a computer. The finite element method (FEM) is one method to transform systems of PDE s into systems of linear equations. Other methods are for eample the finite difference method, the finite volume method, the spectral method or the boundary element method. In this lecture the basic concept of the FEM is introduced by transforming a simple ordinary equation into a system of linear equations.

3 The model equation We consider the equation Case A) u ( ) A B u B L This equation is a second order, inhomogeneous ordinary differential equation. Physically it describes for eample: A) The deflection of a stretched wire under a lateral load (u = deflection, A = tension, B = lateral load) B) Steady state heat conduction with radiogenic heat production (u = temperature, A = thermal diffusivity, B = heat production) C) Viscous fluid flow between parallel plates (u = velocity, A = viscosity, B = pressure drop)

4 The analytical solution We find the general analytical solution by simple integration u ( ) B integrate d A u ( ) B C integrate d A B A u ( ) C C u The special solution is B BL A A u ( ) B L L=, A=, B=- The two integration constants are found by two boundary conditions u ( ) C BL u ( L) C A u

5 The weak formulation - The original equation u ( ) A B Multiply with test function u ( ) N( ) A B Integrate spatially L L u ( ) N( ) A B d u ( ) N( ) A N( ) B d Integrate by parts L L u ( ) N ( ) u ( ) N( ) A A N( ) B d u ( ) LN ( ) u ( ) N( ) A d A N( ) Bd L u ( ) L N ( ) u ( ) N( ) A A N( ) Bd The product rule of differentiation a b b a ab b a a ab b u ( ) a N( ), b A

6 The weak formulation - L u ( ) L N ( ) u ( ) N( ) A A N( ) Bd The first term requires our function u() at the boundaries = and =L and is given by the boundary conditions. Therefore, we do not need to test u() at these boundary points. L N( ) u( ) A N( ) Bd The original equation u ( ) A B The above equation is the weak form of our original equations, because it has weaker constraints on the differentiability on our solution (only first derivative compared to second derivative in original equation).

7 The finite element approimation - We approimate our unknown solution as a sum of known functions, the so-called shape functions, multiplied with unknown coefficients. The shape functions are one at only one nodal point and zero at all other nodal points, so that the coefficient corresponding to a certain shape function is the solution at the node. u ( ) u i ui i i i i

8 The finite element approimation - We approimate our unknown solution as a sum of known functions, the so-called shape functions, multiplied with unknown coefficients. The shape functions are one at only one nodal point and zero at all other nodal points, so that the coefficient corresponding to a certain shape function is the solution at the node. ui u( ) uin( ) i ui N( ) i N( ) i N( ) i ui T Nu u ( ) u i ui i i i i

9 The finite element approimation - We approimate our unknown solution as a sum of known functions, the so-called shape functions, multiplied with unknown coefficients. The shape functions are one at only one nodal point and zero at all other nodal points, so that the coefficient corresponding to a certain shape function is the solution at the node. ui u( ) uin( ) i ui N( ) i N( ) i N( ) i ui T Nu u ( ) i N( ) i d i i N( ) i i d i i u i ui i i Finite Element d i i i i

10 The finite element approimation - LN( ) u( ) A N( ) Bd d N( ) i ui N( ) i A N( ) ( ) i N i Bd N( ) i ui N( ) i u N( ) i N( ) i N( ) i d N( ) ( ) u ( ) i N i i N i A Bd N( ) i ui N( ) i N( ) i N( ) i N( ) i N( ) i d ui N( ) i A Bd N( ) i N( ) i N( ) i N( ) i ui N( ) i N( ) i N( ) i N( ) i N( ) i d ui d N( ) i Ad Bd N ( ) i N ( ) i N ( ) i N ( ) i u i N( ) i Ku - F u i ui The FEM where the shape functions are identical to the test (weight) functions is called Galerkin method after Boris Galerkin.

11 The finite element approimation - Ku - F K N( ) i N( ) i N( ) i N( ) i N( ) Bd d d i Ad, F N( ) i N( ) i N( ) i N( ) i N( ) i d N( ) ( ) d i N i Kii Ad A d d d d A A A d d d d i N( ) i d A A Bd d d, K F A A Bd d d i N( ) i N( ) i d i N( ) i i i i i d d i

12 The finite element approimation - 4 Local system for element A A Bd d d u A A Bd u d d u Local system for element u A A Bd u d d u A A Bd d d d L/ d L Global system for sum of all elements A A Bd d d u A A A ubd d d d u Bd A A d d

13 The finite element approimation - 5 Global system without boundary conditions A A Bd d d u A A A u Bd d d d u Bd A A d d d L/ d L Implementing boundary conditions: u and u = u A A A u Bd d d d u

14 The finite element approimation - 5 Global system without boundary conditions A A Bd d d u A A A u Bd d d d u Bd A A d d Implementing boundary conditions: u and u = u A A A u Bd d d d u d L/ d L Calculate solution using L= (d=l/=5), A=, B=- u u u u 5 u 5.5 u B BL A A u ( ) Analytical solution at =5 u ( 5) 5 5.5

15 Programming finite elements - Global nodes Local nodes Nine finite elements Which nodes belong to what element? Introduce a node matri! The NODE matri assigns to each local element the corresponding global node Ten nodes i i D ecursion

16 Programming finite elements - Nine finite elements Global nodes Ten nodes Local nodes Local system for 4 finite element d d A A Bd d d d d u A Au Bd d d A A B d u4 A A u 5 Bd

17 Programming finite elements - The global stiffness matri is the sum of all local stiffness matries. In our code we will first setup a global stiffness matri K Global full of zeros. We will then ) loop through the finite elements, ) identify where the local element is positioned within the global matri and ) add the local stiffness matri at the correct position to the global matri. A A d d A A A A d d A A d d A A d d d d A A d d K Global Eactly the same is done for the right hand side vector F.

18 The FEM Maple code > restart; > # FEM # Derivation of small matri for D nd order steady state > # Number of nodes per element nonel := : > # Shape functions N[] := (d-)/d: N[] := /d: > # FEM approimation u := sum( t[j]*n[j],j=..nonel): > # Weak formulation of D equation for i from to nonel do LN( ) u( ) A Eq_weak[i] := int( -A*diff(u,)*diff(N[i],) + B*N[i],=..d); od: > # Create element matries for conductive and transient terms K:=matri(nonel,nonel,): F:=matri(nonel,,): for i from to nonel do for j from to nonel do K[i,j] := coeff(eq_weak[i],t[j]): od: F[i,] := -coeff(eq_weak[i],b)*b: od: > # Display K and F matri(k); matri(f); A d A d A d A d N( ) Bd B d Bd

19 The FEM Matlab code In the numerical solution all parameters can be made variable easily, while it gets more difficult to find analytical solutions for variable parameters, e.g., A and B.

20 FEM applications Taken from MIT lecture, de Weck and Kim

21 FEM element types Taken from unknown web script

22 FEM applications Shortening of the continental lithosphere with: (i) viscoelastoplastic rheology, (ii) transient temperature field, (iii) viscous heating and (iv) gravity.

23 FEM applications Three-dimensional viscous folding

Numerical modeling of rock deformation: 03 Analytical methods - Folding

Numerical modeling of rock deformation: 03 Analytical methods - Folding Numerical modeling of rock deformation: 0 Analytical methods - Folding Stefan Schmalholz schmalholz@erdw.ethz.ch NO E 6 AS 2009, Thursday 0-2, NO D Overview Application of linear stability analysis Dominant

More information

Numerical modeling of rock deformation: 03 Analytical methods - Folding. Stefan Schmalholz LEB D3

Numerical modeling of rock deformation: 03 Analytical methods - Folding. Stefan Schmalholz LEB D3 Numerical modeling of rock deformation: 0 Analytical methods - Folding Stefan Schmalholz schmalholz@erdw.ethz.ch LEB D S008, Thursday 0-, CAB 5 Overview Derive a thin-plate equation for bending, folding

More information

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

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

More information

Chapter 6 2D Elements Plate Elements

Chapter 6 2D Elements Plate Elements Institute of Structural Engineering Page 1 Chapter 6 2D Elements Plate Elements Method of Finite Elements I Institute of Structural Engineering Page 2 Continuum Elements Plane Stress Plane Strain Toda

More information

du(l) 5 dl = U(0) = 1 and 1.) Substitute for U an unspecified trial function into governing equation, i.e. dx + = =

du(l) 5 dl = U(0) = 1 and 1.) Substitute for U an unspecified trial function into governing equation, i.e. dx + = = Consider an ODE of te form: Finite Element Metod du fu g d + wit te following Boundary Conditions: U(0) and du(l) 5 dl.) Substitute for U an unspecified trial function into governing equation, i.e. ^ U

More information

Seismotectonics of intraplate oceanic regions. Thermal model Strength envelopes Plate forces Seismicity distributions

Seismotectonics of intraplate oceanic regions. Thermal model Strength envelopes Plate forces Seismicity distributions Seismotectonics of intraplate oceanic regions Thermal model Strength envelopes Plate forces Seismicity distributions Cooling of oceanic lithosphere also increases rock strength and seismic velocity. Thus

More information

Linear Algebra. Solving SLEs with Matlab. Matrix Inversion. Solving SLE s by Matlab - Inverse. Solving Simultaneous Linear Equations in MATLAB

Linear Algebra. Solving SLEs with Matlab. Matrix Inversion. Solving SLE s by Matlab - Inverse. Solving Simultaneous Linear Equations in MATLAB Linear Algebra Solving Simultaneous Linear Equations in MATLAB Solving SLEs with Matlab Matlab can solve some numerical SLE s A b Five techniques available:. method. method. method 4. method. method Matri

More information

Lecture 1: Course Introduction.

Lecture 1: Course Introduction. Lecture : Course Introduction. What is the Finite Element Method (FEM)? a numerical method for solving problems of engineering and mathematical physics. (Logan Pg. #). In MECH 40 we are concerned with

More information

Introduction to Finite Element Method. Dr. Aamer Haque

Introduction to Finite Element Method. Dr. Aamer Haque Introduction to Finite Element Method 4 th Order Beam Equation Dr. Aamer Haque http://math.iit.edu/~ahaque6 ahaque7@iit.edu Illinois Institute of Technology July 1, 009 Outline Euler-Bernoulli Beams Assumptions

More information

Eigenvalues of Trusses and Beams Using the Accurate Element Method

Eigenvalues of Trusses and Beams Using the Accurate Element Method Eigenvalues of russes and Beams Using the Accurate Element Method Maty Blumenfeld Department of Strength of Materials Universitatea Politehnica Bucharest, Romania Paul Cizmas Department of Aerospace Engineering

More information

Development of Truss Equations

Development of Truss Equations CIVL 7/87 Chapter 3 - Truss Equations - Part /53 Chapter 3a Development of Truss Equations Learning Objectives To derive the stiffness matri for a bar element. To illustrate how to solve a bar assemblage

More information

MECh300H Introduction to Finite Element Methods. Finite Element Analysis (F.E.A.) of 1-D Problems

MECh300H Introduction to Finite Element Methods. Finite Element Analysis (F.E.A.) of 1-D Problems MECh300H Introduction to Finite Element Methods Finite Element Analysis (F.E.A.) of -D Problems Historical Background Hrenikoff, 94 frame work method Courant, 943 piecewise polynomial interpolation Turner,

More information

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

Relevant self-assessment exercises: [LIST SELF-ASSESSMENT EXERCISES HERE] Chapter 5 Fourier Analysis of Finite Difference Methods In this lecture, we determine the stability of PDE discretizations using Fourier analysis. First, we begin with Fourier analysis of PDE s, and then

More information

Surface changes caused by erosion and sedimentation were treated by solving: (2)

Surface changes caused by erosion and sedimentation were treated by solving: (2) GSA DATA REPOSITORY 214279 GUY SIMPSON Model with dynamic faulting and surface processes The model used for the simulations reported in Figures 1-3 of the main text is based on two dimensional (plane strain)

More information

ANALYSIS OF FLOW IN A CONCENTRIC ANNULUS USING FINITE ELEMENT METHOD

ANALYSIS OF FLOW IN A CONCENTRIC ANNULUS USING FINITE ELEMENT METHOD Nigerian Journal of Technology (NIJOTECH) Vol 35, No 2, April 2016, pp 344 348 Copyright Faculty of Engineering, University of Nigeria, Nsukka, Print ISSN: 0331-8443, Electronic ISSN: 2467-8821 wwwnijotechcom

More information

INTRODUCCION AL ANALISIS DE ELEMENTO FINITO (CAE / FEA)

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

More information

1 2D Stokes equations on a staggered grid using primitive variables

1 2D Stokes equations on a staggered grid using primitive variables Figure 1: Staggered grid definition. Properties such as viscosity and density inside a control volume (gray) are assumed to be constant. Moreover, a constant grid spacing in x and -direction is assumed.

More information

Lesson 9: Diffusion of Heat (discrete rod) and ode45

Lesson 9: Diffusion of Heat (discrete rod) and ode45 Lesson 9: Diffusion of Heat (discrete rod) and ode45 9.1 Applied Problem. Consider the temperature in a thin rod such as a wire with electrical current. Assume the ends have a fixed temperature and the

More information

Lecture 4.2 Finite Difference Approximation

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

More information

Formal Methods for Deriving Element Equations

Formal Methods for Deriving Element Equations Formal Methods for Deriving Element Eqations And the importance of Shape Fnctions Formal Methods In previos lectres we obtained a bar element s stiffness eqations sing the Direct Method to obtain eact

More information

Finite Element Nonlinear Analysis for Catenary Structure Considering Elastic Deformation

Finite Element Nonlinear Analysis for Catenary Structure Considering Elastic Deformation Copyright 21 Tech Science Press CMES, vol.63, no.1, pp.29-45, 21 Finite Element Nonlinear Analysis for Catenary Structure Considering Elastic Deformation B.W. Kim 1, H.G. Sung 1, S.Y. Hong 1 and H.J. Jung

More information

Tutorials for Thermal Convection. Shijie Zhong Department of Physics University of Colorado Boulder, CO

Tutorials for Thermal Convection. Shijie Zhong Department of Physics University of Colorado Boulder, CO Tutorials for Thermal Convection Shijie Zhong Department of Physics University of Colorado Boulder, CO 80305 Email: szhong@colorado.edu Table of content: 1. Introduction 2 2. Governing equations 2 3. Rheology

More information

Chapter 6 Laminar External Flow

Chapter 6 Laminar External Flow Chapter 6 aminar Eternal Flow Contents 1 Thermal Boundary ayer 1 2 Scale analysis 2 2.1 Case 1: δ t > δ (Thermal B.. is larger than the velocity B..) 3 2.2 Case 2: δ t < δ (Thermal B.. is smaller than

More information

2.25 Advanced Fluid Mechanics

2.25 Advanced Fluid Mechanics MIT Department of Mechanical Engineering.5 Advanced Fluid Mechanics Problem 6.0a This problem is from Advanced Fluid Mechanics Problems by A.H. Shapiro and A.A. Sonin Consider a steady, fully developed

More information

MMJ1153 COMPUTATIONAL METHOD IN SOLID MECHANICS PRELIMINARIES TO FEM

MMJ1153 COMPUTATIONAL METHOD IN SOLID MECHANICS PRELIMINARIES TO FEM B Course Content: A INTRODUCTION AND OVERVIEW Numerical method and Computer-Aided Engineering; Phsical problems; Mathematical models; Finite element method;. B Elements and nodes, natural coordinates,

More information

Numerical Modelling in Geosciences

Numerical Modelling in Geosciences Numerical Modelling in Geosciences Dave A. May (ETHZ) dave.may@erdw.ethz.ch Laetitia Le Pourhiet (UPMC) Jonas Ruh (UPMC) Liang Zheng (ETHZ) Zooming In between Plates (FP7 64713) ZIP WP5.1 Short-course

More information

A Numerical Study of Several Viscoelastic Fluid Models

A Numerical Study of Several Viscoelastic Fluid Models A Numerical Study of Several Viscoelastic Fluid Models Corina Putinar January 3, 6 Abstract Viscoelastic fluids are a type of fluid with a solvent and immersed elastic filaments which create additional

More information

CHAPTER 4 BOUNDARY LAYER FLOW APPLICATION TO EXTERNAL FLOW

CHAPTER 4 BOUNDARY LAYER FLOW APPLICATION TO EXTERNAL FLOW CHAPTER 4 BOUNDARY LAYER FLOW APPLICATION TO EXTERNAL FLOW 4.1 Introduction Boundary layer concept (Prandtl 1904): Eliminate selected terms in the governing equations Two key questions (1) What are the

More information

Chapter 2. Formulation of Finite Element Method by Variational Principle

Chapter 2. Formulation of Finite Element Method by Variational Principle Chapter 2 Formulation of Finite Element Method by Variational Principle The Concept of Variation of FUNCTIONALS Variation Principle: Is to keep the DIFFERENCE between a REAL situation and an APPROXIMATE

More information

DETAILS ABOUT THE TECHNIQUE. We use a global mantle convection model (Bunge et al., 1997) in conjunction with a

DETAILS ABOUT THE TECHNIQUE. We use a global mantle convection model (Bunge et al., 1997) in conjunction with a DETAILS ABOUT THE TECHNIQUE We use a global mantle convection model (Bunge et al., 1997) in conjunction with a global model of the lithosphere (Kong and Bird, 1995) to compute plate motions consistent

More information

1 Lecture 1 Fundamental Concepts. 1.1 Introduction

1 Lecture 1 Fundamental Concepts. 1.1 Introduction 1.1 Introduction 1 ecture 1 Fundamental Concepts The finite element method is a numerical method for solving problems of engineering and physical science. Useful for problems with complicated geometries,

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

Lecture 26: Putting it all together #5... Galerkin Finite Element Methods for ODE BVPs

Lecture 26: Putting it all together #5... Galerkin Finite Element Methods for ODE BVPs Lecture 26: Putting it all together #5... Galerkin Finite Element Methods for ODE BVPs Outline 1) : Review 2) A specific Example: Piecewise linear elements 3) Computational Issues and Algorithms A) Calculation

More information

Lecture 4.5 Schemes for Parabolic Type Equations

Lecture 4.5 Schemes for Parabolic Type Equations Lecture 4.5 Schemes for Parabolic Type Equations 1 Difference Schemes for Parabolic Equations One-dimensional problems: Consider the unsteady diffusion problem (parabolic in nature) in a thin wire governed

More information

18.303: Introduction to Green s functions and operator inverses

18.303: Introduction to Green s functions and operator inverses 8.33: Introduction to Green s functions and operator inverses S. G. Johnson October 9, 2 Abstract In analogy with the inverse A of a matri A, we try to construct an analogous inverse  of differential

More information

Introduction to Finite Element Modelling in Geosciences

Introduction to Finite Element Modelling in Geosciences Introduction to Finite Element Modelling in Geosciences Dave A. May (dave.may@erdw.ethz.ch) Marcel Frehner (marcel.frehner@erdw.ethz.ch) Mike Afanasiev (ETH Zürich) Patrick Sanan (USI Lugano) 651-4144-L

More information

Numerical Integration (Quadrature) Another application for our interpolation tools!

Numerical Integration (Quadrature) Another application for our interpolation tools! Numerical Integration (Quadrature) Another application for our interpolation tools! Integration: Area under a curve Curve = data or function Integrating data Finite number of data points spacing specified

More information

ME8230 Nonlinear Dynamics

ME8230 Nonlinear Dynamics ME8230 Nonlinear Dynamics Lecture 1, part 1 Introduction, some basic math background, and some random examples Prof. Manoj Srinivasan Mechanical and Aerospace Engineering srinivasan.88@osu.edu Spring mass

More information

Rheology III. Ideal materials Laboratory tests Power-law creep The strength of the lithosphere The role of micromechanical defects in power-law creep

Rheology III. Ideal materials Laboratory tests Power-law creep The strength of the lithosphere The role of micromechanical defects in power-law creep Rheology III Ideal materials Laboratory tests Power-law creep The strength of the lithosphere The role of micromechanical defects in power-law creep Ideal materials fall into one of the following categories:

More information

What make cloth hard to simulate?

What make cloth hard to simulate? Cloth Simulation What make cloth hard to simulate? Due to the thin and flexible nature of cloth, it produces detailed folds and wrinkles, which in turn can lead to complicated selfcollisions. Cloth is

More information

Partial Differential Equations

Partial Differential Equations Next: Using Matlab Up: Numerical Analysis for Chemical Previous: Ordinary Differential Equations Subsections Finite Difference: Elliptic Equations The Laplace Equations Solution Techniques Boundary Conditions

More information

Linear Equations in Linear Algebra

Linear Equations in Linear Algebra 1 Linear Equations in Linear Algebra 1.1 SYSTEMS OF LINEAR EQUATIONS LINEAR EQUATION,, 1 n A linear equation in the variables equation that can be written in the form a a a b 1 1 2 2 n n a a is an where

More information

Bake, shake or break - and other applications for the FEM. 5: Do real-life experimentation using your FEM code

Bake, shake or break - and other applications for the FEM. 5: Do real-life experimentation using your FEM code Bake, shake or break - and other applications for the FEM Programming project in TMA4220 - part 2 by Kjetil André Johannessen TMA4220 - Numerical solution of partial differential equations using the finite

More information

Stress, Strain, and Viscosity. San Andreas Fault Palmdale

Stress, Strain, and Viscosity. San Andreas Fault Palmdale Stress, Strain, and Viscosity San Andreas Fault Palmdale Solids and Liquids Solid Behavior: Liquid Behavior: - elastic - fluid - rebound - no rebound - retain original shape - shape changes - small deformations

More information

7. Choice of approximating for the FE-method scalar problems

7. Choice of approximating for the FE-method scalar problems 7. Choice of approimating for the FE-method scalar problems Finite Element Method Differential Equation Weak Formulation Approimating Functions Weighted Residuals FEM - Formulation Weak form of heat flow

More information

Introduction to Geology Spring 2008

Introduction to Geology Spring 2008 MIT OpenCourseWare http://ocw.mit.edu 12.001 Introduction to Geology Spring 2008 For information about citing these materials or our Terms of Use, visit: http://ocw.mit.edu/terms. RHEOLOGICAL MODELS Rheology

More information

A high order adaptive finite element method for solving nonlinear hyperbolic conservation laws

A high order adaptive finite element method for solving nonlinear hyperbolic conservation laws A high order adaptive finite element method for solving nonlinear hyperbolic conservation laws Zhengfu Xu, Jinchao Xu and Chi-Wang Shu 0th April 010 Abstract In this note, we apply the h-adaptive streamline

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

Homework #4 Solution. μ 1. μ 2

Homework #4 Solution. μ 1. μ 2 Homework #4 Solution 4.20 in Middleman We have two viscous liquids that are immiscible (e.g. water and oil), layered between two solid surfaces, where the top boundary is translating: y = B y = kb y =

More information

General Physics I. Lecture 12: Applications of Oscillatory Motion. Prof. WAN, Xin ( 万歆 )

General Physics I. Lecture 12: Applications of Oscillatory Motion. Prof. WAN, Xin ( 万歆 ) General Physics I Lecture 1: Applications of Oscillatory Motion Prof. WAN, Xin ( 万歆 ) inwan@zju.edu.cn http://zimp.zju.edu.cn/~inwan/ Outline The pendulum Comparing simple harmonic motion and uniform circular

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

Continuum mechanism: Stress and strain

Continuum mechanism: Stress and strain Continuum mechanics deals with the relation between forces (stress, σ) and deformation (strain, ε), or deformation rate (strain rate, ε). Solid materials, rigid, usually deform elastically, that is the

More information

2.29 Numerical Fluid Mechanics Fall 2011 Lecture 27

2.29 Numerical Fluid Mechanics Fall 2011 Lecture 27 REVIEW Lecture 26: Fall 2011 Lecture 27 Solution of the Navier-Stokes Equations Pressure Correction and Projection Methods (review) Fractional Step Methods (Example using Crank-Nicholson) Streamfunction-Vorticity

More information

ALGEBRAIC FLUX CORRECTION FOR FINITE ELEMENT DISCRETIZATIONS OF COUPLED SYSTEMS

ALGEBRAIC FLUX CORRECTION FOR FINITE ELEMENT DISCRETIZATIONS OF COUPLED SYSTEMS Int. Conf. on Computational Methods for Coupled Problems in Science and Engineering COUPLED PROBLEMS 2007 M. Papadrakakis, E. Oñate and B. Schrefler (Eds) c CIMNE, Barcelona, 2007 ALGEBRAIC FLUX CORRECTION

More information

FLEXIBILITY METHOD FOR INDETERMINATE FRAMES

FLEXIBILITY METHOD FOR INDETERMINATE FRAMES UNIT - I FLEXIBILITY METHOD FOR INDETERMINATE FRAMES 1. What is meant by indeterminate structures? Structures that do not satisfy the conditions of equilibrium are called indeterminate structure. These

More information

Lecture 2: Deformation in the crust and the mantle. Read KK&V chapter 2.10

Lecture 2: Deformation in the crust and the mantle. Read KK&V chapter 2.10 Lecture 2: Deformation in the crust and the mantle Read KK&V chapter 2.10 Tectonic plates What are the structure and composi1on of tectonic plates? Crust, mantle, and lithosphere Crust relatively light

More information

Contents. Prologue Introduction. Classical Approximation... 19

Contents. Prologue Introduction. Classical Approximation... 19 Contents Prologue........................................................................ 15 1 Introduction. Classical Approximation.................................. 19 1.1 Introduction................................................................

More information

1 Stokes equations with FD on a staggered grid using the stream-function approach.

1 Stokes equations with FD on a staggered grid using the stream-function approach. Figure 1: Discretiation for the streamfunction approach. The boundary conditions are set through fictious boundary points. 1 Stokes equations with FD on a staggered grid using the stream-function approach.

More information

Finite Element Method in Geotechnical Engineering

Finite Element Method in Geotechnical Engineering Finite Element Method in Geotechnical Engineering Short Course on + Dynamics Boulder, Colorado January 5-8, 2004 Stein Sture Professor of Civil Engineering University of Colorado at Boulder Contents Steps

More information

Lecture 22: 1-D Heat Transfer.

Lecture 22: 1-D Heat Transfer. Chapter 13: Heat Transfer and Mass Transport. We will focus initially on the steady state heat transfer problem. Start by looking at the transfer of thermal energy along one dimension. With no convection

More information

Numerical Solutions of Volterra Integral Equations Using Galerkin method with Hermite Polynomials

Numerical Solutions of Volterra Integral Equations Using Galerkin method with Hermite Polynomials Proceedings of the 3 International Conference on Applied Mathematics and Computational Methods in Engineering Numerical of Volterra Integral Equations Using Galerkin method with Hermite Polynomials M.

More information

Scientific Computing I

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

More information

MITOCW MITRES2_002S10nonlinear_lec05_300k-mp4

MITOCW MITRES2_002S10nonlinear_lec05_300k-mp4 MITOCW MITRES2_002S10nonlinear_lec05_300k-mp4 The following content is provided under a Creative Commons license. Your support will help MIT OpenCourseWare continue to offer high quality educational resources

More information

DEPARTMENT OF MATHEMATICS. The University of Queensland. MATH3203 Scientific Computation: Algorithmic Design and Implementation

DEPARTMENT OF MATHEMATICS. The University of Queensland. MATH3203 Scientific Computation: Algorithmic Design and Implementation DEPARTMENT OF MATHEMATICS The University of Queensland MATH303 Scientific Computation: Algorithmic Design and Implementation Section A Boundary Value Problem in dimension Semester, 00 A simplified problem

More information

GEO E1050 Finite Element Method Autumn Lecture. 9. Nonlinear Finite Element Method & Summary

GEO E1050 Finite Element Method Autumn Lecture. 9. Nonlinear Finite Element Method & Summary GEO E1050 Finite Element Method Autumn 2016 Lecture. 9. Nonlinear Finite Element Method & Summary To learn today The lecture should give you overview of how non-linear problems in Finite Element Method

More information

Rheology. What is rheology? From the root work rheo- Current: flow. Greek: rhein, to flow (river) Like rheostat flow of current

Rheology. What is rheology? From the root work rheo- Current: flow. Greek: rhein, to flow (river) Like rheostat flow of current Rheology What is rheology? From the root work rheo- Current: flow Greek: rhein, to flow (river) Like rheostat flow of current Rheology What physical properties control deformation? - Rock type - Temperature

More information

EE C245 ME C218 Introduction to MEMS Design

EE C245 ME C218 Introduction to MEMS Design EE C245 ME C218 Introduction to MEMS Design Fall 2007 Prof. Clark T.-C. Nguyen Dept. of Electrical Engineering & Computer Sciences University of California at Berkeley Berkeley, CA 94720 Lecture 16: Energy

More information

(b) What is the amplitude at the altitude of a satellite of 400 km?

(b) What is the amplitude at the altitude of a satellite of 400 km? Practice final quiz 2015 Geodynamics 2015 1 a) Complete the following table. parameter symbol units temperature T C or K thermal conductivity heat capacity density coefficient of thermal expansion volumetric)

More information

Fall Exam II. Wed. Nov. 9, 2005

Fall Exam II. Wed. Nov. 9, 2005 Fall 005 10.34 Eam II. Wed. Nov. 9 005 (SOLUTION) Read through the entire eam before beginning work and budget your time. You are researching drug eluting stents and wish to understand better how the drug

More information

ECE 695 Numerical Simulations Lecture 12: Thermomechanical FEM. Prof. Peter Bermel February 6, 2017

ECE 695 Numerical Simulations Lecture 12: Thermomechanical FEM. Prof. Peter Bermel February 6, 2017 ECE 695 Numerical Simulations Lecture 12: Thermomechanical FEM Prof. Peter Bermel February 6, 2017 Outline Static Equilibrium Dynamic Equilibrium Thermal transport mechanisms Thermal transport modeling

More information

A Fast Solver for the Stokes Equations. Tejaswin Parthasarathy CS 598APK, Fall 2017

A Fast Solver for the Stokes Equations. Tejaswin Parthasarathy CS 598APK, Fall 2017 A Fast Solver for the Stokes Equations Tejaswin Parthasarathy CS 598APK, Fall 2017 Stokes Equations? http://www.earthtimes.org/ Continuity wallpapers-s.blogspot.com @ @t + @( u i) @ i =0 http://testingstufftonight.blogspot.com/

More information

An Introductory Course on Modelling of Multiphysics Problems

An Introductory Course on Modelling of Multiphysics Problems An Introductory Course on Modelling of Multiphysics Problems Introductory Course on Multiphysics Modelling TOMASZ G. ZIELIŃSKI bluebox.ippt.pan.pl/ tzielins/ Institute of Fundamental Technological Research

More information

Unit 4 Lesson 3 Mountain Building. Copyright Houghton Mifflin Harcourt Publishing Company

Unit 4 Lesson 3 Mountain Building. Copyright Houghton Mifflin Harcourt Publishing Company Stressed Out How can tectonic plate motion cause deformation? The movement of tectonic plates causes stress on rock structures. Stress is the amount of force per unit area that is placed on an object.

More information

Chapter 6. Legendre and Bessel Functions

Chapter 6. Legendre and Bessel Functions Chapter 6 Legendre and Bessel Functions Legendre's Equation Legendre's Equation (order n): legendre d K y''k y'c n n C y = : is an important ode in applied mathematics When n is a non-negative integer,

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

Mathematical Model of Forced Van Der Pol s Equation

Mathematical Model of Forced Van Der Pol s Equation Mathematical Model of Forced Van Der Pol s Equation TO Tsz Lok Wallace LEE Tsz Hong Homer December 9, Abstract This work is going to analyze the Forced Van Der Pol s Equation which is used to analyze the

More information

3.1: 1, 3, 5, 9, 10, 12, 14, 18

3.1: 1, 3, 5, 9, 10, 12, 14, 18 3.:, 3, 5, 9,,, 4, 8 ) We want to solve d d c() d = f() with c() = c = constant and f() = for different boundary conditions to get w() and u(). dw d = dw d d = ( )d w() w() = w() = w() ( ) c d d = u()

More information

Lecture 12: Finite Elements

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

More information

Due Tuesday, September 21 st, 12:00 midnight

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

More information

A STUDY ON THE FRACTURE A SIROCCO FAN IMPELLER

A STUDY ON THE FRACTURE A SIROCCO FAN IMPELLER FIFTH INTERNATIONAL CONGRESS ON SOUND AND VIBRATION DECEMBER 15-18, 1997 ADELAIDE, SOUTH AUSTRALIA A STUDY ON THE FRACTURE A SIROCCO FAN IMPELLER OF S.P. Lee, C.O. Ahn, H.S. Rew, S.C. Park, Y.M. Park and

More information

Interconnection Relationships. Derive Input/Output Models. School of Mechanical Engineering Purdue University

Interconnection Relationships. Derive Input/Output Models. School of Mechanical Engineering Purdue University hermal Systems Basic Modeling Elements esistance esistance Conduction Convection adiation Capacitance Interconnection elationships Energy Balance - st Law of hermodynamics Derive Input/Output Models ME375

More information

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

Finite Element Analysis Prof. Dr. B. N. Rao Department of Civil Engineering Indian Institute of Technology, Madras. Lecture - 06 Finite Element Analysis Prof. Dr. B. N. Rao Department of Civil Engineering Indian Institute of Technology, Madras Lecture - 06 In the last lecture, we have seen a boundary value problem, using the formal

More information

Theoretical Manual Theoretical background to the Strand7 finite element analysis system

Theoretical Manual Theoretical background to the Strand7 finite element analysis system Theoretical Manual Theoretical background to the Strand7 finite element analysis system Edition 1 January 2005 Strand7 Release 2.3 2004-2005 Strand7 Pty Limited All rights reserved Contents Preface Chapter

More information

Chapter 5. Formulation of FEM for Unsteady Problems

Chapter 5. Formulation of FEM for Unsteady Problems Chapter 5 Formulation of FEM for Unsteady Problems Two alternatives for formulating time dependent problems are called coupled space-time formulation and semi-discrete formulation. The first one treats

More information

Dynamical Systems. 1.0 Ordinary Differential Equations. 2.0 Dynamical Systems

Dynamical Systems. 1.0 Ordinary Differential Equations. 2.0 Dynamical Systems . Ordinary Differential Equations. An ordinary differential equation (ODE, for short) is an equation involves a dependent variable and its derivatives with respect to an independent variable. When we speak

More information

DYNAMICAL SYNTHESIS OF OSCILLATING SYSTEM MASS-SPRING-MAGNET

DYNAMICAL SYNTHESIS OF OSCILLATING SYSTEM MASS-SPRING-MAGNET DYNAMICAL SYNTHESIS OF OSCILLATING SYSTEM MASS-SPRING-MAGNET Rumen NIKOLOV, Todor TODOROV Technical University of Sofia, Bulgaria Abstract. On the basis of a qualitative analysis of nonlinear differential

More information

dw 2 3(w) x 4 x 4 =L x 3 x 1 =0 x 2 El #1 El #2 El #3 Potential energy of element 3: Total potential energy Potential energy of element 1:

dw 2 3(w) x 4 x 4 =L x 3 x 1 =0 x 2 El #1 El #2 El #3 Potential energy of element 3: Total potential energy Potential energy of element 1: MAE 44 & CIV 44 Introduction to Finite Elements Reading assignment: ecture notes, ogan. Summary: Pro. Suvranu De Finite element ormulation or D elasticity using the Rayleigh-Ritz Principle Stiness matri

More information

Problem 1. Solve the following boundary problem with the Ritz method:

Problem 1. Solve the following boundary problem with the Ritz method: Eamples on Variational Methods for Solving Boundary Problems for Ordinary Differential Equations (ODE) of the Second Order (Galerkin and Ritz methods) Problem Solve the following boundary problem with

More information

Introduction to Finite Element Analysis (FEA) or Finite Element Method (FEM)

Introduction to Finite Element Analysis (FEA) or Finite Element Method (FEM) Introduction to Finite Element Analysis (FEA) or Finite Element Method (FEM) Finite Element Analysis (FEA) or Finite Element Method (FEM) The Finite Element Analysis (FEA) is a numerical method for solving

More information

Introduction to Computational Stochastic Differential Equations

Introduction to Computational Stochastic Differential Equations Introduction to Computational Stochastic Differential Equations Gabriel J. Lord Catherine E. Powell Tony Shardlow Preface Techniques for solving many of the differential equations traditionally used by

More information

Finite Element Solution of Nonlinear Transient Rock Damage with Application in Geomechanics of Oil and Gas Reservoirs

Finite Element Solution of Nonlinear Transient Rock Damage with Application in Geomechanics of Oil and Gas Reservoirs Finite Element Solution of Nonlinear Transient Rock Damage with Application in Geomechanics of Oil and Gas Reservoirs S. Enayatpour*1, T. Patzek2 1,2 The University of Texas at Austin *Corresponding author:

More information

Computation Time Assessment of a Galerkin Finite Volume Method (GFVM) for Solving Time Solid Mechanics Problems under Dynamic Loads

Computation Time Assessment of a Galerkin Finite Volume Method (GFVM) for Solving Time Solid Mechanics Problems under Dynamic Loads Proceedings of the International Conference on Civil, Structural and Transportation Engineering Ottawa, Ontario, Canada, May 4 5, 215 Paper o. 31 Computation Time Assessment of a Galerkin Finite Volume

More information

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

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

More information

Geodynamics of congested subduction zones - implications for evolution of the Tasmanides

Geodynamics of congested subduction zones - implications for evolution of the Tasmanides Geodynamics of congested subduction zones - implications for evolution of the Tasmanides Pete Betts - School of Earth, Atmosphere, and environment, Monash University Louis Moresi Department of Earth Sciences,

More information

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

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

More information

Geodynamics. Heat conduction and production Lecture Heat production. Lecturer: David Whipp

Geodynamics. Heat conduction and production Lecture Heat production. Lecturer: David Whipp Geodynamics Heat conduction and production Lecture 7.3 - Heat production Lecturer: David Whipp david.whipp@helsinki.fi Geodynamics www.helsinki.fi/yliopisto 1 Goals of this lecture Discuss radiogenic heat

More information

Journal of Applied Mathematics and Computation (JAMC), 2018, 2(7),

Journal of Applied Mathematics and Computation (JAMC), 2018, 2(7), Journal of Applied Mathematics and Computation (JAMC), 2018, 2(7), 266-270 http://www.hillpublisher.org/journal/jamc ISSN Online:2576-0645 ISSN Print:2576-0653 The Solution Of 2D Hydrodynamic Equations

More information

Homework 6: Energy methods, Implementing FEA.

Homework 6: Energy methods, Implementing FEA. EN75: Advanced Mechanics of Solids Homework 6: Energy methods, Implementing FEA. School of Engineering Brown University. The figure shows a eam with clamped ends sujected to a point force at its center.

More information

Introduction to Chemical Engineering Computing, 2 nd edition, Bruce A. Finlayson, Wiley (2012)

Introduction to Chemical Engineering Computing, 2 nd edition, Bruce A. Finlayson, Wiley (2012) Introduction to Chemical Engineering Computing, 2 nd edition, Bruce A. Finlayson, Wiley (2012) The following web sites can be used to obtain material from Wiley. It includes the keys to the problems (useful

More information

Lecture 6 mechanical system modeling equivalent mass gears

Lecture 6 mechanical system modeling equivalent mass gears M2794.25 Mechanical System Analysis 기계시스템해석 lecture 6,7,8 Dongjun Lee ( 이동준 ) Department of Mechanical & Aerospace Engineering Seoul National University Dongjun Lee Lecture 6 mechanical system modeling

More information