Introduction to Finite Element computations

Size: px
Start display at page:

Download "Introduction to Finite Element computations"

Transcription

1 Non Linear Computational Mechanics Athens MP06/2012 Introduction to Finite Element computations Vincent Chiaruttini, Georges Cailletaud

2 Outline Continuous to discrete problem Strong to weak formulation Galerkin method for approximate solution computation Isoparametric finite elements Finite element mesh Geometrical element Interpolation of displacements FE method for linear elastic problems Variational formulation with isoparametric elements Elemental computations Global problem Linear solution process 2

3 Continuous mechanical problem Solving PDE on a given time-space Studied domain Local r¾ + f = 0 1 T "(u) = ru +r u 2 ¾=K :" Boundary conditions Unable to get exact solution How to obtain an approximated solution? u = ud ¾ n = F

4 Continuous mechanical problem Local equations r¾ + f = 0 1 T "= ru + r u 2 ¾=K :" u = ud ¾ n = F Admissible spaces for displacements Uad = fuju continuous and regular on ; u = ud g 0 Uad = fuju continuous and regular on ; u = 0 g Variational formulation of the displacement problem 0 Finding u 2 Uad that verifies, for all u 2 Uad ¾ : " f :u d = F :u ds, a(u; u ) = L(u

5 Continuous mechanical problem Potential energy definition 1 P (v) = "(v) : K : "(v)d f :vd F :vds 1 P (v) = a(v; v) L(v) 2 Minimization problem Lax-Milgram theorm insures 0 u 2 Uad veri es 8u 2 Uad ; a(u; u ) = L(u ), u = argminv2uad P(v) Variational formulation = weak formulation on a stationary functional Galerkin based methods Approximate minimization problem

6 From Galerkin method to FE method Galerkin method Finding the solution of a variational formulation in an admissible subspace of Using polynomial base functions defined on the domain, for instance v(x) = ud (x) + N X k Ák (x) k=1 ud (x) 2 Uad Uad 0 Ák (x) 2 Uad The variational formulation produces a NxN linear system 8h 2 f1; : : : ; N g; N X k=1 a(ák ; Áh ) k = L(Ák ) The approximate solution is optimal in the sense that it constitutes the projection of the solution on the given subspace (ie the error is orthogonal to the given subspace) Advantages/drawbacks Mesh and compact support base functions => FE method Easy to define a regular base (polynomials) Optimal approximation Non-sparse operators, not so easy for complex geometries

7 Some popular discrete methods for PDE Finite differences Strong formulation of PDE Differential approximations dti/dx=(ti+1-ti-1)/(2h) h Ti-1 Ti Ti+1 Regular grid Finite volume Integral approximations Flux Very popular for conservation laws Structured or unstructured mesh Finite elements Variational formulation Optimal solution for a given approximation space (Galerkin approach) Free meshes, efficient a priori and a posteriori error estimation

8 Outline Continuous to discrete problem Strong to weak formulation Galerkin method for approximate solution computation Isoparametric finite elements Finite element mesh Geometrical element Interpolation of displacements FE method for linear elastic problems Variational formulation with isoparametric elements Elemental computations Global problem Linear solution process 8

9 Isoparametric finite element Motivation Industrial need for a robust and efficient numerical tool to obtain accurate results in the simulation of mechanical problems with complex behaviour and geometries Meshing process Given a geometrical model (usually from CSG built using a CAD software) 235 parts 45 parts How to obtain a suitable discrete representation for FE computations?

10 Finite element mesh A 2D example triangular elements A continuous domain is approximated Ti using a conform partition based on rectilinear triangular regions => a triangular Mesh h To insure convergence of the solution process the elements size can be reduced If the studied domain boundary is polygonal, it is possible to get = h Interpolation functions Represent a scalar field Th (x) on the domain using nodal values Ti x 2 in element T Th (x) = N1 (x) T1 + N2 (x) T2 + N3 (x) T3 T3 3 T (x) T1 1 x T2 2 Can functions Ti be less dependant of the mesh?

11 Deformed and reference configurations Parametrization of an element positioned anywhere in the studied space (linear triangular example) Physical element»2 X3 x X1 X2 Reference element 3(0; 1)» 1(0; 0)»1 2(1; 0) x = N1 (») X 1 + N2 (») X 2 + N3 (») X 3 Ni (») are base or shape functions defined on the reference domain for the geometrical representation of the element, usually linear: 8 < N1 (»1 ;»2 ) = 1»1»2 N2 (»1 ;»2 ) =»1 : N3 (»1 ;»2 ) =»2

12 Deformed and reference configurations Parametrization of an element positioned anywhere in the studied space (quadratic triangular example) Physical element X5»2 X4 X6 X1 x X2 X3 Reference element 5 6 1» 4 2»1 3 Reference to physical transformation regularity (n nodes element) " n # n x= Nk (») X k J(») = = (»)Xkj J(») = j j k=1 k=1 The transformation between the reference and the physical configurations must be a bijection, the Jacobian must not reach the zero value. Misappropriate physical element geometry can produce such failure Element integration dv (x) = J(»)dV (»), if N is polynomial then J is also

13 Interpolation of displacements Isoparametric element The same base functions are used for geometry and displacement interpolation uh (x) = n X Nk (») U k where U k are the vectorial nodal displacements k=1

14 Operational computation of displacements Local vector of displacement unknowns for element e with n nodes A vector of elementary degrees of freedoms is usually built, for a 2D problem by Ue = (j) h it (1) (1) (2) (2) (j) U1 ; U2 ; U1 ; U2 ; : : : ; Ui ; : : : where Ui is the nodal displacement in direction i at node j Thus for any point x inside the specified element of coordinate system, the displacement is obtained by» in the reference uh (x) = N e (») U e N e (») is a matrix built using the base function, in 2D: N1 (») 0 N2 (») 0 : : : Nj (») N (») = 0 N1 (») 0 N2 (») : : : 0 where 0 Nj (») ::: ::: To insure correct convergence properties (ie representation of constant gradient and solid body displacement field), the following partition of unity property must be n verified anywhere in the element: X Nk (») = 1 k=1

15 Operational computation of displacement gradients Vectorial Voigt writing of second order tensors Symmetric gradients h it p p p "v = "11 "22 "33 2"12 2"13 2"23 h it p p p ¾ v = ¾11 ¾22 ¾33 2¾12 2¾13 2¾23 Linear behaviour relationship as a matrix-vector product ¾ v = [A] "v Gradient computation Physical system of coordinate gradient definition duh (x) = r uh (x) dx " n # To link with the reference coordinate (k) (») Ui duh (x) = H(») dx with H(») = [Hij ] k=0 using dx = J(») d» we get Symmetric gradient computation r uh (x) = H(») J 1 (») 1³ T ²h [u(»)] = H(») J 1 (») + H(») J 1 (») 2 v That can be expressed as ²h (») = B U e using the symmetric gradient operator

16 Outline Continuous to discrete problem Strong to weak formulation Galerkin method for approximate solution computation Isoparametric finite elements Finite element mesh Geometrical element Interpolation of displacements FE method for linear elastic problems Variational formulation with isoparametric elements Elemental computations Global problem Linear solution process 16

17 Finite element method for linear elasticity Global algorithm from the variational formulation in displacement Continuous problem Uad = fuju continuous and regular on ; u = ud 0 8u 2 Uad ; ¾ : " d = f:u d Finite element discrete problem Su Sf 8U j ; h On each element ek F :u uh (x) = N ke (») U e Prescribed displacements on Su nodes Usk k = U (x d s) h k Virtual displacement field uh (x) = N e (») U e ek Verifying null value on Su nodes Usk = 0 "vh [A] : "v d = f :u d + F :u h h h h h ds h, 8W; [W ]T [K][U ] = [W ]T [F ]

18 Computing elementary contributions Domain formulation based on element by element contributions X [W ]T [K][U ] = "vh [A] "v h dv fek g [W ]T [F ] = X fek g ek ek f :u h dv + Usually the two parts are separated in Internal force contributions External force contributions ef F :u h ds [Fint ] + [Fext ] = [0] [Fint ] = [Fext ] = X fek g X fek g ek ek "vh [A] "v h dv f :u h dv + ef F :u h ds

19 Computing elementary contributions Elementary rigidity matrices Using the FE gradient operators and the local vectors of unknowns we need to compute: ek T "vh [A] "v h dv = [We ] [B]T [A][B]dV [Ue ] = [We ][Ke ][Ue ] ek Even for polynomial base/shape function, the inverse of Jacobian used to compute the [B] symmetric gradient operator, make impossible to evaluate such elementary integral exactly for non-trivial meshes. Thus a Gauss integration process is used: ek f (»)dv (») ¼ G X wg f (» g ) g=1 Such process requires the knowledge of some predefined integration points» g (usually called Gauss points) and the associated weight wg for the reference configuration of the element. The parametric representation of both the geometry and the displacement field of the element constitutes one of most important aspect to insure the generic aspect of the FE method: only a few patterns of integration scheme are required corresponding to the associated finite element in reference configuration.

20 Computing elementary contributions Gauss integration 1D example

21 Computing elementary contributions Gauss integration 1D example

22 Computing elementary contributions Gauss integration 1D example

23 Computing elementary contributions Gauss integration 1D example

24 Computing elementary contributions Gauss integration In 3D

25 Computing elementary contributions External forces X [Fext ] = [W ]T [N ][f ]dv + fek g ek [W ][N ]T [F ]ds ef For the volume force a Gauss integration process is required For the nodal force nodal value must be correctly calculated

26 Computing elementary contributions External forces

27 Computing elementary contributions External forces X [Fext ] = fek g ek f :u h dv + ef F :u h ds For the volume force a Gauss integration process is required For the nodal force nodal value must be correctly calculated

28 Computing elementary contributions External forces X [Fext ] = fek g ek f :u h dv + ef F :u h ds For the volume force a Gauss integration process is required For the nodal force nodal value must be correctly calculated

29 Computing elementary contributions External forces X [Fext ] = fek g ek f :u h dv + ef F :u h ds For the volume force a Gauss integration process is required For the nodal force nodal value must be correctly calculated

30 Assembling the global problem Local to global DOF indices (thermal problem for shake of simplicity) 2 E1 1 E2 4 7 E9 Global DOF numbering E3 9 E4 E3 E E5 10 E8 E7 1 E6 Elementary DOF numbering Global matrix 1 Binary trace operators [Ue ] = [ e ][U ] [U ] = [ e ]T [Ue ] 2 3 Assembling global matrix 4 [K] = bandwidth X [ e ]T [Ke ][ e ] fek g Prescribed displacements When assembling is processed, prescribed displacement unknowns can be replaced and eliminated for the linear system

31 Solving efficiently a sparse linear system Large linear system to be solved [K][U ] = [F ] sparse with n equations (n from 104 to 109) K is a symmetric, definite positive for a linear-elastic problem Reduce bandwidth using an accurate numbering process (reduce computational cost) Optimization in memory requirement: sparse storage only keep non zero terms Direct solvers Factorization process [K] = [L][L]T with L a lower-triangular matrix Solving [L][Y ] = [F ] then [L]T [U ] = [Y ] (2 successive triangular systems solving) Interest: matrix storage, less memory consuming than required by inverse computation, triangular system solving is of the same complexity order than matrix vector product Optimized multifrontal, dissection, multithreated, solvers Iterative solvers Krylov type solvers (conjugate gradient, GMRes) need good preconditionners Domain decomposition solvers Split the structure in many subdomains (for supercomputers parallel computation) Efficient iterative strategy to achieve interface equilibrium condition (very good preconditionners)

32 Convergence proprieties Displacement convergence Polynomial approximations are used, on any element Ee, Taylor expansion gives: (x; x0 ) 2 Ee2 u(x) = u(x0 ) + ru(x0 ):(x x0 ) + : : : + O(kx x0 kp+1 ) Committed error on displacement using p order shape function and h characteristic size kx x0 k < h gives ku(x) uh (x)k = O(hp+1 ); x 2 Ee Strain and stress convergence FE error k"[u](x) " [u](x)k = O(hp ); x 2 Ee h k¾[u](x) ¾ h [u](x)k = O(hp ); x 2 Ee Energy norm 2 "[v] : A : "[v]d Defined by kvke = For order p 1 the FE method is convergent in energy: ku uh ke! 0 if h! 0 and if the problem is regular enough ku uh ke C hp kuke

33 Global FE solution process for a linear problem Approximate geometry build a mesh using a priori analysis Loop on elements Compute the local variational formulation contribution Loop on elements Gauss points Compute Jacobian, gradient matrices, get behaviour, multiply matrices to get local rigidity contribution Integrate the rigidity matrix and the local vector for external forces Assemble local rigidity matrix and local external forces Apply Dirichlet BC, MPC (linear relationship between unknowns) Compute global external forces Solve the linear system

34 References Bonnet M., Frangi A. (2006) Analyse des solides déformables par la méthode des éléments finis. Editions Ecole Polytechnique. Belytschko, T., Liu, W., and Moran, B. (2000). Nonlinear Finite Elements for Continua and Structures. Besson, J., Cailletaud, G., Chaboche, J.-L., and Forest, S. (2001). Mecanique non linéaire des matériaux. Hermes. Ciarlet, P. and Lions, J. (1995). Handbook of Numerical Analysis : Finite Element Methods (P.1), Numerical Methods for Solids (P.2). North Holland. Dhatt, G. and Touzot, G. (1981). Une présentation de la méthode des élements finis. Maloine. Hughes, T. (1987). The finite element method: Linear static and dynamic finite element analysis. Prentice Hall Inc. Simo, J. and Hughes, T. (1997). Computational Inelasticity. Springer Verlag. ienkiewicz, O. and Taylor, R. (2000). The finite element method, Vol. I-III (Vol.1: The Basis, Vol.2: Solid Mechanics, Vol. 3: Fluid dynamics). Butterworth Heinemann.

The Finite Element method for nonlinear structural problems

The Finite Element method for nonlinear structural problems Non Linear Computational Mechanics Athens MP06/2013 The Finite Element method for nonlinear structural problems Vincent Chiaruttini vincent.chiaruttini@onera.fr Outline Generalities on computational strategies

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

Iterative Methods for Linear Systems

Iterative Methods for Linear Systems Iterative Methods for Linear Systems 1. Introduction: Direct solvers versus iterative solvers In many applications we have to solve a linear system Ax = b with A R n n and b R n given. If n is large the

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

Boundary Value Problems and Iterative Methods for Linear Systems

Boundary Value Problems and Iterative Methods for Linear Systems Boundary Value Problems and Iterative Methods for Linear Systems 1. Equilibrium Problems 1.1. Abstract setting We want to find a displacement u V. Here V is a complete vector space with a norm v V. In

More information

Institute of Structural Engineering Page 1. Method of Finite Elements I. Chapter 2. The Direct Stiffness Method. Method of Finite Elements I

Institute of Structural Engineering Page 1. Method of Finite Elements I. Chapter 2. The Direct Stiffness Method. Method of Finite Elements I Institute of Structural Engineering Page 1 Chapter 2 The Direct Stiffness Method Institute of Structural Engineering Page 2 Direct Stiffness Method (DSM) Computational method for structural analysis Matrix

More information

Institute of Structural Engineering Page 1. Method of Finite Elements I. Chapter 2. The Direct Stiffness Method. Method of Finite Elements I

Institute of Structural Engineering Page 1. Method of Finite Elements I. Chapter 2. The Direct Stiffness Method. Method of Finite Elements I Institute of Structural Engineering Page 1 Chapter 2 The Direct Stiffness Method Institute of Structural Engineering Page 2 Direct Stiffness Method (DSM) Computational method for structural analysis Matrix

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

Chapter 2 Finite Element Formulations

Chapter 2 Finite Element Formulations Chapter 2 Finite Element Formulations The governing equations for problems solved by the finite element method are typically formulated by partial differential equations in their original form. These are

More information

Concepts. 3.1 Numerical Analysis. Chapter Numerical Analysis Scheme

Concepts. 3.1 Numerical Analysis. Chapter Numerical Analysis Scheme Chapter 3 Concepts The objective of this work is to create a framework to implement multi-disciplinary finite element applications. Before starting, it is necessary to explain some basic concepts of the

More information

Chapter 1: The Finite Element Method

Chapter 1: The Finite Element Method Chapter 1: The Finite Element Method Michael Hanke Read: Strang, p 428 436 A Model Problem Mathematical Models, Analysis and Simulation, Part Applications: u = fx), < x < 1 u) = u1) = D) axial deformation

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

Scientific Computing WS 2018/2019. Lecture 15. Jürgen Fuhrmann Lecture 15 Slide 1

Scientific Computing WS 2018/2019. Lecture 15. Jürgen Fuhrmann Lecture 15 Slide 1 Scientific Computing WS 2018/2019 Lecture 15 Jürgen Fuhrmann juergen.fuhrmann@wias-berlin.de Lecture 15 Slide 1 Lecture 15 Slide 2 Problems with strong formulation Writing the PDE with divergence and gradient

More information

Discontinuous Galerkin methods for nonlinear elasticity

Discontinuous Galerkin methods for nonlinear elasticity Discontinuous Galerkin methods for nonlinear elasticity Preprint submitted to lsevier Science 8 January 2008 The goal of this paper is to introduce Discontinuous Galerkin (DG) methods for nonlinear elasticity

More information

Two-scale Dirichlet-Neumann preconditioners for boundary refinements

Two-scale Dirichlet-Neumann preconditioners for boundary refinements Two-scale Dirichlet-Neumann preconditioners for boundary refinements Patrice Hauret 1 and Patrick Le Tallec 2 1 Graduate Aeronautical Laboratories, MS 25-45, California Institute of Technology Pasadena,

More information

The Plane Stress Problem

The Plane Stress Problem The Plane Stress Problem Martin Kronbichler Applied Scientific Computing (Tillämpad beräkningsvetenskap) February 2, 2010 Martin Kronbichler (TDB) The Plane Stress Problem February 2, 2010 1 / 24 Outline

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

Contents as of 12/8/2017. Preface. 1. Overview...1

Contents as of 12/8/2017. Preface. 1. Overview...1 Contents as of 12/8/2017 Preface 1. Overview...1 1.1 Introduction...1 1.2 Finite element data...1 1.3 Matrix notation...3 1.4 Matrix partitions...8 1.5 Special finite element matrix notations...9 1.6 Finite

More information

JEPPIAAR ENGINEERING COLLEGE

JEPPIAAR ENGINEERING COLLEGE JEPPIAAR ENGINEERING COLLEGE Jeppiaar Nagar, Rajiv Gandhi Salai 600 119 DEPARTMENT OFMECHANICAL ENGINEERING QUESTION BANK VI SEMESTER ME6603 FINITE ELEMENT ANALYSIS Regulation 013 SUBJECT YEAR /SEM: III

More information

The Finite Element Method for Computational Structural Mechanics

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

More information

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

FEniCS Course. Lecture 0: Introduction to FEM. Contributors Anders Logg, Kent-Andre Mardal

FEniCS Course. Lecture 0: Introduction to FEM. Contributors Anders Logg, Kent-Andre Mardal FEniCS Course Lecture 0: Introduction to FEM Contributors Anders Logg, Kent-Andre Mardal 1 / 46 What is FEM? The finite element method is a framework and a recipe for discretization of mathematical problems

More information

Generalized Finite Element Methods for Three Dimensional Structural Mechanics Problems. C. A. Duarte. I. Babuška and J. T. Oden

Generalized Finite Element Methods for Three Dimensional Structural Mechanics Problems. C. A. Duarte. I. Babuška and J. T. Oden Generalized Finite Element Methods for Three Dimensional Structural Mechanics Problems C. A. Duarte COMCO, Inc., 7800 Shoal Creek Blvd. Suite 290E Austin, Texas, 78757, USA I. Babuška and J. T. Oden TICAM,

More information

Chapter 12. Partial di erential equations Di erential operators in R n. The gradient and Jacobian. Divergence and rotation

Chapter 12. Partial di erential equations Di erential operators in R n. The gradient and Jacobian. Divergence and rotation Chapter 12 Partial di erential equations 12.1 Di erential operators in R n The gradient and Jacobian We recall the definition of the gradient of a scalar function f : R n! R, as @f grad f = rf =,..., @f

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

A brief introduction to finite element methods

A brief introduction to finite element methods CHAPTER A brief introduction to finite element methods 1. Two-point boundary value problem and the variational formulation 1.1. The model problem. Consider the two-point boundary value problem: Given a

More information

. D CR Nomenclature D 1

. D CR Nomenclature D 1 . D CR Nomenclature D 1 Appendix D: CR NOMENCLATURE D 2 The notation used by different investigators working in CR formulations has not coalesced, since the topic is in flux. This Appendix identifies the

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

Steps in the Finite Element Method. Chung Hua University Department of Mechanical Engineering Dr. Ching I Chen

Steps in the Finite Element Method. Chung Hua University Department of Mechanical Engineering Dr. Ching I Chen Steps in the Finite Element Method Chung Hua University Department of Mechanical Engineering Dr. Ching I Chen General Idea Engineers are interested in evaluating effects such as deformations, stresses,

More information

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

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

More information

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

DISPENSA FEM in MSC. Nastran

DISPENSA FEM in MSC. Nastran DISPENSA FEM in MSC. Nastran preprocessing: mesh generation material definitions definition of loads and boundary conditions solving: solving the (linear) set of equations components postprocessing: visualisation

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

Newton-Multigrid Least-Squares FEM for S-V-P Formulation of the Navier-Stokes Equations

Newton-Multigrid Least-Squares FEM for S-V-P Formulation of the Navier-Stokes Equations Newton-Multigrid Least-Squares FEM for S-V-P Formulation of the Navier-Stokes Equations A. Ouazzi, M. Nickaeen, S. Turek, and M. Waseem Institut für Angewandte Mathematik, LSIII, TU Dortmund, Vogelpothsweg

More information

4 NON-LINEAR ANALYSIS

4 NON-LINEAR ANALYSIS 4 NON-INEAR ANAYSIS arge displacement elasticity theory, principle of virtual work arge displacement FEA with solid, thin slab, and bar models Virtual work density of internal forces revisited 4-1 SOURCES

More information

Introduction to Scientific Computing

Introduction to Scientific Computing (Lecture 5: Linear system of equations / Matrix Splitting) Bojana Rosić, Thilo Moshagen Institute of Scientific Computing Motivation Let us resolve the problem scheme by using Kirchhoff s laws: the algebraic

More information

SOLVING SPARSE LINEAR SYSTEMS OF EQUATIONS. Chao Yang Computational Research Division Lawrence Berkeley National Laboratory Berkeley, CA, USA

SOLVING SPARSE LINEAR SYSTEMS OF EQUATIONS. Chao Yang Computational Research Division Lawrence Berkeley National Laboratory Berkeley, CA, USA 1 SOLVING SPARSE LINEAR SYSTEMS OF EQUATIONS Chao Yang Computational Research Division Lawrence Berkeley National Laboratory Berkeley, CA, USA 2 OUTLINE Sparse matrix storage format Basic factorization

More information

Non-Linear Finite Element Methods in Solid Mechanics Attilio Frangi, Politecnico di Milano, February 17, 2017, Lesson 5

Non-Linear Finite Element Methods in Solid Mechanics Attilio Frangi, Politecnico di Milano, February 17, 2017, Lesson 5 Non-Linear Finite Element Methods in Solid Mechanics Attilio Frangi, attilio.frangi@polimi.it Politecnico di Milano, February 17, 2017, Lesson 5 1 Politecnico di Milano, February 17, 2017, Lesson 5 2 Outline

More information

Finite Elements. Colin Cotter. February 22, Colin Cotter FEM

Finite Elements. Colin Cotter. February 22, Colin Cotter FEM Finite Elements February 22, 2019 In the previous sections, we introduced the concept of finite element spaces, which contain certain functions defined on a domain. Finite element spaces are examples of

More information

Finite Element Method

Finite Element Method Finite Element Method Finite Element Method (ENGC 6321) Syllabus Objectives Understand the basic theory of the FEM Know the behaviour and usage of each type of elements covered in this course one dimensional

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

Implicit Solution of Viscous Aerodynamic Flows using the Discontinuous Galerkin Method

Implicit Solution of Viscous Aerodynamic Flows using the Discontinuous Galerkin Method Implicit Solution of Viscous Aerodynamic Flows using the Discontinuous Galerkin Method Per-Olof Persson and Jaime Peraire Massachusetts Institute of Technology 7th World Congress on Computational Mechanics

More information

Chapter 3 Variational Formulation & the Galerkin Method

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

More information

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

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

Development of discontinuous Galerkin method for linear strain gradient elasticity

Development of discontinuous Galerkin method for linear strain gradient elasticity Development of discontinuous Galerkin method for linear strain gradient elasticity R Bala Chandran Computation for Design and Optimizaton Massachusetts Institute of Technology Cambridge, MA L. Noels* Aerospace

More information

Discontinuous Galerkin Methods

Discontinuous Galerkin Methods Discontinuous Galerkin Methods Joachim Schöberl May 20, 206 Discontinuous Galerkin (DG) methods approximate the solution with piecewise functions (polynomials), which are discontinuous across element interfaces.

More information

Spline Element Method for Partial Differential Equations

Spline Element Method for Partial Differential Equations for Partial Differential Equations Department of Mathematical Sciences Northern Illinois University 2009 Multivariate Splines Summer School, Summer 2009 Outline 1 Why multivariate splines for PDEs? Motivation

More information

Finite Element Method-Part II Isoparametric FE Formulation and some numerical examples Lecture 29 Smart and Micro Systems

Finite Element Method-Part II Isoparametric FE Formulation and some numerical examples Lecture 29 Smart and Micro Systems Finite Element Method-Part II Isoparametric FE Formulation and some numerical examples Lecture 29 Smart and Micro Systems Introduction Till now we dealt only with finite elements having straight edges.

More information

Simple Examples on Rectangular Domains

Simple Examples on Rectangular Domains 84 Chapter 5 Simple Examples on Rectangular Domains In this chapter we consider simple elliptic boundary value problems in rectangular domains in R 2 or R 3 ; our prototype example is the Poisson equation

More information

The Finite Element Method for the Analysis of Non-Linear and Dynamic Systems. Prof. Dr. Eleni Chatzi Lecture 1-20 September, 2017

The Finite Element Method for the Analysis of Non-Linear and Dynamic Systems. Prof. Dr. Eleni Chatzi Lecture 1-20 September, 2017 The Finite Element Method for the Analysis of Non-Linear and Dynamic Systems Prof. Dr. Eleni Chatzi Lecture 1-20 September, 2017 Institute of Structural Engineering Method of Finite Elements II 1 Course

More information

arxiv: v1 [math.na] 29 Feb 2016

arxiv: v1 [math.na] 29 Feb 2016 EFFECTIVE IMPLEMENTATION OF THE WEAK GALERKIN FINITE ELEMENT METHODS FOR THE BIHARMONIC EQUATION LIN MU, JUNPING WANG, AND XIU YE Abstract. arxiv:1602.08817v1 [math.na] 29 Feb 2016 The weak Galerkin (WG)

More information

Basic Principles of Weak Galerkin Finite Element Methods for PDEs

Basic Principles of Weak Galerkin Finite Element Methods for PDEs Basic Principles of Weak Galerkin Finite Element Methods for PDEs Junping Wang Computational Mathematics Division of Mathematical Sciences National Science Foundation Arlington, VA 22230 Polytopal Element

More information

Introduction to Finite Element Method

Introduction to Finite Element Method Introduction to Finite Element Method Dr. Rakesh K Kapania Aerospace and Ocean Engineering Department Virginia Polytechnic Institute and State University, Blacksburg, VA AOE 524, Vehicle Structures Summer,

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

The Finite Element Method

The Finite Element Method Chapter 1 The Finite Element Method 1.1 Introduction This document provides a brief introduction to the finite element method and illustrates how the method is implemented in oomph-lib. The first few sections

More information

The Finite Element Method for Solid and Structural Mechanics

The Finite Element Method for Solid and Structural Mechanics The Finite Element Method for Solid and Structural Mechanics Sixth edition O.C. Zienkiewicz, CBE, FRS UNESCO Professor of Numerical Methods in Engineering International Centre for Numerical Methods in

More information

Domain Decomposition Preconditioners for Spectral Nédélec Elements in Two and Three Dimensions

Domain Decomposition Preconditioners for Spectral Nédélec Elements in Two and Three Dimensions Domain Decomposition Preconditioners for Spectral Nédélec Elements in Two and Three Dimensions Bernhard Hientzsch Courant Institute of Mathematical Sciences, New York University, 51 Mercer Street, New

More information

LibMesh Experience and Usage

LibMesh Experience and Usage LibMesh Experience and Usage John W. Peterson peterson@cfdlab.ae.utexas.edu and Roy H. Stogner roystgnr@cfdlab.ae.utexas.edu Univ. of Texas at Austin September 9, 2008 1 Introduction 2 Weighted Residuals

More information

Introduction to Mobile Robotics Compact Course on Linear Algebra. Wolfram Burgard, Bastian Steder

Introduction to Mobile Robotics Compact Course on Linear Algebra. Wolfram Burgard, Bastian Steder Introduction to Mobile Robotics Compact Course on Linear Algebra Wolfram Burgard, Bastian Steder Reference Book Thrun, Burgard, and Fox: Probabilistic Robotics Vectors Arrays of numbers Vectors represent

More information

Divergence Formulation of Source Term

Divergence Formulation of Source Term Preprint accepted for publication in Journal of Computational Physics, 2012 http://dx.doi.org/10.1016/j.jcp.2012.05.032 Divergence Formulation of Source Term Hiroaki Nishikawa National Institute of Aerospace,

More information

Mobile Robotics 1. A Compact Course on Linear Algebra. Giorgio Grisetti

Mobile Robotics 1. A Compact Course on Linear Algebra. Giorgio Grisetti Mobile Robotics 1 A Compact Course on Linear Algebra Giorgio Grisetti SA-1 Vectors Arrays of numbers They represent a point in a n dimensional space 2 Vectors: Scalar Product Scalar-Vector Product Changes

More information

CIVL4332 L1 Introduction to Finite Element Method

CIVL4332 L1 Introduction to Finite Element Method CIVL L Introduction to Finite Element Method CIVL L Introduction to Finite Element Method by Joe Gattas, Faris Albermani Introduction The FEM is a numerical technique for solving physical problems such

More information

Juan Vicente Gutiérrez Santacreu Rafael Rodríguez Galván. Departamento de Matemática Aplicada I Universidad de Sevilla

Juan Vicente Gutiérrez Santacreu Rafael Rodríguez Galván. Departamento de Matemática Aplicada I Universidad de Sevilla Doc-Course: Partial Differential Equations: Analysis, Numerics and Control Research Unit 3: Numerical Methods for PDEs Part I: Finite Element Method: Elliptic and Parabolic Equations Juan Vicente Gutiérrez

More information

High Order Accurate Runge Kutta Nodal Discontinuous Galerkin Method for Numerical Solution of Linear Convection Equation

High Order Accurate Runge Kutta Nodal Discontinuous Galerkin Method for Numerical Solution of Linear Convection Equation High Order Accurate Runge Kutta Nodal Discontinuous Galerkin Method for Numerical Solution of Linear Convection Equation Faheem Ahmed, Fareed Ahmed, Yongheng Guo, Yong Yang Abstract This paper deals with

More information

From Completing the Squares and Orthogonal Projection to Finite Element Methods

From Completing the Squares and Orthogonal Projection to Finite Element Methods From Completing the Squares and Orthogonal Projection to Finite Element Methods Mo MU Background In scientific computing, it is important to start with an appropriate model in order to design effective

More information

The Conjugate Gradient Method

The Conjugate Gradient Method The Conjugate Gradient Method Classical Iterations We have a problem, We assume that the matrix comes from a discretization of a PDE. The best and most popular model problem is, The matrix will be as large

More information

IsogEometric Tearing and Interconnecting

IsogEometric Tearing and Interconnecting IsogEometric Tearing and Interconnecting Christoph Hofer and Ludwig Mitter Johannes Kepler University, Linz 26.01.2017 Doctoral Program Computational Mathematics Numerical Analysis and Symbolic Computation

More information

Numerical Methods for Partial Differential Equations

Numerical Methods for Partial Differential Equations Numerical Methods for Partial Differential Equations Eric de Sturler University of Illinois at Urbana-Champaign Read section 8. to see where equations of type (au x ) x = f show up and their (exact) solution

More information

Discrete Analysis for Plate Bending Problems by Using Hybrid-type Penalty Method

Discrete Analysis for Plate Bending Problems by Using Hybrid-type Penalty Method 131 Bulletin of Research Center for Computing and Multimedia Studies, Hosei University, 21 (2008) Published online (http://hdl.handle.net/10114/1532) Discrete Analysis for Plate Bending Problems by Using

More information

Reduction of Finite Element Models of Complex Mechanical Components

Reduction of Finite Element Models of Complex Mechanical Components Reduction of Finite Element Models of Complex Mechanical Components Håkan Jakobsson Research Assistant hakan.jakobsson@math.umu.se Mats G. Larson Professor Applied Mathematics mats.larson@math.umu.se Department

More information

2C9 Design for seismic and climate changes. Jiří Máca

2C9 Design for seismic and climate changes. Jiří Máca 2C9 Design for seismic and climate changes Jiří Máca List of lectures 1. Elements of seismology and seismicity I 2. Elements of seismology and seismicity II 3. Dynamic analysis of single-degree-of-freedom

More information

Algebraic Multigrid as Solvers and as Preconditioner

Algebraic Multigrid as Solvers and as Preconditioner Ò Algebraic Multigrid as Solvers and as Preconditioner Domenico Lahaye domenico.lahaye@cs.kuleuven.ac.be http://www.cs.kuleuven.ac.be/ domenico/ Department of Computer Science Katholieke Universiteit Leuven

More information

A Finite Element Method for an Ill-Posed Problem. Martin-Luther-Universitat, Fachbereich Mathematik/Informatik,Postfach 8, D Halle, Abstract

A Finite Element Method for an Ill-Posed Problem. Martin-Luther-Universitat, Fachbereich Mathematik/Informatik,Postfach 8, D Halle, Abstract A Finite Element Method for an Ill-Posed Problem W. Lucht Martin-Luther-Universitat, Fachbereich Mathematik/Informatik,Postfach 8, D-699 Halle, Germany Abstract For an ill-posed problem which has its origin

More information

Partial Differential Equations and the Finite Element Method

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

More information

General elastic beam with an elastic foundation

General elastic beam with an elastic foundation General elastic beam with an elastic foundation Figure 1 shows a beam-column on an elastic foundation. The beam is connected to a continuous series of foundation springs. The other end of the foundation

More information

UNCONVENTIONAL FINITE ELEMENT MODELS FOR NONLINEAR ANALYSIS OF BEAMS AND PLATES

UNCONVENTIONAL FINITE ELEMENT MODELS FOR NONLINEAR ANALYSIS OF BEAMS AND PLATES UNCONVENTIONAL FINITE ELEMENT MODELS FOR NONLINEAR ANALYSIS OF BEAMS AND PLATES A Thesis by WOORAM KIM Submitted to the Office of Graduate Studies of Texas A&M University in partial fulfillment of the

More information

Weak Galerkin Finite Element Scheme and Its Applications

Weak Galerkin Finite Element Scheme and Its Applications Weak Galerkin Finite Element Scheme and Its Applications Ran Zhang Department of Mathematics Jilin University, China IMS, Singapore February 6, 2015 Talk Outline Motivation WG FEMs: Weak Operators + Stabilizer

More information

Introduction to Mobile Robotics Compact Course on Linear Algebra. Wolfram Burgard, Cyrill Stachniss, Maren Bennewitz, Diego Tipaldi, Luciano Spinello

Introduction to Mobile Robotics Compact Course on Linear Algebra. Wolfram Burgard, Cyrill Stachniss, Maren Bennewitz, Diego Tipaldi, Luciano Spinello Introduction to Mobile Robotics Compact Course on Linear Algebra Wolfram Burgard, Cyrill Stachniss, Maren Bennewitz, Diego Tipaldi, Luciano Spinello Vectors Arrays of numbers Vectors represent a point

More information

Multi-Point Constraints

Multi-Point Constraints Multi-Point Constraints Multi-Point Constraints Multi-Point Constraints Single point constraint examples Multi-Point constraint examples linear, homogeneous linear, non-homogeneous linear, homogeneous

More information

A Krylov Subspace Accelerated Newton Algorithm

A Krylov Subspace Accelerated Newton Algorithm A Krylov Subspace Accelerated Newton Algorithm Michael H. Scott 1 and Gregory L. Fenves 2 ABSTRACT In the nonlinear analysis of structural systems, the Newton-Raphson (NR) method is the most common method

More information

Quintic beam closed form matrices (revised 2/21, 2/23/12) General elastic beam with an elastic foundation

Quintic beam closed form matrices (revised 2/21, 2/23/12) General elastic beam with an elastic foundation General elastic beam with an elastic foundation Figure 1 shows a beam-column on an elastic foundation. The beam is connected to a continuous series of foundation springs. The other end of the foundation

More information

Introduction to Mobile Robotics Compact Course on Linear Algebra. Wolfram Burgard, Cyrill Stachniss, Kai Arras, Maren Bennewitz

Introduction to Mobile Robotics Compact Course on Linear Algebra. Wolfram Burgard, Cyrill Stachniss, Kai Arras, Maren Bennewitz Introduction to Mobile Robotics Compact Course on Linear Algebra Wolfram Burgard, Cyrill Stachniss, Kai Arras, Maren Bennewitz Vectors Arrays of numbers Vectors represent a point in a n dimensional space

More information

Space-time Finite Element Methods for Parabolic Evolution Problems

Space-time Finite Element Methods for Parabolic Evolution Problems Space-time Finite Element Methods for Parabolic Evolution Problems with Variable Coefficients Ulrich Langer, Martin Neumüller, Andreas Schafelner Johannes Kepler University, Linz Doctoral Program Computational

More information

LECTURE 1: SOURCES OF ERRORS MATHEMATICAL TOOLS A PRIORI ERROR ESTIMATES. Sergey Korotov,

LECTURE 1: SOURCES OF ERRORS MATHEMATICAL TOOLS A PRIORI ERROR ESTIMATES. Sergey Korotov, LECTURE 1: SOURCES OF ERRORS MATHEMATICAL TOOLS A PRIORI ERROR ESTIMATES Sergey Korotov, Institute of Mathematics Helsinki University of Technology, Finland Academy of Finland 1 Main Problem in Mathematical

More information

ONE - DIMENSIONAL INTEGRATION

ONE - DIMENSIONAL INTEGRATION Chapter 4 ONE - DIMENSIONA INTEGRATION 4. Introduction Since the finite element method is based on integral relations it is logical to expect that one should strive to carry out the integrations as efficiently

More information

1. Introduction. The Stokes problem seeks unknown functions u and p satisfying

1. Introduction. The Stokes problem seeks unknown functions u and p satisfying A DISCRETE DIVERGENCE FREE WEAK GALERKIN FINITE ELEMENT METHOD FOR THE STOKES EQUATIONS LIN MU, JUNPING WANG, AND XIU YE Abstract. A discrete divergence free weak Galerkin finite element method is developed

More information

Non-Newtonian Fluids and Finite Elements

Non-Newtonian Fluids and Finite Elements Non-Newtonian Fluids and Finite Elements Janice Giudice Oxford University Computing Laboratory Keble College Talk Outline Motivating Industrial Process Multiple Extrusion of Pastes Governing Equations

More information

Engineering Sciences 241 Advanced Elasticity, Spring Distributed Thursday 8 February.

Engineering Sciences 241 Advanced Elasticity, Spring Distributed Thursday 8 February. Engineering Sciences 241 Advanced Elasticity, Spring 2001 J. R. Rice Homework Problems / Class Notes Mechanics of finite deformation (list of references at end) Distributed Thursday 8 February. Problems

More information

AMS526: Numerical Analysis I (Numerical Linear Algebra for Computational and Data Sciences)

AMS526: Numerical Analysis I (Numerical Linear Algebra for Computational and Data Sciences) AMS526: Numerical Analysis I (Numerical Linear Algebra for Computational and Data Sciences) Lecture 19: Computing the SVD; Sparse Linear Systems Xiangmin Jiao Stony Brook University Xiangmin Jiao Numerical

More information

DEVELOPMENT OF A CONTINUUM PLASTICITY MODEL FOR THE COMMERCIAL FINITE ELEMENT CODE ABAQUS

DEVELOPMENT OF A CONTINUUM PLASTICITY MODEL FOR THE COMMERCIAL FINITE ELEMENT CODE ABAQUS DEVELOPMENT OF A CONTINUUM PLASTICITY MODEL FOR THE COMMERCIAL FINITE ELEMENT CODE ABAQUS Mohsen Safaei, Wim De Waele Ghent University, Laboratory Soete, Belgium Abstract The present work relates to the

More information

Lehrstuhl Informatik V. Lehrstuhl Informatik V. 1. solve weak form of PDE to reduce regularity properties. Lehrstuhl Informatik V

Lehrstuhl Informatik V. Lehrstuhl Informatik V. 1. solve weak form of PDE to reduce regularity properties. Lehrstuhl Informatik V Part I: Introduction to Finite Element Methods Scientific Computing I Module 8: An Introduction to Finite Element Methods Tobias Necel Winter 4/5 The Model Problem FEM Main Ingredients Wea Forms and Wea

More information

University of Illinois at Urbana-Champaign College of Engineering

University of Illinois at Urbana-Champaign College of Engineering University of Illinois at Urbana-Champaign College of Engineering CEE 570 Finite Element Methods (in Solid and Structural Mechanics) Spring Semester 03 Quiz # April 8, 03 Name: SOUTION ID#: PS.: A the

More information

Contents. Preface... xi. Introduction...

Contents. Preface... xi. Introduction... Contents Preface... xi Introduction... xv Chapter 1. Computer Architectures... 1 1.1. Different types of parallelism... 1 1.1.1. Overlap, concurrency and parallelism... 1 1.1.2. Temporal and spatial parallelism

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 THE EXPLICIT FINITE ELEMENT METHOD FOR NONLINEAR TRANSIENT DYNAMICS

INTRODUCTION TO THE EXPLICIT FINITE ELEMENT METHOD FOR NONLINEAR TRANSIENT DYNAMICS INTRODUCTION TO THE EXPLICIT FINITE ELEMENT METHOD FOR NONLINEAR TRANSIENT DYNAMICS SHEN R. WU and LEI GU WILEY A JOHN WILEY & SONS, INC., PUBLICATION ! PREFACE xv PARTI FUNDAMENTALS 1 1 INTRODUCTION 3

More information

Sparse Linear Systems. Iterative Methods for Sparse Linear Systems. Motivation for Studying Sparse Linear Systems. Partial Differential Equations

Sparse Linear Systems. Iterative Methods for Sparse Linear Systems. Motivation for Studying Sparse Linear Systems. Partial Differential Equations Sparse Linear Systems Iterative Methods for Sparse Linear Systems Matrix Computations and Applications, Lecture C11 Fredrik Bengzon, Robert Söderlund We consider the problem of solving the linear system

More information

Multigrid Methods and their application in CFD

Multigrid Methods and their application in CFD Multigrid Methods and their application in CFD Michael Wurst TU München 16.06.2009 1 Multigrid Methods Definition Multigrid (MG) methods in numerical analysis are a group of algorithms for solving differential

More information

CHAPTER 14 BUCKLING ANALYSIS OF 1D AND 2D STRUCTURES

CHAPTER 14 BUCKLING ANALYSIS OF 1D AND 2D STRUCTURES CHAPTER 14 BUCKLING ANALYSIS OF 1D AND 2D STRUCTURES 14.1 GENERAL REMARKS In structures where dominant loading is usually static, the most common cause of the collapse is a buckling failure. Buckling may

More information

Nonlinear Theory of Elasticity. Dr.-Ing. Martin Ruess

Nonlinear Theory of Elasticity. Dr.-Ing. Martin Ruess Nonlinear Theory of Elasticity Dr.-Ing. Martin Ruess geometry description Cartesian global coordinate system with base vectors of the Euclidian space orthonormal basis origin O point P domain of a deformable

More information