Efficient hp-finite elements

Size: px
Start display at page:

Download "Efficient hp-finite elements"

Transcription

1 Efficient hp-finite elements Ammon Washburn July 31, 2015 Abstract Ways to make an hp-finite element method efficient are presented. Standard FEMs and hp-fems with their various strengths and weaknesses are compared. Strategies to allow the hp-fems to be faster are described and examples are shown. 1 Introduction The finite element method is heavily used in industry, especially in solid and fluid mechanics. It allows the simulation of complex two and three dimensional problems using very simple piece-wise polynomials. The normal approach is to use small degree polynomials and a large number of elements. The elements quickly grow in these settings and the problem becomes intractable. In order to get accurate results for a small number of elements, there has been a need to develop hp FEMs which allow for exponential rates of convergence [2]. Melenk et al and Ainsworth et al seek to develop hp FEMs that have the same asymptotic computation count as the standard finite element methods. They have both developed a basis of polynomials with the needed properties to allow for efficient evaluation of their integrals. Melenk et al developed a basis for hexahedral elements [2] while Ainsworth et al developed a basis for simplicial elements [1]. I would like to verify their results and compare the two ways to see if they are compatible. I will first provide a background of FEMs to illustrate the importance of hp FEMs. I will explain the two methods which allow for easy evaluation of the integrals in hp-fe. Then I will explain what Melenk et al and Ainsworth et al did and describe further directions to improve these methods. 2 Background Boris Galerkin was a Polish mathematician who developed ways to solve problems dealing with infinite spaces. He developed a way to find an approximate answer to an infinite dimensional problem. The problem is this: Find u V satisfying a(u, v) = f(v) v V where f is a functional and a is bilinear. Galerkin posed a similar but easier problem: Consider a finite-dimensional sub-space V n of the infinite dimensional Hilbert space V which we hope is dense in V or close enough. The solution for this problem is easy: In this sub-space V n it is enough to find u n so that a(u, e i ) = f(e i ) for every basis element e i V n In terms of FE methods, the finite dimensional space is piece-wise polynomials of degree n. The 1

2 Figure 1: The approximate solution from the finite dimensional space might or might not be close enough to the real solution. Depends on your finite dimensional space. differential equation is turned into it s weak formulation and all polynomials are iterated in the basis through this weak formulation. Each element gives a local stiffness matrix and the matrices are assembled into a global stiffness matrix which is then solved to find the coefficients on the basis functions to make up the approximate solution. In order to make the approximation better, hitherto it was necessary to make lots of elements with a low degree or to keep a small number of elements but with the polynomial degree very high. The hp-fem seeks to combine the advantages of both while still having the same optimal operation count that these first methods had. 3 Sum Factorization Typically for calculating two dimensions, a double summation has this form: q 0 q 1 s=1 t=1 Φ 1 i (x s )Φ 2 j(y t )Ψ 1 k(x s )Ψ 2 l (y t )w s w t b(x s, y t ) Where Φ and Ψ come from the basis functions, w s and w t are weights associated with a quadrature formula, b(x s, y t ) is a map from a master element to the element currently being worked on, and i, j, k and l all index the one dimensional basis functions. This requires n 4 q 0 q 1 number of operations! However, if some pieces are factored out of the first summation and summed up first, then it only requires n 2 q 1 (n 2 + q 0 ) operations. q 0 s=1 Φ 1 i (x s )Ψ 1 k(x s ) q 1 t=1 Φ 2 j(y t )Ψ 2 l (y t )w s w t b(x s, y t ) This is a very simple operation, but it requires the basis to have some sort of tensor product, or in the case of simplicial elements, some transformation to a tensor polynomial [1]. 4 Spectral Methods Eventually it will become necessary to use some quadrature rule to evaluate the integrals. Because the basis functions are piece-wise polynomials, Gauss- 2

3 Figure 2: There are usually associated nine degrees of freedom with a square element Lobatto quadrature rules can exactly evaluate the integrals. Knowing this, the shape polynomials (the polynomials that are zero on the boundary but give the element shape in the middle) will be designed to be zero at most of the points of the quadrature rule. This will drastically decrease the number of evaluations. Consider again q 0 s=1 Φ 1 i (x s )Ψ 1 k(x s ) q 1 t=1 Φ 2 j(y t )Ψ 2 l (y t )w s w t b(x s, y t ) What if most of Φ 1 i (x s)φ 2 j (y t)ψ 1 k (x s)ψ 2 l (y t) was zero? Then the operation count would be n 2 q 1(n 2 +q 0) where q 1, q 0 << q 1, q 0. As an example, it requires about fifty function evaluations to exactly approximate the integral of a hundred degree polynomial but with classical spectral methods, it would require one point. However, over integration is important to insure that the method is stable. This is done by writing the basis functions of degree p with Lagrange interpolants l i based on the p + q + 1 points of Gaussian quadrature. l i (ξ j ) = 0 for all but q + 1 points where ξ j is the j th node in Gaussian quadrature of p + q + 1 points. This over integration allows you to pick just how many extra evaluations (q) that you want to add. Note that usually p is in the range of a hundred while q is in the range of ten. 5 Hp-spectral Galerkin FEM Melenk et al provide a basis and method for hp-fem called the hp-spectral Galerkin FEM that can take advantage of both sum factorization and the spectral method. For simplicity of presentation, I will describe the 2D form of the basis functions, though the authors believe a similar extension to 3D is easy enough to see because of the tensor nature of the basis functions. 5.1 Basis functions In figure 2, there are four black dots, a 1, a 2, a 3, a 4, on the vertex nodes that represent the simple bilinear nodes. The function space E 0 of these functions is defined by the following, h 1 (x) = 1 x, h 2 (x) = x, E 0 = h i (x) h j (y) (i, j) 1, 2 1, 2 3

4 When these functions are bilinear, they are a lot easier to deal with. That is why standard FEM uses low degree polynomials. However, spectral FEM uses high degree polynomials in the interior to increase convergence to piece-wise analytic solutions. The interior function space J takes care of the degree of freedom represented by a 9 and is made up as follows: l i (x, GL p+q ) = p+1 i=1 i j x x i, J = l i (x, GL p+q ) l j (y, GL p+q ) 2 i p, 2 j p x j x i Note that although there are p + q + 1 points in GL p+q only p + 1 points are used to make the Lagrange interpolants and the boundary points are always used to make sure they are zero on all the sides. To accurately represent the side nodes, there are many different options that the authors give to write the shape functions. The side shape functions are functions that are zero on every side except one side and take care of the degrees of freedom of the four red dots on the sides, a 5, a 6, a 7, a 8. I will give an example of how to write the function spaces E 1, E 2, E 3, E 4 of side shape functions that also take advantage of the spectral method. Note the h i and l i (x, GL p+q ) are same as before. E 1 = l i (x, GL p+q ) h 1 (y) 2 i p E 2 = E 3 = E 4 = l i (x, GL p+q ) h 2 (y) 2 i p h 1 (x) l i (y, GL p+q ) 2 i p h 2 (x) l i (y, GL p+q ) 2 i p In this example, the same degree is used as the interior functions, but it is flexible enough to handle smaller degrees than the interior. However, the functions will no longer be using the same quadrature rule. Each degree of freedom and the functions associated with them could have their own quadrature rule to which they were adapted. This might be useful if the problem had some inherent scale that you could take advantage of, like modeling a wave front. 5.2 Comparison of asymptotic work By using sum factorization and spectral methods with these basis functions, the order of complexity is reduced from O(p 6 ) to O(p 4 ) in two dimensions. (See table 1 for a comparison in three dimensions.) In this case the p represents the polynomial power of the side shape functions as those are the functions less suited to the quadrature rule. If lower degree polynomials were used instead like in the standard FEM but the high degree interior functions were used as well then hp-spectral FEM has the same asymptotic work as the standard FEM. Of course the method is superior in problems where the solution is piecewise analytic. It requires very few elements to be computed because of the high degree of the interior polynomial. 4

5 Version of hp FEM 2-D 3-D Standard O(p 4 (p + q) 2 ) O(p 6 (p + q) 3 Sum factorization O(p 4 (p + q) + p 2 (p + q) 2 ) O(p 6 (p + q) + p 4 (p + q) 2 + p 2 (p + q) 3 ) Hp-spectral O(p 4 (1 + q) + p 2 q 2 ) O(qp 6 + p 5 + q 2 p 4 + q 3 p 2 ) Table 1: This table is from Melenk et al [2] 6 Bernstein-Bézier FEM In a hexahedral element, the tensor product of the polynomials is natural with finite elements because control of the values at the boundaries is crucial. However, in simplicial elements the tensor product structure doesn t allow for that. Ainsworth et al [1] develop a basis that allows for the control of the boundaries but still allows the use of sum factorization as well. 6.1 Bernstein Polynomials Given a non-degenerate set of corners in the simplex x 1,..., x d+1, define the barycentric coordinates λ = (λ 1,..., λ d+1 ) of any point x R d uniquely by d+1 d+1 x = λ k x k, 1 = k=1 k=1 Define the Bernstein polynomials as ( ) n Bα n = λ α, α Id n α where the standard multi-index notation is used throughout and Id n = α Z d+1 + α = n. I will list some standard multi-index notation for the reader. λ α = d k=1 λα k k, α = d k=1 α k, ( n d α) = n!/α!, α! = k=1 α k!. These Bernstein polynomials have desirable properties. They form a basis for the piece-wise polynomial space, they can match and be continuous across the elements by just looking at the boundary points on the elements, the product of two Bernstein polynomials is just a scaled Bernstein polynomial, and there is a closed form solution for the evaluation of the polynomials. However, in the form the Bernstein polynomials are currently in, we can not take advantage of sum factorization. 6.2 Duffy transformation The Duffy transformation allows the conversion of the Bernstein polynomials into a tensor product construction. The Duffy transformation takes a point t on the unit square in d dimensions and maps it to a point x on a triangle in d dimensions. To get the coordinates you use the following equations: λ 1 = t 1, λ 2 = t 2 (1 t 1 ), λ 3 = t 3 (1 t 1 )(1 t 2 ) λ k 5

6 . λ d = t d (1 t 1 )(1 t 2 )...(1 t d 1 ), λ d+1 = (1 t 1 )(1 t 2 )...(1 t d ) Looking where the corners of the n-dimensional cube get mapped to will illuminate what the transformation is doing. In a n-dimensional cube there are 2 d corners which get mapped to the d + 1 corners of the simplicial element. 2 d i cube corners will get mapped to λ i or the i th corner of the simplicial element for 1 i d and the only point mapping to λ d+1 is (0, 0,..., 0) which accounts for all the 2 d points in a d-dimensional cube. Effectively, the corners of a cube are squeezing together to make a tetrahedral element. Applying this change of coordinates to the Bernstein polynomials, they become a product of one dimensional Bernstein polynomials. Bα(x(t)) n = Bα n 1 (t 1 )Bα n α1 2 (t 2 )...B n α1... α d 1 α d (t d ) Now just integrate over the d-dimensional cube and that will integrate over the tetrahedral element. In these new coordinates the Bernstein polynomials have the tensor product structure needed for sum factorization. Note that with this arrangement that the spectral element methods discussed before can t be used but the Bernstein polynomials are zero on the sides for most of the α Id n which decreases the operation count a little. 7 Further Research The Bernstein-Bézier elements have very desirable properties that make for very efficient evaluation of the elements but the last property that would allow for highly efficient calculations would be an added spectral property that would allow only a few non-zero evaluations to calculate the integrals. This could be done using a different basis for the interior that preserved some of the properties of the Bernstein polynomials but allowed for spectral methods. For the hp-spectral Galerkin elements there needs to be a more rigorous analysis of the stability and convergence of the methods used to calculate the integral, especially since the boundary functions and the interior functions aren t the same degree of polynomial. Numerical studies as well as analysis would help to see when the added complexity of implementing these methods significantly added to the convergence of the method with fewer operations than standard FEM. 8 Conclusion The hp-spectral Galerkin and Bernstein-Bézier FEMs provide for faster convergence to the actual solution with the optimal asymptotic number of computations as normal FEMs. Hp-spectral Galerkin FEMs use high degree tensor product Lagrange interpolants in the interior to obtain faster convergence and then uses sum factorization and spectral methods to decrease the operation count. Bernstein-Bézier FEMs use the properties of Bernstein polynomials and the Duffy transformation to be able to use sum factorization to decrease the 6

7 operation count. Bernstein polynomials have a number of other properties that allow for efficient evaluation such as analytic moments and derivatives. Further areas include more rigorous analysis on the stability and convergence of these methods as well as numerical tests. References [1] Mark Ainsworth, Gaelle Andriamaro, and Oleg Davydov. Bernstein-bézier finite elements of arbitrary order and optimal assembly procedures. SIAM Journal on Scientific Computing, 33(6): , [2] Jens M Melenk, Klaus Gerdes, and Christoph Schwab. Fully discrete hpfinite elements: Fast quadrature. Computer Methods in Applied Mechanics and Engineering, 190(32): ,

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

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

Journal of Computational Physics

Journal of Computational Physics Journal of Computational Physics 23 (211) 8573 862 Contents lists available at SciVerse ScienceDirect Journal of Computational Physics journal homepage: www.elsevier.com/locate/jcp An eigen-based high-order

More information

Slow Growth for Gauss Legendre Sparse Grids

Slow Growth for Gauss Legendre Sparse Grids Slow Growth for Gauss Legendre Sparse Grids John Burkardt, Clayton Webster April 4, 2014 Abstract A sparse grid for multidimensional quadrature can be constructed from products of 1D rules. For multidimensional

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

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

3. Numerical integration

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

More information

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

Solving Boundary Value Problems (with Gaussians)

Solving Boundary Value Problems (with Gaussians) What is a boundary value problem? Solving Boundary Value Problems (with Gaussians) Definition A differential equation with constraints on the boundary Michael McCourt Division Argonne National Laboratory

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

A High-Order Galerkin Solver for the Poisson Problem on the Surface of the Cubed Sphere

A High-Order Galerkin Solver for the Poisson Problem on the Surface of the Cubed Sphere A High-Order Galerkin Solver for the Poisson Problem on the Surface of the Cubed Sphere Michael Levy University of Colorado at Boulder Department of Applied Mathematics August 10, 2007 Outline 1 Background

More information

Implementation of the dg method

Implementation of the dg method Implementation of the dg method Matteo Cicuttin CERMICS - École Nationale des Ponts et Chaussées Marne-la-Vallée March 6, 2017 Outline Model problem, fix notation Representing polynomials Computing integrals

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 3 Conforming Finite Element Methods 3.1 Foundations Ritz-Galerkin Method

Chapter 3 Conforming Finite Element Methods 3.1 Foundations Ritz-Galerkin Method Chapter 3 Conforming Finite Element Methods 3.1 Foundations 3.1.1 Ritz-Galerkin Method Let V be a Hilbert space, a(, ) : V V lr a bounded, V-elliptic bilinear form and l : V lr a bounded linear functional.

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

CHAPTER 4 NUMERICAL INTEGRATION METHODS TO EVALUATE TRIPLE INTEGRALS USING GENERALIZED GAUSSIAN QUADRATURE

CHAPTER 4 NUMERICAL INTEGRATION METHODS TO EVALUATE TRIPLE INTEGRALS USING GENERALIZED GAUSSIAN QUADRATURE CHAPTER 4 NUMERICAL INTEGRATION METHODS TO EVALUATE TRIPLE INTEGRALS USING GENERALIZED GAUSSIAN QUADRATURE 4.1 Introduction Many applications in science and engineering require the solution of three dimensional

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

The Spectral-Element Method: Introduction

The Spectral-Element Method: Introduction The Spectral-Element Method: Introduction Heiner Igel Department of Earth and Environmental Sciences Ludwig-Maximilians-University Munich Computational Seismology 1 / 59 Outline 1 Introduction 2 Lagrange

More information

TMA4220: Programming project - part 1

TMA4220: Programming project - part 1 TMA4220: Programming project - part 1 TMA4220 - Numerical solution of partial differential equations using the finite element method The programming project will be split into two parts. This is the first

More information

Robust exponential convergence of hp-fem for singularly perturbed systems of reaction-diffusion equations

Robust exponential convergence of hp-fem for singularly perturbed systems of reaction-diffusion equations Robust exponential convergence of hp-fem for singularly perturbed systems of reaction-diffusion equations Christos Xenophontos Department of Mathematics and Statistics University of Cyprus joint work with

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

8 A pseudo-spectral solution to the Stokes Problem

8 A pseudo-spectral solution to the Stokes Problem 8 A pseudo-spectral solution to the Stokes Problem 8.1 The Method 8.1.1 Generalities We are interested in setting up a pseudo-spectral method for the following Stokes Problem u σu p = f in Ω u = 0 in Ω,

More information

INTRODUCTION TO FINITE ELEMENT METHODS

INTRODUCTION TO FINITE ELEMENT METHODS INTRODUCTION TO FINITE ELEMENT METHODS LONG CHEN Finite element methods are based on the variational formulation of partial differential equations which only need to compute the gradient of a function.

More information

Nonlinear, Transient Conduction Heat Transfer Using A Discontinuous Galerkin Hierarchical Finite Element Method

Nonlinear, Transient Conduction Heat Transfer Using A Discontinuous Galerkin Hierarchical Finite Element Method Nonlinear, Transient Conduction Heat Transfer Using A Discontinuous Galerkin Hierarchical Finite Element Method by Jerome Charles Sanders B.S. in Physics, May 2002 The College of New Jersey A Thesis submitted

More information

Remarks on the analysis of finite element methods on a Shishkin mesh: are Scott-Zhang interpolants applicable?

Remarks on the analysis of finite element methods on a Shishkin mesh: are Scott-Zhang interpolants applicable? Remarks on the analysis of finite element methods on a Shishkin mesh: are Scott-Zhang interpolants applicable? Thomas Apel, Hans-G. Roos 22.7.2008 Abstract In the first part of the paper we discuss minimal

More information

A very short introduction to the Finite Element Method

A very short introduction to the Finite Element Method A very short introduction to the Finite Element Method Till Mathis Wagner Technical University of Munich JASS 2004, St Petersburg May 4, 2004 1 Introduction This is a short introduction to the finite element

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

Improved Lebesgue constants on the triangle

Improved Lebesgue constants on the triangle Journal of Computational Physics 207 (2005) 625 638 www.elsevier.com/locate/jcp Improved Lebesgue constants on the triangle Wilhelm Heinrichs Universität Duisburg-Essen, Ingenieurmathematik (FB 10), Universitätsstrasse

More information

CS 450 Numerical Analysis. Chapter 8: Numerical Integration and Differentiation

CS 450 Numerical Analysis. Chapter 8: Numerical Integration and Differentiation Lecture slides based on the textbook Scientific Computing: An Introductory Survey by Michael T. Heath, copyright c 2018 by the Society for Industrial and Applied Mathematics. http://www.siam.org/books/cl80

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

Global polynomial interpolants suffer from the Runge Phenomenon if the data sites (nodes) are not chosen correctly.

Global polynomial interpolants suffer from the Runge Phenomenon if the data sites (nodes) are not chosen correctly. Piecewise polynomial interpolation Global polynomial interpolants suffer from the Runge Phenomenon if the data sites (nodes) are not chosen correctly. In many applications, one does not have the freedom

More information

On angle conditions in the finite element method. Institute of Mathematics, Academy of Sciences Prague, Czech Republic

On angle conditions in the finite element method. Institute of Mathematics, Academy of Sciences Prague, Czech Republic On angle conditions in the finite element method Michal Křížek Institute of Mathematics, Academy of Sciences Prague, Czech Republic Joint work with Jan Brandts (University of Amsterdam), Antti Hannukainen

More information

Institut de Recherche MAthématique de Rennes

Institut de Recherche MAthématique de Rennes LMS Durham Symposium: Computational methods for wave propagation in direct scattering. - July, Durham, UK The hp version of the Weighted Regularization Method for Maxwell Equations Martin COSTABEL & Monique

More information

New class of finite element methods: weak Galerkin methods

New class of finite element methods: weak Galerkin methods New class of finite element methods: weak Galerkin methods Xiu Ye University of Arkansas at Little Rock Second order elliptic equation Consider second order elliptic problem: a u = f, in Ω (1) u = 0, on

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

Technische Universität Graz

Technische Universität Graz Technische Universität Graz Sparsity optimized high order finite element functions for Hdiv on simplices S. Beuchler, V. Pillwein, S. Zaglmayr Berichte aus dem Institut für Numerische Mathematik Bericht

More information

LOW-COMPLEXITY FINITE ELEMENT ALGORITHMS FOR THE DE RHAM COMPLEX ON SIMPLICES

LOW-COMPLEXITY FINITE ELEMENT ALGORITHMS FOR THE DE RHAM COMPLEX ON SIMPLICES LOW-COMPLEXIY FINIE ELEMEN ALGORIHMS FOR HE DE RHAM COMPLEX ON SIMPLICES ROBER C. KIRBY Abstract. We combine recently-developed finite element algorithms based on Bernstein polynomials [1, 14] with the

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

Scientific Computing: Numerical Integration

Scientific Computing: Numerical Integration Scientific Computing: Numerical Integration Aleksandar Donev Courant Institute, NYU 1 donev@courant.nyu.edu 1 Course MATH-GA.2043 or CSCI-GA.2112, Fall 2015 Nov 5th, 2015 A. Donev (Courant Institute) Lecture

More information

Approximation SEM-DG pour les problèmes d ondes elasto-acoustiques

Approximation SEM-DG pour les problèmes d ondes elasto-acoustiques Approximation SEM-DG pour les problèmes d ondes elasto-acoustiques Helene Barucq, Henri Calandra, Aurélien Citrain, Julien Diaz, Christian Gout To cite this version: Helene Barucq, Henri Calandra, Aurélien

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

Preface. Figures Figures appearing in the text were prepared using MATLAB R. For product information, please contact:

Preface. Figures Figures appearing in the text were prepared using MATLAB R. For product information, please contact: Linear algebra forms the basis for much of modern mathematics theoretical, applied, and computational. The purpose of this book is to provide a broad and solid foundation for the study of advanced mathematics.

More information

Numerical Analysis of Electromagnetic Fields

Numerical Analysis of Electromagnetic Fields Pei-bai Zhou Numerical Analysis of Electromagnetic Fields With 157 Figures Springer-Verlag Berlin Heidelberg New York London Paris Tokyo Hong Kong Barcelona Budapest Contents Part 1 Universal Concepts

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

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

Generalised Summation-by-Parts Operators and Variable Coefficients

Generalised Summation-by-Parts Operators and Variable Coefficients Institute Computational Mathematics Generalised Summation-by-Parts Operators and Variable Coefficients arxiv:1705.10541v [math.na] 16 Feb 018 Hendrik Ranocha 14th November 017 High-order methods for conservation

More information

Sparsity optimized high order finite element functions for H(div) on simplices

Sparsity optimized high order finite element functions for H(div) on simplices Sparsity optimized high order finite element functions for Hdiv on simplices Sven Beuchler, Veronika Pillwein, Sabine Zaglmayr DK-Report No. 010-04 09 010 A 4040 LINZ, ALTENBERGERSTRASSE 69, AUSTRIA Supported

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

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

AMS 529: Finite Element Methods: Fundamentals, Applications, and New Trends AMS 529: Finite Element Methods: Fundamentals, Applications, and New Trends Lecture 3: Finite Elements in 2-D Xiangmin Jiao SUNY Stony Brook Xiangmin Jiao Finite Element Methods 1 / 18 Outline 1 Boundary

More information

Numerical Integration in Meshfree Methods

Numerical Integration in Meshfree Methods Numerical Integration in Meshfree Methods Pravin Madhavan New College University of Oxford A thesis submitted for the degree of Master of Science in Mathematical Modelling and Scientific Computing Trinity

More information

19. TAYLOR SERIES AND TECHNIQUES

19. TAYLOR SERIES AND TECHNIQUES 19. TAYLOR SERIES AND TECHNIQUES Taylor polynomials can be generated for a given function through a certain linear combination of its derivatives. The idea is that we can approximate a function by a polynomial,

More information

Parallel Discontinuous Galerkin Method

Parallel Discontinuous Galerkin Method Parallel Discontinuous Galerkin Method Yin Ki, NG The Chinese University of Hong Kong Aug 5, 2015 Mentors: Dr. Ohannes Karakashian, Dr. Kwai Wong Overview Project Goal Implement parallelization on Discontinuous

More information

Applied/Numerical Analysis Qualifying Exam

Applied/Numerical Analysis Qualifying Exam Applied/Numerical Analysis Qualifying Exam August 9, 212 Cover Sheet Applied Analysis Part Policy on misprints: The qualifying exam committee tries to proofread exams as carefully as possible. Nevertheless,

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

Solving the steady state diffusion equation with uncertainty Final Presentation

Solving the steady state diffusion equation with uncertainty Final Presentation Solving the steady state diffusion equation with uncertainty Final Presentation Virginia Forstall vhfors@gmail.com Advisor: Howard Elman elman@cs.umd.edu Department of Computer Science May 6, 2012 Problem

More information

Non-Conforming Finite Element Methods for Nonmatching Grids in Three Dimensions

Non-Conforming Finite Element Methods for Nonmatching Grids in Three Dimensions Non-Conforming Finite Element Methods for Nonmatching Grids in Three Dimensions Wayne McGee and Padmanabhan Seshaiyer Texas Tech University, Mathematics and Statistics (padhu@math.ttu.edu) Summary. In

More information

Convergence under Subdivision and Complexity of Polynomial Minimization in the Simplicial Bernstein Basis

Convergence under Subdivision and Complexity of Polynomial Minimization in the Simplicial Bernstein Basis Convergence under Subdivision and Complexity of Polynomial Minimization in the Simplicial Bernstein Basis Richard Leroy IRMAR, University of Rennes 1 richard.leroy@ens-cachan.org Abstract In this article,

More information

Lecture 20: Lagrange Interpolation and Neville s Algorithm. for I will pass through thee, saith the LORD. Amos 5:17

Lecture 20: Lagrange Interpolation and Neville s Algorithm. for I will pass through thee, saith the LORD. Amos 5:17 Lecture 20: Lagrange Interpolation and Neville s Algorithm for I will pass through thee, saith the LORD. Amos 5:17 1. Introduction Perhaps the easiest way to describe a shape is to select some points on

More information

Slow Exponential Growth for Clenshaw Curtis Sparse Grids jburkardt/presentations/... slow growth paper.

Slow Exponential Growth for Clenshaw Curtis Sparse Grids   jburkardt/presentations/... slow growth paper. Slow Exponential Growth for Clenshaw Curtis Sparse Grids http://people.sc.fsu.edu/ jburkardt/presentations/...... slow growth paper.pdf John Burkardt, Clayton Webster April 30, 2014 Abstract A widely used

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

Katholieke Universiteit Leuven Department of Computer Science

Katholieke Universiteit Leuven Department of Computer Science Interpolation with quintic Powell-Sabin splines Hendrik Speleers Report TW 583, January 2011 Katholieke Universiteit Leuven Department of Computer Science Celestijnenlaan 200A B-3001 Heverlee (Belgium)

More information

1 Introduction. 2 Elements and Shape Functions in 1D

1 Introduction. 2 Elements and Shape Functions in 1D Introduction Introduction to the Finite Element Method James R Nagel Department of Electrical and Computer Engineering University of Utah, Salt Lake City, Utah April 4, 0 The finite element method (FEM)

More information

A note on accurate and efficient higher order Galerkin time stepping schemes for the nonstationary Stokes equations

A note on accurate and efficient higher order Galerkin time stepping schemes for the nonstationary Stokes equations A note on accurate and efficient higher order Galerkin time stepping schemes for the nonstationary Stokes equations S. Hussain, F. Schieweck, S. Turek Abstract In this note, we extend our recent work for

More information

Improving Dense Packings of Equal Disks in a Square

Improving Dense Packings of Equal Disks in a Square Improving Dense Packings of Equal Disks in a Square David W. Boll Jerry Donovan Ronald L. Graham Boris D. Lubachevsky Hewlett-Packard Hewlett-Packard University of California Lucent Technologies 00 st

More information

The Discontinuous Galerkin Finite Element Method

The Discontinuous Galerkin Finite Element Method The Discontinuous Galerkin Finite Element Method Michael A. Saum msaum@math.utk.edu Department of Mathematics University of Tennessee, Knoxville The Discontinuous Galerkin Finite Element Method p.1/41

More information

DHANALAKSHMI COLLEGE OF ENGINEERING, CHENNAI DEPARTMENT OF MECHANICAL ENGINEERING ME 6603 FINITE ELEMENT ANALYSIS PART A (2 MARKS)

DHANALAKSHMI COLLEGE OF ENGINEERING, CHENNAI DEPARTMENT OF MECHANICAL ENGINEERING ME 6603 FINITE ELEMENT ANALYSIS PART A (2 MARKS) DHANALAKSHMI COLLEGE OF ENGINEERING, CHENNAI DEPARTMENT OF MECHANICAL ENGINEERING ME 6603 FINITE ELEMENT ANALYSIS UNIT I : FINITE ELEMENT FORMULATION OF BOUNDARY VALUE PART A (2 MARKS) 1. Write the types

More information

Space-time sparse discretization of linear parabolic equations

Space-time sparse discretization of linear parabolic equations Space-time sparse discretization of linear parabolic equations Roman Andreev August 2, 200 Seminar for Applied Mathematics, ETH Zürich, Switzerland Support by SNF Grant No. PDFMP2-27034/ Part of PhD thesis

More information

Numerical Methods I: Numerical Integration/Quadrature

Numerical Methods I: Numerical Integration/Quadrature 1/20 Numerical Methods I: Numerical Integration/Quadrature Georg Stadler Courant Institute, NYU stadler@cims.nyu.edu November 30, 2017 umerical integration 2/20 We want to approximate the definite integral

More information

A MODIFIED DECOUPLED SCALED BOUNDARY-FINITE ELEMENT METHOD FOR MODELING 2D IN-PLANE-MOTION TRANSIENT ELASTODYNAMIC PROBLEMS IN SEMI-INFINITE MEDIA

A MODIFIED DECOUPLED SCALED BOUNDARY-FINITE ELEMENT METHOD FOR MODELING 2D IN-PLANE-MOTION TRANSIENT ELASTODYNAMIC PROBLEMS IN SEMI-INFINITE MEDIA 8 th GRACM International Congress on Computational Mechanics Volos, 2 July 5 July 205 A MODIFIED DECOUPLED SCALED BOUNDARY-FINITE ELEMENT METHOD FOR MODELING 2D IN-PLANE-MOTION TRANSIENT ELASTODYNAMIC

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

Finite Element Solver for Flux-Source Equations

Finite Element Solver for Flux-Source Equations Finite Element Solver for Flux-Source Equations Weston B. Lowrie A thesis submitted in partial fulfillment of the requirements for the degree of Master of Science in Aeronautics Astronautics University

More information

Level 7 Postgraduate Diploma in Engineering Computational mechanics using finite element method

Level 7 Postgraduate Diploma in Engineering Computational mechanics using finite element method 9210-203 Level 7 Postgraduate Diploma in Engineering Computational mechanics using finite element method You should have the following for this examination one answer book No additional data is attached

More information

Slow Exponential Growth for Clenshaw Curtis Sparse Grids

Slow Exponential Growth for Clenshaw Curtis Sparse Grids Slow Exponential Growth for Clenshaw Curtis Sparse Grids John Burkardt Interdisciplinary Center for Applied Mathematics & Information Technology Department Virginia Tech... http://people.sc.fsu.edu/ burkardt/presentations/sgmga

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

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

A Method for Reducing Ill-Conditioning of Polynomial Root Finding Using a Change of Basis

A Method for Reducing Ill-Conditioning of Polynomial Root Finding Using a Change of Basis Portland State University PDXScholar University Honors Theses University Honors College 2014 A Method for Reducing Ill-Conditioning of Polynomial Root Finding Using a Change of Basis Edison Tsai Portland

More information

Middle East Technical University Department of Mechanical Engineering ME 413 Introduction to Finite Element Analysis. Chapter 2 Introduction to FEM

Middle East Technical University Department of Mechanical Engineering ME 413 Introduction to Finite Element Analysis. Chapter 2 Introduction to FEM Middle East Technical University Department of Mechanical Engineering ME 43 Introction to Finite Element Analysis Chapter 2 Introction to FEM These notes are prepared by Dr. Cüneyt Sert http://www.me.metu.e.tr/people/cuneyt

More information

Introduction. J.M. Burgers Center Graduate Course CFD I January Least-Squares Spectral Element Methods

Introduction. J.M. Burgers Center Graduate Course CFD I January Least-Squares Spectral Element Methods Introduction In this workshop we will introduce you to the least-squares spectral element method. As you can see from the lecture notes, this method is a combination of the weak formulation derived from

More information

Introduction. Chapter One

Introduction. Chapter One Chapter One Introduction The aim of this book is to describe and explain the beautiful mathematical relationships between matrices, moments, orthogonal polynomials, quadrature rules and the Lanczos and

More information

Pascal s Triangle on a Budget. Accuracy, Precision and Efficiency in Sparse Grids

Pascal s Triangle on a Budget. Accuracy, Precision and Efficiency in Sparse Grids Covering : Accuracy, Precision and Efficiency in Sparse Grids https://people.sc.fsu.edu/ jburkardt/presentations/auburn 2009.pdf... John Interdisciplinary Center for Applied Mathematics & Information Technology

More information

A GLOBAL COLLOCATION METHOD FOR TWO-DIMENSIONAL RECTANGULAR DOMAINS

A GLOBAL COLLOCATION METHOD FOR TWO-DIMENSIONAL RECTANGULAR DOMAINS JOURNAL OF MECHANICS OF MATERIALS AND STRUCTURES Vol., No., A GLOBAL COLLOCATION METHOD FOR TWO-DIMENSIONAL RECTANGULAR DOMAINS CHRISTOPHER G. PROVATIDIS This paper proposes the use of a global collocation

More information

Feynmann diagrams in a finite dimensional setting

Feynmann diagrams in a finite dimensional setting Feynmann diagrams in a finite dimensional setting Daniel Neiss Uppsala Universitet September 4, 202 Abstract This article aims to explain and justify the use of Feynmann diagrams as a computational tool

More information

Numerical integration and differentiation. Unit IV. Numerical Integration and Differentiation. Plan of attack. Numerical integration.

Numerical integration and differentiation. Unit IV. Numerical Integration and Differentiation. Plan of attack. Numerical integration. Unit IV Numerical Integration and Differentiation Numerical integration and differentiation quadrature classical formulas for equally spaced nodes improper integrals Gaussian quadrature and orthogonal

More information

Fast and accurate methods for the discretization of singular integral operators given on surfaces

Fast and accurate methods for the discretization of singular integral operators given on surfaces Fast and accurate methods for the discretization of singular integral operators given on surfaces James Bremer University of California, Davis March 15, 2018 This is joint work with Zydrunas Gimbutas (NIST

More information

An Introduction to Tropical Geometry

An Introduction to Tropical Geometry An Introduction to Tropical Geometry Ryan Hart Doenges June 8, 2015 1 Introduction In their paper A Bit of Tropical Geometry [1], Erwan Brugallé and Kristin Shaw present an elementary introduction to the

More information

6.080/6.089 GITCS May 6-8, Lecture 22/23. α 0 + β 1. α 2 + β 2 = 1

6.080/6.089 GITCS May 6-8, Lecture 22/23. α 0 + β 1. α 2 + β 2 = 1 6.080/6.089 GITCS May 6-8, 2008 Lecturer: Scott Aaronson Lecture 22/23 Scribe: Chris Granade 1 Quantum Mechanics 1.1 Quantum states of n qubits If you have an object that can be in two perfectly distinguishable

More information

Chapter 2 Definition of Different Types of Finite Elements

Chapter 2 Definition of Different Types of Finite Elements Chapter 2 Definition of Different Types of Finite Elements Abstract This chapter presents a wide variety of finite elements of different shapes (quadrilaterals, hexahedra, triangles, tetrahedra, pyramids

More information

Accuracy, Precision and Efficiency in Sparse Grids

Accuracy, Precision and Efficiency in Sparse Grids John, Information Technology Department, Virginia Tech.... http://people.sc.fsu.edu/ jburkardt/presentations/ sandia 2009.pdf... Computer Science Research Institute, Sandia National Laboratory, 23 July

More information

1 Discretizing BVP with Finite Element Methods.

1 Discretizing BVP with Finite Element Methods. 1 Discretizing BVP with Finite Element Methods In this section, we will discuss a process for solving boundary value problems numerically, the Finite Element Method (FEM) We note that such method is a

More information

Some New Elements for the Reissner Mindlin Plate Model

Some New Elements for the Reissner Mindlin Plate Model Boundary Value Problems for Partial Differential Equations and Applications, J.-L. Lions and C. Baiocchi, eds., Masson, 1993, pp. 287 292. Some New Elements for the Reissner Mindlin Plate Model Douglas

More information

Numerical Solutions of Laplacian Problems over L-Shaped Domains and Calculations of the Generalized Stress Intensity Factors

Numerical Solutions of Laplacian Problems over L-Shaped Domains and Calculations of the Generalized Stress Intensity Factors WCCM V Fifth World Congress on Computational Mechanics July 7-2, 2002, Vienna, Austria Eds.: H.A. Mang, F.G. Rammerstorfer, J. Eberhardsteiner Numerical Solutions of Laplacian Problems over L-Shaped Domains

More information

Lecture 3. Electric Field Flux, Gauss Law. Last Lecture: Electric Field Lines

Lecture 3. Electric Field Flux, Gauss Law. Last Lecture: Electric Field Lines Lecture 3. Electric Field Flux, Gauss Law Last Lecture: Electric Field Lines 1 iclicker Charged particles are fixed on grids having the same spacing. Each charge has the same magnitude Q with signs given

More information

Fast domain decomposition algorithm for discretizations of 3-d elliptic equations by spectral elements

Fast domain decomposition algorithm for discretizations of 3-d elliptic equations by spectral elements www.oeaw.ac.at Fast domain decomposition algorithm for discretizations of 3-d elliptic equations by spectral elements V. Korneev, A. Rytov RICAM-Report 2006-21 www.ricam.oeaw.ac.at Fast domain decomposition

More information

Method in 1D. Introduction of the Basic Concepts and Comparison to Optimal FD Operators

Method in 1D. Introduction of the Basic Concepts and Comparison to Optimal FD Operators The Spectral Element Method in 1D Introduction of the Basic Concepts and Comparison to Optimal FD Operators Seismology and Seismics Seminar 17.06.2003 Ludwigs-Maximilians-Universität München by Bernhard

More information

Open Problems in Mixed Models

Open Problems in Mixed Models xxiii Determining how to deal with a not positive definite covariance matrix of random effects, D during maximum likelihood estimation algorithms. Several strategies are discussed in Section 2.15. For

More information

Rening the submesh strategy in the two-level nite element method: application to the advection diusion equation

Rening the submesh strategy in the two-level nite element method: application to the advection diusion equation INTERNATIONAL JOURNAL FOR NUMERICAL METHODS IN FLUIDS Int. J. Numer. Meth. Fluids 2002; 39:161 187 (DOI: 10.1002/d.219) Rening the submesh strategy in the two-level nite element method: application to

More information

Meshless Local Petrov-Galerkin (MLPG) Methods in

Meshless Local Petrov-Galerkin (MLPG) Methods in Meshless Local Petrov-Galerkin MLPG) Methods in Quantum Mechanics *Williams L Nicomedes Renato C Mesquita *Ferno J S Moreira * Federal University of Minas Gerais Dept of Electronic Engineering Belo Horizonte

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

Three topics in multivariate spline theory

Three topics in multivariate spline theory Simon Foucart Texas A&M University Abstract We examine three topics at the interface between spline theory and algebraic geometry. In the first part, we show how the concept of domain points can be used

More information

Computational Techniques Prof. Sreenivas Jayanthi. Department of Chemical Engineering Indian institute of Technology, Madras

Computational Techniques Prof. Sreenivas Jayanthi. Department of Chemical Engineering Indian institute of Technology, Madras Computational Techniques Prof. Sreenivas Jayanthi. Department of Chemical Engineering Indian institute of Technology, Madras Module No. # 05 Lecture No. # 24 Gauss-Jordan method L U decomposition method

More information