Electro-Thermal-Mechanical MEMS Devices Multi-Physics Problems

Size: px
Start display at page:

Download "Electro-Thermal-Mechanical MEMS Devices Multi-Physics Problems"

Transcription

1 Electro-Thermal-Mechanical MEMS Devices Multi-Physics Problems Presentation for ASEN 5519 Joseph Pajot Department of Aerospace Engineering CU Boulder November 15, 2004 Typeset by FoilTEX 1

2 The ETM Problems Background Electro-thermal-mechanical coupling Joule heating Thermal expansion Application MEMS Typeset by FoilTEX 2

3 The ETM Problem: Electrostatic Governing Physics Poisson Equation ( ) V σ xx x x + y ( σ yy V y ) + z ( σ zz V z ) = z Isotopic conduction (σ = σ xx = σ yy = σ zz ) σ 2 V = z Electrostatic conduction finite element discretization R E = K E V Z = 0 V = ˆV on Ω V Z = Ẑ on Ω Z Typeset by FoilTEX 3

4 The ETM Problem: Electrostatic Governing Physics Poisson Equation x ( ) V σ xx x + y ( σ yy V y ) + z ( σ zz V z ) = z Isotopic conduction (σ = σ xx = σ yy = σ zz ) σ 2 V = z Electrostatic conduction finite element discretization R E = K E V = 0 V = ˆV on Ω V Typeset by FoilTEX 4

5 The ETM Problem: Coupling Electrothermal Joule Heating q = J E J = σe E = V Element expression Q J = Ω σe T EdΩ Typeset by FoilTEX 5

6 The ETM Problem: Thermal Governing Physics Poisson Equation ( ) T k xx x x + y ( ) T k yy y + z ( ) T k zz z = q Isotopic conduction (k = k xx = k yy = k zz ) k 2 T = q Conduction finite element discretization R Q = K Q T Q ext = 0 T = ˆT T = ˆf on Ω T on Ω F Typeset by FoilTEX 6

7 The ETM Problem: Thermal Governing Physics R Q = K Q T Q ext = 0 T = ˆT T = ˆf on Ω T on Ω F Q ext contributions 1. Joule heating 2. Convection 3. Radiation Typeset by FoilTEX 7

8 The ETM Problem: Thermal Convection Convective bc s proportional to temperature Q c h(t T) For shell elements convecting through one lateral side Q c = K c (T T) Typeset by FoilTEX 8

9 The ETM Problem: Thermal Radiation Blackbody radiation proportional to temperature to the fourth Q r h r (T 4 r T 4 ) Element radiation from one end will produce load vector Q r = N (e) h r (T 4 r T 4 )dω Ω Linearization of residual ( K Q + K c Q ) r T T + R Q (T ) = 0 K Q T + R Q (T ) = 0 Typeset by FoilTEX 9

10 The ETM Problem: Coupling Thermal strain (in plane) Structural-Thermal e t ij = { αij (T T 0 ) if i = j = 1, 2 0 else Elemental external force f ext = Ω C ijkl e t kldω Element orientation independent force in local coord Typeset by FoilTEX 10

11 The ETM Problem: Structure Governing Physics Continuum mechanics σ ij + p i = 0 u i = ū i σ ij n j = ˆt i on Ω u on Ω t TPE functional Π[u] = U W = Ω σ ij e ij dω σ ij = C ijkl (e kl e t kl) Ω p i u i dω Ω t ˆt i n i dω t Typeset by FoilTEX 11

12 The ETM Problem Governing Equations Residual finite element equations in each domain Structural: R S = f int (u) f ext (u, T) = 0 Thermal: R Q = Q int (u, T) Q ext (u, V) = 0 Electrostatic: R E = Z int (u, V) Z ext = 0 K T R Q ext f T 0 u K Q Qext V R E u 0 K E u (n) T (n) V (n) u (n+1) = u (n) + u (n) T (n+1) = T (n) + T (n) V (n+1) = V (n) + V (n) = R (n) S R (n) Q R (n) E Typeset by FoilTEX 12

13 The ETM Problem Governing Equations Residual finite element equations in each domain Structural: R S = f int (u) f ext (u, T) = 0 K T K Q K E Thermal: R Q = Q int (u, T) Q ext (u, V) = 0 Electrostatic: R E = Z int (u, V) Z ext = 0 u (n) T (n) = V (n) u (n+1) = u (n) + u (n) T (n+1) = T (n) + T (n) V (n+1) = V (n) + V (n) R S (u (n), T (n) ) R Q (u (n), T (n), V (n) ) R E (u (n), V (n) ) Typeset by FoilTEX 13

14 The ETM Problem: Coupling One Way Coupling The Linearized operator Φ = K T R Q ext f T 0 u K Q Qext V R E u 0 K E Assume thermal and electrostatic independent of structural response R Q u = 0 R E u = 0 Typeset by FoilTEX 14

15 The ETM Problem: Coupling One Way Coupling The one way linearized operator Φ = ext f T 0 0 K Q Qext V 0 0 K E K T Eliminate costly computations Upper diagonal one solve per domain Effect on solution/accuracy? Typeset by FoilTEX 15

16 The ETM Problem: Verification Energy Balance Check that power balance is correct Electrical Power in equals thermal dissipation Electrical Power: P = IV = I 2 R = V/R 2 I = J ˆndA Thermal Power: P = ˆf ˆndA ˆf = k T Typeset by FoilTEX 16

17 The ETM Problem: Solution How does one run these problems Modularity Parallel computation One-to-one interface Body is the interface Solution Procedure Typeset by FoilTEX 17

18 The ETM Problem: Solution Modularity Which values should be sent from code to code? Codes should be kept dumb to each other Thermal codes at the middle of coupling Master-slave relationship Typeset by FoilTEX 18

19 Modular requirements The ETM Problem: Solution Parallel computation Split problem into manageable sizes Φ = ext f T 0 0 K Q Qext V 0 0 K E K T If domains have 10k nodes, full system is larger than 30k by 30k! Typeset by FoilTEX 19

20 The ETM Problem: Solution Parallel computation Handling communications between domains (e.g. MPI) Nontrivial issue Pass minimum amount of information (vectors vs matrix) Computations carried out within each domain Resultants sent back Typeset by FoilTEX 20

21 The ETM Problem: Parallel Computation Optimization 1. Problem definition min s z(s) g i (s) 0 h i (s) = 0 s L s s U 2. Analysis of physical fields (FEM) - Optimization criteria q = q(s, u(s), T(s), V(s)) - State variables u = u(s), T = T(s), V = V(s) Typeset by FoilTEX 21

22 ETM Optimization Background Linking optimization variables to physical problem Size optimization Shape optimization Typeset by FoilTEX 22

23 ETM Optimization Background Topology optimization is a material distribution problem Indicator function χ χ(r) = { 1 r Ω1 0 r Ω 0 Ω = Ω 0 Ω 1 Typeset by FoilTEX 23

24 ETM Optimization Sensitivity Analysis Require criteria gradients dq j = q j + q j du + q j dt + q j dv s i u T V Differentiate Finite Element Residual Equations with respect to s i K T R Q ext f T 0 u K Q Qext V R E u 0 K E du dt dv = Φ du dt dv = R S s i R Q s i R E s i Typeset by FoilTEX 24

25 ETM Optimization Sensitivity Analysis Rewrite criteria sensitivity expression dq j = q j s i [ qj u q j T q j V ] Φ 1 R S s i R Q s i R E s i Matrix-vector solves required Minimize this expensive procedure Direct vs Adjoint Typeset by FoilTEX 25

26 K T R Q ETM Optimization Staggered Solution ext f T 0 u K Q Qext V R E u 0 K E du dt dv = Gauss-Seidel solve on submatricies R S s i R Q s i R E s i K T K Q K E du dt dv = R Q s i R S s i + R Q u R E s i f ext dt T du + Qext V R E u du dv Effect of one way coupling? Typeset by FoilTEX 26

27 ETM Optimization Examples Maximize output force Uses less than 30% of available mass (d) Current Density (e) Temperature (f) Deformation Typeset by FoilTEX 27

28 ETM Optimization Examples Maximize output force Uses less than 30% of available mass (a) Current Density (b) Temperature (c) Deformation Typeset by FoilTEX 28

29 ETM Optimization Examples Maximize output force Uses less than 30% of available mass (a) Current Density (b) Temperature (c) Deformation Typeset by FoilTEX 29

Fundamentals of Linear Elasticity

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

More information

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

Mechanics PhD Preliminary Spring 2017

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

More information

NONLINEAR CONTINUUM FORMULATIONS CONTENTS

NONLINEAR CONTINUUM FORMULATIONS CONTENTS NONLINEAR CONTINUUM FORMULATIONS CONTENTS Introduction to nonlinear continuum mechanics Descriptions of motion Measures of stresses and strains Updated and Total Lagrangian formulations Continuum shell

More information

Variational principles in mechanics

Variational principles in mechanics CHAPTER Variational principles in mechanics.1 Linear Elasticity n D Figure.1: A domain and its boundary = D [. Consider a domain Ω R 3 with its boundary = D [ of normal n (see Figure.1). The problem of

More information

16.20 HANDOUT #2 Fall, 2002 Review of General Elasticity

16.20 HANDOUT #2 Fall, 2002 Review of General Elasticity 6.20 HANDOUT #2 Fall, 2002 Review of General Elasticity NOTATION REVIEW (e.g., for strain) Engineering Contracted Engineering Tensor Tensor ε x = ε = ε xx = ε ε y = ε 2 = ε yy = ε 22 ε z = ε 3 = ε zz =

More information

PEAT SEISMOLOGY Lecture 2: Continuum mechanics

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

More information

Fig. 1. Circular fiber and interphase between the fiber and the matrix.

Fig. 1. Circular fiber and interphase between the fiber and the matrix. Finite element unit cell model based on ABAQUS for fiber reinforced composites Tian Tang Composites Manufacturing & Simulation Center, Purdue University West Lafayette, IN 47906 1. Problem Statement In

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

Boundary Value Problems - Solving 3-D Finite-Difference problems Jacob White

Boundary Value Problems - Solving 3-D Finite-Difference problems Jacob White Introduction to Simulation - Lecture 2 Boundary Value Problems - Solving 3-D Finite-Difference problems Jacob White Thanks to Deepak Ramaswamy, Michal Rewienski, and Karen Veroy Outline Reminder about

More information

Problem Set #3: 2.11, 2.15, 2.21, 2.26, 2.40, 2.42, 2.43, 2.46 (Due Thursday Feb. 27th)

Problem Set #3: 2.11, 2.15, 2.21, 2.26, 2.40, 2.42, 2.43, 2.46 (Due Thursday Feb. 27th) Chapter Electrostatics Problem Set #3:.,.5,.,.6,.40,.4,.43,.46 (Due Thursday Feb. 7th). Coulomb s Law Coulomb showed experimentally that for two point charges the force is - proportional to each of the

More information

LASER GENERATED THERMOELASTIC WAVES IN AN ANISOTROPIC INFINITE PLATE

LASER GENERATED THERMOELASTIC WAVES IN AN ANISOTROPIC INFINITE PLATE LASER GENERATED THERMOELASTIC WAVES IN AN ANISOTROPIC INFINITE PLATE H. M. Al-Qahtani and S. K. Datta University of Colorado Boulder CO 839-7 ABSTRACT. An analysis of the propagation of thermoelastic waves

More information

BAR ELEMENT WITH VARIATION OF CROSS-SECTION FOR GEOMETRIC NON-LINEAR ANALYSIS

BAR ELEMENT WITH VARIATION OF CROSS-SECTION FOR GEOMETRIC NON-LINEAR ANALYSIS Journal of Computational and Applied Mechanics, Vol.., No. 1., (2005), pp. 83 94 BAR ELEMENT WITH VARIATION OF CROSS-SECTION FOR GEOMETRIC NON-LINEAR ANALYSIS Vladimír Kutiš and Justín Murín Department

More information

5.80 Small-Molecule Spectroscopy and Dynamics

5.80 Small-Molecule Spectroscopy and Dynamics MIT OpenCourseWare http://ocw.mit.edu 5.80 Small-Molecule Spectroscopy and Dynamics Fall 2008 For information about citing these materials or our Terms of Use, visit: http://ocw.mit.edu/terms. 5.80 Lecture

More information

The Finite Element Method

The Finite Element Method The Finite Element Method 3D Problems Heat Transfer and Elasticity Read: Chapter 14 CONTENTS Finite element models of 3-D Heat Transfer Finite element model of 3-D Elasticity Typical 3-D Finite Elements

More information

Residual Force Equations

Residual Force Equations 3 Residual Force Equations NFEM Ch 3 Slide 1 Total Force Residual Equation Vector form r(u,λ) = 0 r = total force residual vector u = state vector with displacement DOF Λ = array of control parameters

More information

Alternative numerical method in continuum mechanics COMPUTATIONAL MULTISCALE. University of Liège Aerospace & Mechanical Engineering

Alternative numerical method in continuum mechanics COMPUTATIONAL MULTISCALE. University of Liège Aerospace & Mechanical Engineering University of Liège Aerospace & Mechanical Engineering Alternative numerical method in continuum mechanics COMPUTATIONAL MULTISCALE Van Dung NGUYEN Innocent NIYONZIMA Aerospace & Mechanical engineering

More information

Two Posts to Fill On School Board

Two Posts to Fill On School Board Y Y 9 86 4 4 qz 86 x : ( ) z 7 854 Y x 4 z z x x 4 87 88 Y 5 x q x 8 Y 8 x x : 6 ; : 5 x ; 4 ( z ; ( ) ) x ; z 94 ; x 3 3 3 5 94 ; ; ; ; 3 x : 5 89 q ; ; x ; x ; ; x : ; ; ; ; ; ; 87 47% : () : / : 83

More information

Peter Hertel. University of Osnabrück, Germany. Lecture presented at APS, Nankai University, China.

Peter Hertel. University of Osnabrück, Germany. Lecture presented at APS, Nankai University, China. Balance University of Osnabrück, Germany Lecture presented at APS, Nankai University, China http://www.home.uni-osnabrueck.de/phertel Spring 2012 Linear and angular momentum and First and Second Law point

More information

12. Stresses and Strains

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

More information

Vorticity and Dynamics

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

More information

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

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

BACKGROUNDS. Two Models of Deformable Body. Distinct Element Method (DEM)

BACKGROUNDS. Two Models of Deformable Body. Distinct Element Method (DEM) BACKGROUNDS Two Models of Deformable Body continuum rigid-body spring deformation expressed in terms of field variables assembly of rigid-bodies connected by spring Distinct Element Method (DEM) simple

More information

3D and Planar Constitutive Relations

3D and Planar Constitutive Relations 3D and Planar Constitutive Relations A School on Mechanics of Fibre Reinforced Polymer Composites Knowledge Incubation for TEQIP Indian Institute of Technology Kanpur PM Mohite Department of Aerospace

More information

Ritz Method. Introductory Course on Multiphysics Modelling

Ritz Method. Introductory Course on Multiphysics Modelling Ritz Method Introductory Course on Multiphysics Modelling TOMASZ G. ZIELIŃSKI bluebox.ippt.pan.pl/ tzielins/ Institute of Fundamental Technological Research of the Polish Academy of Sciences Warsaw Poland

More information

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

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

More information

Phase Equilibria and Molecular Solutions Jan G. Korvink and Evgenii Rudnyi IMTEK Albert Ludwig University Freiburg, Germany

Phase Equilibria and Molecular Solutions Jan G. Korvink and Evgenii Rudnyi IMTEK Albert Ludwig University Freiburg, Germany Phase Equilibria and Molecular Solutions Jan G. Korvink and Evgenii Rudnyi IMTEK Albert Ludwig University Freiburg, Germany Preliminaries Learning Goals Phase Equilibria Phase diagrams and classical thermodynamics

More information

The Generalized Interpolation Material Point Method

The Generalized Interpolation Material Point Method Compaction of a foam microstructure The Generalized Interpolation Material Point Method Tungsten Particle Impacting sandstone The Material Point Method (MPM) 1. Lagrangian material points carry all state

More information

The Plane Stress Problem

The Plane Stress Problem 14 The Plane Stress Problem IFEM Ch 14 Slide 1 Plate in Plane Stress Thickness dimension or transverse dimension z Top surface Inplane dimensions: in, plane IFEM Ch 14 Slide 2 Mathematical Idealization

More information

Modelling and numerical simulation of the wrinkling evolution for thermo-mechanical loading cases

Modelling and numerical simulation of the wrinkling evolution for thermo-mechanical loading cases Modelling and numerical simulation of the wrinkling evolution for thermo-mechanical loading cases Georg Haasemann Conrad Kloß 1 AIMCAL Conference 2016 MOTIVATION Wrinkles in web handling system Loss of

More information

Introduction to Electrostatics

Introduction to Electrostatics Chapter 1 Introduction to Electrostatics Problem Set #1: 1.5, 1.7, 1.12 (Due Monday Feb. 11th) 1.1 Electric field Coulomb showed experimentally that for two point charges the force is -proportionaltoeachofthecharges,

More information

OWELL WEEKLY JOURNAL

OWELL WEEKLY JOURNAL Y \»< - } Y Y Y & #»»» q ] q»»»>) & - - - } ) x ( - { Y» & ( x - (» & )< - Y X - & Q Q» 3 - x Q Y 6 \Y > Y Y X 3 3-9 33 x - - / - -»- --

More information

Uncertainty Quantification in MEMS

Uncertainty Quantification in MEMS Uncertainty Quantification in MEMS N. Agarwal and N. R. Aluru Department of Mechanical Science and Engineering for Advanced Science and Technology Introduction Capacitive RF MEMS switch Comb drive Various

More information

Continuum mechanics V. Constitutive equations. 1. Constitutive equation: definition and basic axioms

Continuum mechanics V. Constitutive equations. 1. Constitutive equation: definition and basic axioms Continuum mechanics office Math 0.107 ales.janka@unifr.ch http://perso.unifr.ch/ales.janka/mechanics Mars 16, 2011, Université de Fribourg 1. Constitutive equation: definition and basic axioms Constitutive

More information

AA242B: MECHANICAL VIBRATIONS

AA242B: MECHANICAL VIBRATIONS AA242B: MECHANICAL VIBRATIONS 1 / 57 AA242B: MECHANICAL VIBRATIONS Dynamics of Continuous Systems These slides are based on the recommended textbook: M. Géradin and D. Rixen, Mechanical Vibrations: Theory

More information

Lecture 18 Classical Iterative Methods

Lecture 18 Classical Iterative Methods Lecture 18 Classical Iterative Methods MIT 18.335J / 6.337J Introduction to Numerical Methods Per-Olof Persson November 14, 2006 1 Iterative Methods for Linear Systems Direct methods for solving Ax = b,

More information

Poisson Equation in 2D

Poisson Equation in 2D A Parallel Strategy Department of Mathematics and Statistics McMaster University March 31, 2010 Outline Introduction 1 Introduction Motivation Discretization Iterative Methods 2 Additive Schwarz Method

More information

A Framework for Analyzing and Constructing Hierarchical-Type A Posteriori Error Estimators

A Framework for Analyzing and Constructing Hierarchical-Type A Posteriori Error Estimators A Framework for Analyzing and Constructing Hierarchical-Type A Posteriori Error Estimators Jeff Ovall University of Kentucky Mathematics www.math.uky.edu/ jovall jovall@ms.uky.edu Kentucky Applied and

More information

COMPUTATIONAL MODELING OF SHAPE MEMORY MATERIALS

COMPUTATIONAL MODELING OF SHAPE MEMORY MATERIALS COMPUTATIONAL MODELING OF SHAPE MEMORY MATERIALS Jan Valdman Institute of Information Theory and Automation, Czech Academy of Sciences (Prague) based on joint works with Martin Kružík and Miroslav Frost

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

Continuum Mechanics. Continuum Mechanics and Constitutive Equations

Continuum Mechanics. Continuum Mechanics and Constitutive Equations Continuum Mechanics Continuum Mechanics and Constitutive Equations Continuum mechanics pertains to the description of mechanical behavior of materials under the assumption that the material is a uniform

More information

Continuum Topology Optimization of Buckling-Sensitive Structures

Continuum Topology Optimization of Buckling-Sensitive Structures Continuum Topology Optimization of Buckling-Sensitive Structures Salam Rahmatalla, Ph.D Student Colby C. Swan, Associate Professor Civil & Environmental Engineering Center for Computer-Aided Design The

More information

JACOBI S ITERATION METHOD

JACOBI S ITERATION METHOD ITERATION METHODS These are methods which compute a sequence of progressively accurate iterates to approximate the solution of Ax = b. We need such methods for solving many large linear systems. Sometimes

More information

Analysis of Electro-thermal Stress and Strain in a Functionally Graded Metal Line under Direct Current Field

Analysis of Electro-thermal Stress and Strain in a Functionally Graded Metal Line under Direct Current Field IOSR Journal of Mechanical and Civil Engineering (IOSR-JMCE) e-issn: 78-68,p-ISSN: -X, Volume, Issue Ver. II (Sep. - Oct. ), PP 7-8 www.iosrjournals.org Analysis of Electro-thermal Stress and Strain in

More information

Optimal thickness of a cylindrical shell under dynamical loading

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

More information

1 Hooke s law, stiffness, and compliance

1 Hooke s law, stiffness, and compliance Non-quilibrium Continuum Physics TA session #5 TA: Yohai Bar Sinai 3.04.206 Linear elasticity I This TA session is the first of three at least, maybe more) in which we ll dive deep deep into linear elasticity

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

Lecture 8: Tissue Mechanics

Lecture 8: Tissue Mechanics Computational Biology Group (CoBi), D-BSSE, ETHZ Lecture 8: Tissue Mechanics Prof Dagmar Iber, PhD DPhil MSc Computational Biology 2015/16 7. Mai 2016 2 / 57 Contents 1 Introduction to Elastic Materials

More information

Vibro-acoustic response of FGM plates considering the thermal effects Tieliang Yang1, a, Qibai Huang1, *

Vibro-acoustic response of FGM plates considering the thermal effects Tieliang Yang1, a, Qibai Huang1, * 3rd International Conference on Materials Engineering, Manufacturing Technology and Control (ICMEMTC 2016) Vibro-acoustic response of FGM plates considering the thermal effects Tieliang Yang1, a, Qibai

More information

The Finite Element Method for the Analysis of Non-Linear and Dynamic Systems

The Finite Element Method for the Analysis of Non-Linear and Dynamic Systems The Finite Element Method for the Analysis of Non-Linear and Dynamic Systems Prof. Dr. Eleni Chatzi Dr. Giuseppe Abbiati, Dr. Konstantinos Agathos Lecture 1-21 September, 2017 Institute of Structural Engineering

More information

Optimized Surface Acoustic Waves Devices With FreeFem++ Using an Original FEM/BEM Numerical Model

Optimized Surface Acoustic Waves Devices With FreeFem++ Using an Original FEM/BEM Numerical Model Optimized Surface Acoustic Waves Devices With FreeFem++ Using an Original FEM/BEM Numerical Model P. Ventura*, F. Hecht**, Pierre Dufilié*** *PV R&D Consulting, Nice, France Laboratoire LEM3, Université

More information

NMR: Formalism & Techniques

NMR: Formalism & Techniques NMR: Formalism & Techniques Vesna Mitrović, Brown University Boulder Summer School, 2008 Why NMR? - Local microscopic & bulk probe - Can be performed on relatively small samples (~1 mg +) & no contacts

More information

Introduction to Heat and Mass Transfer. Week 7

Introduction to Heat and Mass Transfer. Week 7 Introduction to Heat and Mass Transfer Week 7 Example Solution Technique Using either finite difference method or finite volume method, we end up with a set of simultaneous algebraic equations in terms

More information

Finite Element simulations of a phase-field model for mode-iii fracture. by V. Kaushik

Finite Element simulations of a phase-field model for mode-iii fracture. by V. Kaushik Finite Element simulations of a phase-field model for mode-iii fracture. by V. Kaushik 1 Motivation The motivation behind this model is to understand the underlying physics behind branching of cracks during

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

Introduction to fracture mechanics

Introduction to fracture mechanics Introduction to fracture mechanics Prof. Dr. Eleni Chatzi Dr. Giuseppe Abbiati, Dr. Konstantinos Agathos Lecture 6-9 November, 2017 Institute of Structural Engineering, ETH Zu rich November 9, 2017 Institute

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

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

Heat Transfer Analysis

Heat Transfer Analysis Heat Transfer 2011 Alex Grishin MAE 323 Chapter 8: Grishin 1 In engineering applications, heat is generally transferred from one location to another and between bodies. This transfer is driven by differences

More information

Getting started: CFD notation

Getting started: CFD notation PDE of p-th order Getting started: CFD notation f ( u,x, t, u x 1,..., u x n, u, 2 u x 1 x 2,..., p u p ) = 0 scalar unknowns u = u(x, t), x R n, t R, n = 1,2,3 vector unknowns v = v(x, t), v R m, m =

More information

Lecture 15: Revisiting bars and beams.

Lecture 15: Revisiting bars and beams. 3.10 Potential Energy Approach to Derive Bar Element Equations. We place assumptions on the stresses developed inside the bar. The spatial stress and strain matrices become very sparse. We add (ad-hoc)

More information

1. Vladimir MILOVANOVIĆ, 2. Dragan RAKIĆ, 3. Miroslav ŽIVKOVIĆ, 4. Snežana VULOVIĆ, 5. Miroslav MILUTINOVIĆ

1. Vladimir MILOVANOVIĆ, 2. Dragan RAKIĆ, 3. Miroslav ŽIVKOVIĆ, 4. Snežana VULOVIĆ, 5. Miroslav MILUTINOVIĆ 1. Vladimir MILOVANOVIĆ, 2. Dragan RAKIĆ, 3. Miroslav ŽIVKOVIĆ, 4. Snežana VULOVIĆ, 5. Miroslav MILUTINOVIĆ THERMO-MECHANIC ANALYSIS OF CEMENT TRANSPORT WAGON - IDENTIFICATION OF THE CAUSE OF CRACKS 1-3.

More information

Finite Difference Methods for Boundary Value Problems

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

More information

Finite Element Method (FEM)

Finite Element Method (FEM) Finite Element Method (FEM) The finite element method (FEM) is the oldest numerical technique applied to engineering problems. FEM itself is not rigorous, but when combined with integral equation techniques

More information

Nonconservative Loading: Overview

Nonconservative Loading: Overview 35 Nonconservative Loading: Overview 35 Chapter 35: NONCONSERVATIVE LOADING: OVERVIEW TABLE OF CONTENTS Page 35. Introduction..................... 35 3 35.2 Sources...................... 35 3 35.3 Three

More information

Computational models of diamond anvil cell compression

Computational models of diamond anvil cell compression UDC 519.6 Computational models of diamond anvil cell compression A. I. Kondrat yev Independent Researcher, 5944 St. Alban Road, Pensacola, Florida 32503, USA Abstract. Diamond anvil cells (DAC) are extensively

More information

r/lt.i Ml s." ifcr ' W ATI II. The fnncrnl.icniccs of Mr*. John We mil uppn our tcpiiblicnn rcprc Died.

r/lt.i Ml s. ifcr ' W ATI II. The fnncrnl.icniccs of Mr*. John We mil uppn our tcpiiblicnn rcprc Died. $ / / - (\ \ - ) # -/ ( - ( [ & - - - - \ - - ( - - - - & - ( ( / - ( \) Q & - - { Q ( - & - ( & q \ ( - ) Q - - # & - - - & - - - $ - 6 - & # - - - & -- - - - & 9 & q - / \ / - - - -)- - ( - - 9 - - -

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

Numerical Heat and Mass Transfer

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

More information

Mechanics of Earthquakes and Faulting

Mechanics of Earthquakes and Faulting Mechanics of Earthquakes and Faulting www.geosc.psu.edu/courses/geosc508 Overview Milestones in continuum mechanics Concepts of modulus and stiffness. Stress-strain relations Elasticity Surface and body

More information

Spin foam vertex and loop gravity

Spin foam vertex and loop gravity Spin foam vertex and loop gravity J Engle, R Pereira and C Rovelli Centre de Physique Théorique CNRS Case 907, Université de la Méditerranée, F-13288 Marseille, EU Roberto Pereira, Loops 07 Morelia 25-30

More information

9.1 Preconditioned Krylov Subspace Methods

9.1 Preconditioned Krylov Subspace Methods Chapter 9 PRECONDITIONING 9.1 Preconditioned Krylov Subspace Methods 9.2 Preconditioned Conjugate Gradient 9.3 Preconditioned Generalized Minimal Residual 9.4 Relaxation Method Preconditioners 9.5 Incomplete

More information

Solving PDEs with Multigrid Methods p.1

Solving PDEs with Multigrid Methods p.1 Solving PDEs with Multigrid Methods Scott MacLachlan maclachl@colorado.edu Department of Applied Mathematics, University of Colorado at Boulder Solving PDEs with Multigrid Methods p.1 Support and Collaboration

More information

Solutions: Homework 5

Solutions: Homework 5 Ex. 5.1: Capacitor Solutions: Homework 5 (a) Consider a parallel plate capacitor with large circular plates, radius a, a distance d apart, with a d. Choose cylindrical coordinates (r,φ,z) and let the z

More information

Fluid-Structure Interaction Problems using SU2 and External Finite-Element Solvers

Fluid-Structure Interaction Problems using SU2 and External Finite-Element Solvers Fluid-Structure Interaction Problems using SU2 and External Finite-Element Solvers R. Sanchez 1, D. Thomas 2, R. Palacios 1, V. Terrapon 2 1 Department of Aeronautics, Imperial College London 2 Department

More information

Analytical Mechanics: Elastic Deformation

Analytical Mechanics: Elastic Deformation Analytical Mechanics: Elastic Deformation Shinichi Hirai Dept. Robotics, Ritsumeikan Univ. Shinichi Hirai (Dept. Robotics, Ritsumeikan Univ.) Analytical Mechanics: Elastic Deformation 1 / 60 Agenda Agenda

More information

FEM modeling of fiber reinforced composites

FEM modeling of fiber reinforced composites FEM modeling of fiber reinforced composites MSc Thesis Civil Engineering Elco Jongejans Delft, the Netherlands August MSc THESIS CIVIL ENGINEERING FEM modeling of fiber reinforced composites The use of

More information

Dr. D. Dinev, Department of Structural Mechanics, UACEG

Dr. D. Dinev, Department of Structural Mechanics, UACEG Lecture 6 Energy principles Energy methods and variational principles Print version Lecture on Theory of Elasticity and Plasticity of Dr. D. Dinev, Department of Structural Mechanics, UACEG 6.1 Contents

More information

Rotational Motion. Chapter 4. P. J. Grandinetti. Sep. 1, Chem P. J. Grandinetti (Chem. 4300) Rotational Motion Sep.

Rotational Motion. Chapter 4. P. J. Grandinetti. Sep. 1, Chem P. J. Grandinetti (Chem. 4300) Rotational Motion Sep. Rotational Motion Chapter 4 P. J. Grandinetti Chem. 4300 Sep. 1, 2017 P. J. Grandinetti (Chem. 4300) Rotational Motion Sep. 1, 2017 1 / 76 Angular Momentum The angular momentum of a particle with respect

More information

THREE-DIMENSIONAL SIMULATION OF THERMAL OXIDATION AND THE INFLUENCE OF STRESS

THREE-DIMENSIONAL SIMULATION OF THERMAL OXIDATION AND THE INFLUENCE OF STRESS THREE-DIMENSIONAL SIMULATION OF THERMAL OXIDATION AND THE INFLUENCE OF STRESS Christian Hollauer, Hajdin Ceric, and Siegfried Selberherr Institute for Microelectronics, Technical University Vienna Gußhausstraße

More information

A Study on Numerical Solution to the Incompressible Navier-Stokes Equation

A Study on Numerical Solution to the Incompressible Navier-Stokes Equation A Study on Numerical Solution to the Incompressible Navier-Stokes Equation Zipeng Zhao May 2014 1 Introduction 1.1 Motivation One of the most important applications of finite differences lies in the field

More information

Image Reconstruction And Poisson s equation

Image Reconstruction And Poisson s equation Chapter 1, p. 1/58 Image Reconstruction And Poisson s equation School of Engineering Sciences Parallel s for Large-Scale Problems I Chapter 1, p. 2/58 Outline 1 2 3 4 Chapter 1, p. 3/58 Question What have

More information

MEC-E8001 FINITE ELEMENT ANALYSIS

MEC-E8001 FINITE ELEMENT ANALYSIS MEC-E800 FINIE EEMEN ANAYSIS 07 - WHY FINIE EEMENS AND IS HEORY? Design of machines and structures: Solution to stress or displacement by analytical method is often impossible due to complex geometry,

More information

AE/ME 339. Computational Fluid Dynamics (CFD) K. M. Isaac. Momentum equation. Computational Fluid Dynamics (AE/ME 339) MAEEM Dept.

AE/ME 339. Computational Fluid Dynamics (CFD) K. M. Isaac. Momentum equation. Computational Fluid Dynamics (AE/ME 339) MAEEM Dept. AE/ME 339 Computational Fluid Dynamics (CFD) 9//005 Topic7_NS_ F0 1 Momentum equation 9//005 Topic7_NS_ F0 1 Consider the moving fluid element model shown in Figure.b Basis is Newton s nd Law which says

More information

Elasticity in two dimensions 1

Elasticity in two dimensions 1 Elasticity in two dimensions 1 Elasticity in two dimensions Chapters 3 and 4 of Mechanics of the Cell, as well as its Appendix D, contain selected results for the elastic behavior of materials in two and

More information

LOWELL WEEKLY JOURNAL

LOWELL WEEKLY JOURNAL Y -» $ 5 Y 7 Y Y -Y- Q x Q» 75»»/ q } # ]»\ - - $ { Q» / X x»»- 3 q $ 9 ) Y q - 5 5 3 3 3 7 Q q - - Q _»»/Q Y - 9 - - - )- [ X 7» -» - )»? / /? Q Y»» # X Q» - -?» Q ) Q \ Q - - - 3? 7» -? #»»» 7 - / Q

More information

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

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

More information

Level Set-based Topology Optimization Method for Viscous Flow Using Lattice Boltzmann Method

Level Set-based Topology Optimization Method for Viscous Flow Using Lattice Boltzmann Method 10 th World Congress on Structural and Multidisciplinary Optimization May 19-24, 2013, Orlando, Florida, USA Level Set-based Topology Optimization Method for Viscous Flow Using Lattice Boltzmann Method

More information

Chapter 2: Heat Conduction Equation

Chapter 2: Heat Conduction Equation -1 General Relation for Fourier s Law of Heat Conduction - Heat Conduction Equation -3 Boundary Conditions and Initial Conditions -1 General Relation for Fourier s Law of Heat Conduction (1) The rate of

More information

Modelling and implementation of algorithms in applied mathematics using MPI

Modelling and implementation of algorithms in applied mathematics using MPI Modelling and implementation of algorithms in applied mathematics using MPI Lecture 3: Linear Systems: Simple Iterative Methods and their parallelization, Programming MPI G. Rapin Brazil March 2011 Outline

More information

Space engineering. Structural finite element models. ECSS-E-ST-32-03C 31 July 2008

Space engineering. Structural finite element models. ECSS-E-ST-32-03C 31 July 2008 ECSS-E-ST-32-03C Space engineering Structural finite element models ECSS Secretariat ESA-ESTEC Requirements & Standards Division Noordwijk, The Netherlands Foreword This Standard is one of the series of

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

4 Electric Fields in Matter

4 Electric Fields in Matter 4 Electric Fields in Matter 4.1 Parity and Time Reversal: Lecture 10 (a) We discussed how fields transform under parity and time reversal. A useful table is Quantity Parity Time Reversal t Even Odd r Odd

More information

Thermal Network Analysis with TNSolver

Thermal Network Analysis with TNSolver Thermal Network Analysis with TNSolver Steady Conduction - The Composite Wall Problem Bob Cochran Applied Computational Heat Transfer Seattle, WA rjc@heattransfer.org ME 331 Introduction to Heat Transfer

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

WRT in 2D: Poisson Example

WRT in 2D: Poisson Example WRT in 2D: Poisson Example Consider 2 u f on [, L x [, L y with u. WRT: For all v X N, find u X N a(v, u) such that v u dv v f dv. Follows from strong form plus integration by parts: ( ) 2 u v + 2 u dx

More information