Automating the Finite Element Method

Size: px
Start display at page:

Download "Automating the Finite Element Method"

Transcription

1 Automating the Finite Element Method Anders Logg Toyota Technological Institute at Chicago Johan Hoffman, Johan Jansson, Claes Johnson, Robert C. Kirby, Matthew Knepley, Ridgway Scott Simula Research Laboratory, Oslo August p. 1

2 Automating the finite element method The FEniCS project automates the following aspects of the finite element method: Automatic generation of finite elements (FIAT) e = (K, P, N ) Automatic evaluation of variational forms (FFC) a(v, u) = Ω v u dx Automatic assembly of linear systems (DOLFIN) for all elements e T Ω A += A e Simula Research Laboratory, Oslo August p. 2

3 $ ( ' & % $ # "! +, * Simula Research Laboratory, Oslo August p. 3 Benchmark results: impressive speedups " )

4 Outline FEniCS and the Automation of CMM FIAT, the finite element tabulator FFC, the form compiler DOLFIN, a PSE for differential equations Benchmark results Future directions for FEniCS Simula Research Laboratory, Oslo August p. 4

5 FEniCS and the Automation of CMM Simula Research Laboratory, Oslo August p. 5

6 The FEniCS project A free software project for the Automation of Computational Mathematical Modeling (ACMM), developed at The Toyota Technological Institute at Chicago The University of Chicago Chalmers University of Technology (Göteborg, Sweden) NADA, KTH (Stockholm, Sweden) Argonne National Laboratory (Chicago) Simula Research Laboratory, Oslo August p. 6

7 Main goal: the Automation of CMM Au = f frag replacements U u TOL > 0 Input: Model Au = f and tolerance TOL > 0 Output: Solution U u satisfying U u TOL Produce a solution U satisfying a given accuracy requirement, using a minimal amount of work Simula Research Laboratory, Oslo August p. 7

8 A key step: the automation of discretization frag replacements Au = f F (x) = 0 (V, ˆV ) Input: Model Au = f and discrete representation (V, ˆV ) Output: Discrete system F (x) = 0 Produce a discrete system F (x) = 0 corresponding to the model Au = f for the given discrete representation (V, ˆV ) Simula Research Laboratory, Oslo August p. 8

9 Basic algorithm: the (Galerkin) finite element method frag replacements a(v, u) = L(v) F (x) = 0 (V, ˆV ) Input: Variational problem a(v, u) = L(v) for all v and discrete representation (V, ˆV ) Output: Discrete system F (x) = 0 Simula Research Laboratory, Oslo August p. 9

10 FEniCS development Basic principles: Focus on automation Focus on efficiency Focus on consistent user-interfaces Focus on applications Implementation: Organized as a collection reusable components A rapid and open development process Modern programming techniques Novel algorithms Simula Research Laboratory, Oslo August p. 10

11 FEniCS components FIAT, the finite element tabulator Robert C. Kirby FFC, the form compiler Anders Logg DOLFIN, a PSE for differential equations Hoffman, Jansson, Logg, et al. FErari, optimized form evaluation Kirby, Knepley, Logg, Scott, Terrel Ko, simulation of mechanical systems Johan Jansson Puffin, educational version for Octave/MATLAB Hoffman, Logg (PETSc) Simula Research Laboratory, Oslo August p. 11

12 FIAT, the finite element tabulator Simula Research Laboratory, Oslo August p. 12

13 FIAT: FInite element Automatic Tabulator Automates the generation of finite element basis functions Simplifies the specification of new elements Continuous and discontinous Lagrange elements of arbitrary order Crouzeix Raviart (CR) elements Nedelec elements Raviart Thomas (RT) elements Brezzi Douglas Marini (BDM) elements Brezzi Douglas Marini Fortin (BDM) elements In preparation: Taylor-Hood, Arnold-Winther,... Simula Research Laboratory, Oslo August p. 13

14 Implementation Use orthonormal basis on triangles and tets (Dubiner) Express basis functions in terms of the orthonormal basis Translate conditions on function space into linear algebraic relations Implemented in Python Efficient linear algebra Efficient tabulation mode Simula Research Laboratory, Oslo August p. 14

15 Basic usage >>> from FIAT.Lagrange import * >>> from FIAT.shapes import * >>> element = Lagrange(TETRAHEDRON, 3) >>> basis = element.function_space() >>> v = basis[0] >>> v((-1.0, -1.0, -1.0)) 1.0 >>> from FIAT.quadrature import * >>> quadrature = make_quadrature(tetrahedron, 2) >>> points = quadrature.get_points() >>> table = basis.tabulate_jet(2, points) Simula Research Laboratory, Oslo August p. 15

16 FFC, the form compiler Simula Research Laboratory, Oslo August p. 16

17 FFC: the FEniCS Form Compiler Automates a key step in the implementation of finite element methods for partial differential equations Input: a variational form and a finite element Output: optimal C/C++ placements a(v, u) = Ω u(x) v(x) dx FFC Poisson.h >> ffc [-l language] poisson.form Simula Research Laboratory, Oslo August p. 17

18 Design goals Any form Any element Maximum efficiency Possible to combine generality with efficiency by using a compiler approach: Generality Efficiency Compiler Simula Research Laboratory, Oslo August p. 18

19 Features Command-line or Python interface Support for a wide range of elements (through FIAT): Continuous scalar or vector Lagrange elements of arbitrary order (q 1) on triangles and tetrahedra Discontinuous scalar or vector Lagrange elements of arbitrary order (q 0) on triangles and tetrahedra Crouzeix Raviart on triangles and tetrahedra Others in preparation Efficient, close to optimal, evaluation of forms Support for user-defined formats Primary target: DOLFIN/PETSc Simula Research Laboratory, Oslo August p. 19

20 Basic usage 1. Implement the form using your favorite text editor (emacs): 2. Compile the form using FFC: >> ffc poisson.form This will generate C++ code (Poisson.h) for DOLFIN Simula Research Laboratory, Oslo August p. 20

21 Components of FFC Simula Research Laboratory, Oslo August p. 21

22 Basic example: Poisson s equation Strong form: Find u C 2 (Ω) with u = 0 on Ω such that u = f in Ω Weak form: Find u H0 1 (Ω) such that v(x) u(x) dx = v(x)f(x) dx Ω Ω for all v H 1 0 (Ω) Standard notation: Find u V such that a(v, u) = L(v) for all v ˆV with a : ˆV V R a bilinear form and L : ˆV R a linear form (functional) Simula Research Laboratory, Oslo August p. 22

23 Obtaining the discrete system Let V and ˆV be discrete function spaces. Then a(v, U) = L(v) for all v ˆV is a discrete linear system for the approximate solution U u. With V = span{φ i } M i=1 and ˆV = span{ ˆφ i } M i=1, we obtain the linear system Ax = b for the degrees of freedom x = (x i ) of U = M i=1 x iφ i, where A ij = a( ˆφ i, φ j ) b i = L( ˆφ i ) Simula Research Laboratory, Oslo August p. 23

24 Computing the linear system: assembly Noting that a(v, u) = e T a e(v, u), the matrix A can be assembled by A = 0 for all elements e T A += A e The element matrix A e is defined by A e ij = a e ( ˆφ i, φ j ) for all local basis functions ˆφ i and φ j on e Simula Research Laboratory, Oslo August p. 24

25 Multilinear forms Consider a multilinear form a : V 1 V 2 V r R with V 1, V 2,..., V r function spaces on the domain Ω Typically, r = 1 (linear form) or r = 2 (bilinear form) Assume V 1 = V 2 = = V r = V for ease of notation Want to compute the rank r element tensor A e defined by A e i = a e (φ i1, φ i2,..., φ ir ) with {φ i } n i=1 the local basis on e and multiindex i = (i 1, i 2,..., i r ) Simula Research Laboratory, Oslo August p. 25

26 Tensor representation of forms In general, the element tensor A e can be represented as the product of a reference tensor A 0 and a geometric tensor G e : A e i = A 0 iαg α e A 0 : a tensor of rank i + α = r + α G e : a tensor of rank α Basic idea: Precompute A 0 at compile-time Generate optimal code for run-time evaluation of G e and the product A 0 iα Gα e Simula Research Laboratory, Oslo August p. 26

27 The (affine) map F e : E e x 3 replacements X 3 = (0, 1) e x = F e (X) x 2 F e x 1 E X F e (X) = x 1 Φ 1 (X) + x 2 Φ 2 (X) + x 3 Φ 3 (X) X 1 = (0, 0) X 2 = (1, 0) Simula Research Laboratory, Oslo August p. 27

28 Example 1: the mass matrix Form: a(v, u) = Ω v(x)u(x) dx Evaluation: A e i = e φ i1 φ i2 dx = det F e E Φ i1 (X)Φ i2 (X) dx = A 0 i G e with A 0 i = E Φ i 1 (X)Φ i2 (X) dx and G e = det F e Simula Research Laboratory, Oslo August p. 28

29 Example 2: Poisson Form: a(v, u) = Evaluation: A e i = φ i1 (x) φ i2 (x) dx e = det F e X α1 X α2 x β x β Ω v(x) u(x) dx E Φ i1 X α1 Φ i2 X α2 dx = A 0 iαg α e with A 0 iα = E Φ i1 X α1 Φ i2 X α2 dx and G α e = det F e X α1 x β X α2 x β Simula Research Laboratory, Oslo August p. 29

30 An algebra for forms Basic elements: basis functions and their derivatives Define addition, subtraction and multiplication with scalars to generate a vector space Define multiplication between elements of A to generate an algebra: A = {v : v = c φ ( ) / x ( ) } A is the algebra of linear combinations of products of basis functions and their derivatives A is closed under addition, subtraction, multiplication and differentiation Consider only multilinear forms which can be expressed as integrals over the domain Ω of elements of A Simula Research Laboratory, Oslo August p. 30

31 Evaluation of forms For any v = c φ ( ) / x ( ), we have A e i = a e (φ i1, φ i2,..., φ in ) = v i dx e = ( c ) φ ( ) / x ( ) dx = c α e ( E = A 0 iαg α e, ) Φ ( ) / X ( ) dx i iα where A 0 iα = ( E Φ ( ) / X ( ) dx ) iα and Gα e = c α Simula Research Laboratory, Oslo August p. 31

32 Optimization Each entry of the element tensor is given by a scalar product Find dependencies between entries: Colinearity Coplanarity Edit distance Optimization handled by FErari (in preparation) Operation count can sometimes be reduced to less than one multiply-add pair per entry Alternative approach: BLAS level 2 or 3 Simula Research Laboratory, Oslo August p. 32

33 Reference tensor (P 2 Poisson in 2D) Simula Research Laboratory, Oslo August p. 33

34 Minimum spanning tree (P 2 Poisson in 2D) Simula Research Laboratory, Oslo August p. 34

35 DOLFIN, a PSE for differential equations Simula Research Laboratory, Oslo August p. 35

36 DOLFIN Provides a simple, consistent and intuitive API to FEniCS Provides solvers for a collection of standard PDEs Implemented as a C++ library Simula Research Laboratory, Oslo August p. 36

37 Basic usage #include <dolfin.h> #include "Poisson.h" using namespace dolfin; int main() {... Mesh mesh("mesh.xml.gz"); Poisson::BilinearForm a; Poisson::LinearForm L(f); Matrix A; Vector x, b; FEM::assemble(a, L, A, b, mesh, bc); GMRES solver; solver.solve(a, x, b); } return 0; Simula Research Laboratory, Oslo August p. 37

38 Basic concepts (classes) Linear algebra Vector, Matrix, VirtualMatrix LinearSolver, Preconditioner Geometry Mesh, Boundary, MeshHierarchy Vertex, Cell, Edge, Face Finite elements FiniteElement, Function BilinearForm, LinearForm Ordinary differential equations ODE, ComplexODE, ParticleSystem, Homotopy Other: File, Progress, Event, Parameter Simula Research Laboratory, Oslo August p. 38

39 Components of DOLFIN Simula Research Laboratory, Oslo August p. 39

40 Components of DOLFIN Simula Research Laboratory, Oslo August p. 40

41 Replacing the backend of DOLFIN Simula Research Laboratory, Oslo August p. 41

42 Example: updated elasticity/plasticity Simulations/animations by Johan Jansson, Computational Technology, Chalmers Simula Research Laboratory, Oslo August p. 42

43 Benchmark results Simula Research Laboratory, Oslo August p. 43

44 H Y Q L U T S R Q P O N M L K J I B < X9 W X [Z Z 4<A < >?01 Simula Research Laboratory, Oslo August p. 44 = 81 ;<3 : Impressive speedups G BC O V F BC E BC D BC 2 3 / 01 1

45 u ] ] f ~ y ~ } { z y x w v o a ^ ^ e i f ˆ ain a m i kl]^ Simula Research Laboratory, Oslo August p. 45 j e^ hi` g a edf c ] Impressive speedups t op ƒ s op r op q op b ` _ ` \ ]^ ^

46 Test case 1: the mass matrix Mathematical notation: FFC implementation: a(v, u) = Ω vu dx v = BasisFunction(element) u = BasisFunction(element) a = v*u*dx Simula Research Laboratory, Oslo August p. 46

47 Ÿ ž š Ž Œ Š Ÿ ž š Ž Œ Š ª Results Simula Research Laboratory, Oslo August p. 47 œ «œ

48 Test case 2: Poisson Mathematical notation: a(v, u) = Ω v u dx = Ω d i=1 v u dx x i x i FFC implementation: v = BasisFunction(element) u = BasisFunction(element) a = v.dx(i)*u.dx(i)*dx Simula Research Laboratory, Oslo August p. 48

49 Ã Â Á À ½ ¼» ³ ² ± Ã Â Á À ½ ¼» ² ± Í Simula Research Laboratory, Oslo August p. 49 Results º É Å ÊÈ Ç ÈÆ Ä ÅÆ ÌË Ë ¹ ¾ µ É Å ÊÈ Ç ÈÆ Ä ÅÆ ÌË Ë Î º ¹ ¾

50 Test case 3: Navier Stokes Mathematical notation: a(v, u) = Ω v(w u) dx = Ω d i=1 d j=1 v i w j u i x j dx FFC implementation: v = BasisFunction(element) u = BasisFunction(element) w = Function(element) a = v[i]*w[j]*u[i].dx(j)*dx Simula Research Laboratory, Oslo August p. 50

51 à ß Þ Ý Ú Ù Ø Ó Ò Ï à ß Þ Ý Ú Ù Ø Ó Ò Ï ê Simula Research Laboratory, Oslo August p. 51 Ñ Ò Ð Ñ Ò Ð Results æ â çå ä åã á âã éè è ÔÏ Ö ÔÏ Ü Û Õ ÔÏ Ñ ÏÐ í ÔÏ æ â çå ä åã á âã éè è ì ÔÏ ë ÔÏ Ü Û ÔÏ Ö ÔÏ Õ ÔÏ Ñ ÏÐ

52 Test case 4: Linear elasticity Mathematical notation: 1 a(v, u) = Ω 4 ( v + ( v) ) : ( u + ( u) ) dx = d d Ω i=1 j=1 1 4 ( v i x j + v j x i )( u i x j + u j x i ) dx FFC implementation: v = BasisFunction(element) u = BasisFunction(element) a = 0.25*(v[i].dx(j) + v[j].dx(i)) * \ (u[i].dx(j) + u[j].dx(i)) * dx Simula Research Laboratory, Oslo August p. 52

53 ÿ þ ý ü ù ø ò ñ î ÿ þ ý ü ù ø ò ñ î Simula Research Laboratory, Oslo August p. 53 ð ñ ï ð ñ ï Results ö óî õ óî û ú ô óî ð îï óî óî óî û ú ö óî õ óî ô óî ð îï

54 Speedup Form q = 1 q = 2 q = 3 q = 4 q = 5 q = 6 q = 7 q = 8 Mass 2D Mass 3D Poisson 2D Poisson 3D Navier Stokes 2D Navier Stokes 3D Elasticity 2D Elasticity 3D Impressive speedups but far from optimal Data access costs more than flops Solution: build arrays and call BLAS (Level 2 or 3) Simula Research Laboratory, Oslo August p. 54

55 ,, * & & * & &,,,, # "! Simula Research Laboratory, Oslo August p. 55 Code bloat * + ( ) %' & $ %& * + ( ) %' & $ %&, /. -., / & 5 (. * 21 )43 0 % 6 2& 5 (. * 21 )43 0 % * ( : (*9 78%& * ( : (*9 78%&

56 Future directions for FEniCS Simula Research Laboratory, Oslo August p. 56

57 Future directions for FEniCS New parallel mesh component (05) Completely parallel assembly/solve (05) Optimize code generation through FErari (05/06) Optimize code generation through BLAS (05/06) Optimize compiler to reduce compile time (05/06) Complete support for non-standard elements (05/06): Crouzeix Raviart, Raviart Thomas, Nedelec, Brezzi Douglas Marini, Brezzi Douglas Fortin Marini, Arnold Winther, Taylor Hood,... Automatic generation of dual problems (06) Automatic generation of error estimates (06) Manuals, tutorials, mini-courses (05/06) Simula Research Laboratory, Oslo August p. 57

58 References A compiler for variational forms Kirby/Logg, submitted to TOMS (2005) Optimizing the evaluation of finite element matrices Kirby/Knepley/Logg/Scott, SISC (2005) Topological optimization of the evaluation of finite element matrices Kirby/Logg/Scott/Terrel, submitted to SISC (2005) FIAT: A new paradigm for computing finite element basis functions Kirby, TOMS (2004) Optimizing FIAT with the Level 3 BLAS Kirby, submitted to TOMS (2005) Evaluation of the action of finite element operators Kirby/Knepley/Scott, submitted to BIT (2004) Simula Research Laboratory, Oslo August p. 58

59 Additional slides Simula Research Laboratory, Oslo August p. 59

60 The Automation of CMM Au = f (iv) U u Ãũ = f cements (i) F (x) = 0 (ii) X x U u TOL (iii) (V, ˆV ) tol > 0 U u Simula Research Laboratory, Oslo August p. 60

61 Example 3: Navier Stokes Form: a(v, u) = Ω v (w )u dx Evaluation: A e i = φ i1 (w )φ i2 dx e = det F e X α3 w α2 Φ i1 [β]φ Φ i 2 [β] α2 [α 1 ] x α1 X α3 E dx = A 0 iαg α e with A 0 iα = E Φ i 1 [β]φ α2 [α 1 ] Φ i 2 [β] X α3 dx and G α e = det F e X α3 x α1 w α2 Simula Research Laboratory, Oslo August p. 61

62 Complexity of form evaluation Basic assumptions: Bilinear form: i = 2 Exact integration of forms Notation: q: polynomial order of basis functions p: total polynomial order of form d: dimension of Ω n: dimension of function space (n q d ) N: number of quadrature points (N p d ) n C : number of coefficients n D : number of derivatives Simula Research Laboratory, Oslo August p. 62

63 Complexity of tensor contraction Need to evaluate A e i = A0 iα Gα e Rank of G α e is n C + n D Number of elements of A e i is n2 Number of elements of G α e is n n C dn D Total cost: T C n 2 n n C d n D (q d ) 2 (q d ) n C d n D q 2d+n Cd d n D Simula Research Laboratory, Oslo August p. 63

64 Complexity of quadrature Need to evaluate A e i at N pd quadrature points Total order of integrand is p = 2q + n C q n D Cost of evaluating integrand is n C + n D d + 1 Total cost: T Q n 2 N(n C + n D d + 1) (q d ) 2 p d (n C + n D d + 1) q 2d (2q + n C q n D ) d (n C + n D d + 1) Simula Research Laboratory, Oslo August p. 64

65 Tensor contraction vs quadrature Speedup: T C q 2d+n Cd d n D T Q q 2d (2q + n C q n D ) d (n C + n D d + 1) T Q /T C (2q + n Cq n D ) d (n C + n D d + 1) q n Cd d n D Rule of thumb: tensor contraction wins for n C = 0, 1 Mass matrix (n C = n D = 0): T Q /T C (2q) d Poisson (n C = 0, n D = 2): T Q /T C (2q 2) d (2d + 1)/d 2 Not clear that tensor contraction wins for the stabilization term of Navier Stokes: (w )u (w )v Need an intelligent system that can do both! Simula Research Laboratory, Oslo August p. 65

Solving an elasto-plastic model using DOLFIN

Solving an elasto-plastic model using DOLFIN Solving an elasto-plastic model using DOLFIN TTI 2005 Johan Jansson johanjan@math.chalmers.se Chalmers University of Technology Solving an elasto-plastic model using DOLFIN p. Overview Motivation Previous

More information

Finite Element Code Generation: Simplicity, Generality, Efficiency

Finite Element Code Generation: Simplicity, Generality, Efficiency : Simplicity, Generality, Efficiency Simula Research Laboratory SCSE 07 Uppsala, August 15 2007 Acknowledgments: Martin Sandve Alnæs, Johan Hoffman, Johan Jansson, Claes Johnson, Robert C. Kirby, Matthew

More information

The FEniCS Project Philosophy, current status and future plans

The FEniCS Project Philosophy, current status and future plans The FEniCS Project Philosophy, current status and future plans Anders Logg logg@simula.no Simula Research Laboratory FEniCS 06 in Delft, November 8-9 2006 Outline Philosophy Recent updates Future plans

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

The FEniCS Project. Anders Logg. Simula Research Laboratory / University of Oslo. Det Norske Veritas

The FEniCS Project. Anders Logg. Simula Research Laboratory / University of Oslo. Det Norske Veritas The FEniCS Project Anders Logg Simula Research Laboratory / University of Oslo Det Norske Veritas 2011 05 11 The FEniCS Project Free Software for Automated Scientific Computing C++/Python library Initiated

More information

Finite Elements with Symbolic Computations and Code Generation

Finite Elements with Symbolic Computations and Code Generation Finite Elements with Symbolic Computations and Code Generation August 15, 2007 Outline We will focus on creating/assembling matrices based on FEM Manual implementation of the integrand/variational form

More information

Framework for functional tree simulation applied to 'golden delicious' apple trees

Framework for functional tree simulation applied to 'golden delicious' apple trees Purdue University Purdue e-pubs Open Access Theses Theses and Dissertations Spring 2015 Framework for functional tree simulation applied to 'golden delicious' apple trees Marek Fiser Purdue University

More information

Automating the Finite Element Method

Automating the Finite Element Method Arch Comput Methods Eng (2007) 14: 93 138 DOI 10.1007/s11831-007-9003-9 Automating the Finite Element Method Anders Logg Received: 22 March 2006 / Accepted: 13 March 2007 / Published online: 15 May 2007

More information

Optimal Control of PDEs

Optimal Control of PDEs Optimal Control of PDEs Suzanne Lenhart University of Tennessee, Knoville Department of Mathematics Lecture1 p.1/36 Outline 1. Idea of diffusion PDE 2. Motivating Eample 3. Big picture of optimal control

More information

An Example file... log.txt

An Example file... log.txt # ' ' Start of fie & %$ " 1 - : 5? ;., B - ( * * B - ( * * F I / 0. )- +, * ( ) 8 8 7 /. 6 )- +, 5 5 3 2( 7 7 +, 6 6 9( 3 5( ) 7-0 +, => - +< ( ) )- +, 7 / +, 5 9 (. 6 )- 0 * D>. C )- +, (A :, C 0 )- +,

More information

Vectors. Teaching Learning Point. Ç, where OP. l m n

Vectors. Teaching Learning Point. Ç, where OP. l m n Vectors 9 Teaching Learning Point l A quantity that has magnitude as well as direction is called is called a vector. l A directed line segment represents a vector and is denoted y AB Å or a Æ. l Position

More information

INTRODUCTION TO THE FINITE ELEMENT SOFTWARE FEniCS ROLAND HERZOG

INTRODUCTION TO THE FINITE ELEMENT SOFTWARE FEniCS ROLAND HERZOG INTRODUCTION TO THE FINITE ELEMENT SOFTWARE FEniCS ROLAND HERZOG 1 Introduction FEniCS is free software for automated solution of differential equations. As a particular feature, it allows the formulation

More information

LA PRISE DE CALAIS. çoys, çoys, har - dis. çoys, dis. tons, mantz, tons, Gas. c est. à ce. C est à ce. coup, c est à ce

LA PRISE DE CALAIS. çoys, çoys, har - dis. çoys, dis. tons, mantz, tons, Gas. c est. à ce. C est à ce. coup, c est à ce > ƒ? @ Z [ \ _ ' µ `. l 1 2 3 z Æ Ñ 6 = Ð l sl (~131 1606) rn % & +, l r s s, r 7 nr ss r r s s s, r s, r! " # $ s s ( ) r * s, / 0 s, r 4 r r 9;: < 10 r mnz, rz, r ns, 1 s ; j;k ns, q r s { } ~ l r mnz,

More information

Vector analysis. 1 Scalars and vectors. Fields. Coordinate systems 1. 2 The operator The gradient, divergence, curl, and Laplacian...

Vector analysis. 1 Scalars and vectors. Fields. Coordinate systems 1. 2 The operator The gradient, divergence, curl, and Laplacian... Vector analysis Abstract These notes present some background material on vector analysis. Except for the material related to proving vector identities (including Einstein s summation convention and the

More information

Connection equations with stream variables are generated in a model when using the # $ % () operator or the & ' %

Connection equations with stream variables are generated in a model when using the # $ % () operator or the & ' % 7 9 9 7 The two basic variable types in a connector potential (or across) variable and flow (or through) variable are not sufficient to describe in a numerically sound way the bi-directional flow of matter

More information

Multilevel Preconditioning of Graph-Laplacians: Polynomial Approximation of the Pivot Blocks Inverses

Multilevel Preconditioning of Graph-Laplacians: Polynomial Approximation of the Pivot Blocks Inverses Multilevel Preconditioning of Graph-Laplacians: Polynomial Approximation of the Pivot Blocks Inverses P. Boyanova 1, I. Georgiev 34, S. Margenov, L. Zikatanov 5 1 Uppsala University, Box 337, 751 05 Uppsala,

More information

! " # $! % & '! , ) ( + - (. ) ( ) * + / 0 1 2 3 0 / 4 5 / 6 0 ; 8 7 < = 7 > 8 7 8 9 : Œ Š ž P P h ˆ Š ˆ Œ ˆ Š ˆ Ž Ž Ý Ü Ý Ü Ý Ž Ý ê ç è ± ¹ ¼ ¹ ä ± ¹ w ç ¹ è ¼ è Œ ¹ ± ¹ è ¹ è ä ç w ¹ ã ¼ ¹ ä ¹ ¼ ¹ ±

More information

An Introduction to Optimal Control Applied to Disease Models

An Introduction to Optimal Control Applied to Disease Models An Introduction to Optimal Control Applied to Disease Models Suzanne Lenhart University of Tennessee, Knoxville Departments of Mathematics Lecture1 p.1/37 Example Number of cancer cells at time (exponential

More information

QUESTIONS ON QUARKONIUM PRODUCTION IN NUCLEAR COLLISIONS

QUESTIONS ON QUARKONIUM PRODUCTION IN NUCLEAR COLLISIONS International Workshop Quarkonium Working Group QUESTIONS ON QUARKONIUM PRODUCTION IN NUCLEAR COLLISIONS ALBERTO POLLERI TU München and ECT* Trento CERN - November 2002 Outline What do we know for sure?

More information

arxiv: v1 [math.na] 14 May 2012

arxiv: v1 [math.na] 14 May 2012 SIAM J. SCI. COMPUT. Vol. 3, No. 6, pp. 430 45 c 009 Society for Industrial and Applied Mathematics EFFICIENT ASSEMBLY OF H(div) AND H(curl) CONFORMING FINITE ELEMENTS MARIE E. ROGNES, ROBERT C. KIRBY,

More information

FEniCS Course. Lecture 1: Introduction to FEniCS. Contributors Anders Logg André Massing

FEniCS Course. Lecture 1: Introduction to FEniCS. Contributors Anders Logg André Massing FEniCS Course Lecture 1: Introduction to FEniCS Contributors Anders Logg André Massing 1 / 15 What is FEniCS? 2 / 15 FEniCS is an automated programming environment for differential equations C++/Python

More information

PREPRINT 2010:23. A nonconforming rotated Q 1 approximation on tetrahedra PETER HANSBO

PREPRINT 2010:23. A nonconforming rotated Q 1 approximation on tetrahedra PETER HANSBO PREPRINT 2010:23 A nonconforming rotated Q 1 approximation on tetrahedra PETER HANSBO Department of Mathematical Sciences Division of Mathematics CHALMERS UNIVERSITY OF TECHNOLOGY UNIVERSITY OF GOTHENBURG

More information

MATH 676. Finite element methods in scientific computing

MATH 676. Finite element methods in scientific computing MATH 676 Finite element methods in scientific computing Wolfgang Bangerth, Texas A&M University Lecture 33.25: Which element to use Part 2: Saddle point problems Consider the stationary Stokes equations:

More information

FEniCS Course. Lecture 1: Introduction to FEniCS. Contributors Anders Logg André Massing

FEniCS Course. Lecture 1: Introduction to FEniCS. Contributors Anders Logg André Massing FEniCS Course Lecture 1: Introduction to FEniCS Contributors Anders Logg André Massing 1 / 30 What is FEniCS? 2 / 30 FEniCS is an automated programming environment for differential equations C++/Python

More information

arxiv: v1 [math.na] 14 May 2012

arxiv: v1 [math.na] 14 May 2012 OPTIMIZING THE EVALUATION OF FINITE ELEMENT MATRICES ROBERT C. KIRBY, MATTHEW KNEPLEY, ANDERS LOGG, AND L. RIDGWAY SCOTT arxiv:1205.2980v1 [math.na] 14 May 2012 Abstract. Assembling stiffness matrices

More information

Planning for Reactive Behaviors in Hide and Seek

Planning for Reactive Behaviors in Hide and Seek University of Pennsylvania ScholarlyCommons Center for Human Modeling and Simulation Department of Computer & Information Science May 1995 Planning for Reactive Behaviors in Hide and Seek Michael B. Moore

More information

A primer on Numerical methods for elasticity

A primer on Numerical methods for elasticity A primer on Numerical methods for elasticity Douglas N. Arnold, University of Minnesota Complex materials: Mathematical models and numerical methods Oslo, June 10 12, 2015 One has to resort to the indignity

More information

Automated Scientific Computing Logg, Mardal, Wells (editors)

Automated Scientific Computing Logg, Mardal, Wells (editors) Automated Scientific Computing Logg, Mardal, Wells (editors) This is a preliminary draft, June 9, 2009. Send comments and suggestions to fenics-book-dev@fenics.org. Automated Scientific Computing The FEniCS

More information

Flexible Specification of Large Systems of Nonlinear PDEs

Flexible Specification of Large Systems of Nonlinear PDEs Flexible Specification of Large Systems of Nonlinear PDEs Hans Petter Langtangen 1,2 Mikael Mortensen 3,1 Center for Biomedical Computing Simula Research Laboratory 1 Dept. of Informatics, University of

More information

Unified Hybridization Of Discontinuous Galerkin, Mixed, And Continuous Galerkin Methods For Second Order Elliptic Problems.

Unified Hybridization Of Discontinuous Galerkin, Mixed, And Continuous Galerkin Methods For Second Order Elliptic Problems. Unified Hybridization Of Discontinuous Galerkin, Mixed, And Continuous Galerkin Methods For Second Order Elliptic Problems. Stefan Girke WWU Münster Institut für Numerische und Angewandte Mathematik 10th

More information

Finite Element Decompositions for Stable Time Integration of Flow Equations

Finite Element Decompositions for Stable Time Integration of Flow Equations MAX PLANCK INSTITUT August 13, 2015 Finite Element Decompositions for Stable Time Integration of Flow Equations Jan Heiland, Robert Altmann (TU Berlin) ICIAM 2015 Beijing DYNAMIK KOMPLEXER TECHNISCHER

More information

OC330C. Wiring Diagram. Recommended PKH- P35 / P50 GALH PKA- RP35 / RP50. Remarks (Drawing No.) No. Parts No. Parts Name Specifications

OC330C. Wiring Diagram. Recommended PKH- P35 / P50 GALH PKA- RP35 / RP50. Remarks (Drawing No.) No. Parts No. Parts Name Specifications G G " # $ % & " ' ( ) $ * " # $ % & " ( + ) $ * " # C % " ' ( ) $ * C " # C % " ( + ) $ * C D ; E @ F @ 9 = H I J ; @ = : @ A > B ; : K 9 L 9 M N O D K P D N O Q P D R S > T ; U V > = : W X Y J > E ; Z

More information

B œ c " " ã B œ c 8 8. such that substituting these values for the B 3 's will make all the equations true

B œ c   ã B œ c 8 8. such that substituting these values for the B 3 's will make all the equations true System of Linear Equations variables Ð unknowns Ñ B" ß B# ß ÞÞÞ ß B8 Æ Æ Æ + B + B ÞÞÞ + B œ, "" " "# # "8 8 " + B + B ÞÞÞ + B œ, #" " ## # #8 8 # ã + B + B ÞÞÞ + B œ, 3" " 3# # 38 8 3 ã + 7" B" + 7# B#

More information

The FEniCS Project. Anders Logg. Simula Research Laboratory University of Oslo NOTUR / 34

The FEniCS Project. Anders Logg. Simula Research Laboratory University of Oslo NOTUR / 34 The FEniCS Project Anders Logg Simula Research Laboratory University of Oslo NOTUR 2011 2011 05 23 1 / 34 What is FEniCS? 2 / 34 FEniCS is an automated programming environment for differential equations

More information

Redoing the Foundations of Decision Theory

Redoing the Foundations of Decision Theory Redoing the Foundations of Decision Theory Joe Halpern Cornell University Joint work with Larry Blume and David Easley Economics Cornell Redoing the Foundations of Decision Theory p. 1/21 Decision Making:

More information

Mixed Finite Element Methods. Douglas N. Arnold, University of Minnesota The 41st Woudschoten Conference 5 October 2016

Mixed Finite Element Methods. Douglas N. Arnold, University of Minnesota The 41st Woudschoten Conference 5 October 2016 Mixed Finite Element Methods Douglas N. Arnold, University of Minnesota The 41st Woudschoten Conference 5 October 2016 Linear elasticity Given the load f : Ω R n, find the displacement u : Ω R n and the

More information

QUADRILATERAL H(DIV) FINITE ELEMENTS

QUADRILATERAL H(DIV) FINITE ELEMENTS QUADRILATERAL H(DIV) FINITE ELEMENTS DOUGLAS N. ARNOLD, DANIELE BOFFI, AND RICHARD S. FALK Abstract. We consider the approximation properties of quadrilateral finite element spaces of vector fields defined

More information

General Neoclassical Closure Theory: Diagonalizing the Drift Kinetic Operator

General Neoclassical Closure Theory: Diagonalizing the Drift Kinetic Operator General Neoclassical Closure Theory: Diagonalizing the Drift Kinetic Operator E. D. Held eheld@cc.usu.edu Utah State University General Neoclassical Closure Theory:Diagonalizing the Drift Kinetic Operator

More information

Matrices and Determinants

Matrices and Determinants Matrices and Determinants Teaching-Learning Points A matri is an ordered rectanguar arra (arrangement) of numbers and encosed b capita bracket [ ]. These numbers are caed eements of the matri. Matri is

More information

Max. Input Power (W) Input Current (Arms) Dimming. Enclosure

Max. Input Power (W) Input Current (Arms) Dimming. Enclosure Product Overview XI025100V036NM1M Input Voltage (Vac) Output Power (W) Output Voltage Range (V) Output urrent (A) Efficiency@ Max Load and 70 ase Max ase Temp. ( ) Input urrent (Arms) Max. Input Power

More information

An abstract Hodge Dirac operator and its stable discretization

An abstract Hodge Dirac operator and its stable discretization An abstract Hodge Dirac operator and its stable discretization Paul Leopardi Mathematical Sciences Institute, Australian National University. For presentation at ICCA, Tartu,. Joint work with Ari Stern,

More information

Expressive Environments and Code Generation for High Performance Computing

Expressive Environments and Code Generation for High Performance Computing Expressive Environments and Code Generation for High Performance Computing Garth N. Wells University of Cambridge SIAM Parallel Processing, 20 February 2014 Collaborators Martin Alnæs, Johan Hake, Richard

More information

F O R SOCI AL WORK RESE ARCH

F O R SOCI AL WORK RESE ARCH 7 TH EUROPE AN CONFERENCE F O R SOCI AL WORK RESE ARCH C h a l l e n g e s i n s o c i a l w o r k r e s e a r c h c o n f l i c t s, b a r r i e r s a n d p o s s i b i l i t i e s i n r e l a t i o n

More information

b i (x) u + c(x)u = f in Ω,

b i (x) u + c(x)u = f in Ω, SIAM J. NUMER. ANAL. Vol. 39, No. 6, pp. 1938 1953 c 2002 Society for Industrial and Applied Mathematics SUBOPTIMAL AND OPTIMAL CONVERGENCE IN MIXED FINITE ELEMENT METHODS ALAN DEMLOW Abstract. An elliptic

More information

Symbols and dingbats. A 41 Α a 61 α À K cb ➋ à esc. Á g e7 á esc. Â e e5 â. Ã L cc ➌ ã esc ~ Ä esc : ä esc : Å esc * å esc *

Symbols and dingbats. A 41 Α a 61 α À K cb ➋ à esc. Á g e7 á esc. Â e e5 â. Ã L cc ➌ ã esc ~ Ä esc : ä esc : Å esc * å esc * Note: Although every effort ws tken to get complete nd ccurte tble, the uhtor cn not be held responsible for ny errors. Vrious sources hd to be consulted nd MIF hd to be exmined to get s much informtion

More information

A Functional Quantum Programming Language

A Functional Quantum Programming Language A Functional Quantum Programming Language Thorsten Altenkirch University of Nottingham based on joint work with Jonathan Grattage and discussions with V.P. Belavkin supported by EPSRC grant GR/S30818/01

More information

Lab 2 Iterative methods and eigenvalue problems. Introduction. Iterative solution of the soap film problem. Beräkningsvetenskap II/NV2, HT (6)

Lab 2 Iterative methods and eigenvalue problems. Introduction. Iterative solution of the soap film problem. Beräkningsvetenskap II/NV2, HT (6) Beräkningsvetenskap II/NV2, HT 2008 1 (6) Institutionen för informationsteknologi Teknisk databehandling Besöksadress: MIC hus 2, Polacksbacken Lägerhyddsvägen 2 Postadress: Box 337 751 05 Uppsala Telefon:

More information

4.3 Laplace Transform in Linear System Analysis

4.3 Laplace Transform in Linear System Analysis 4.3 Laplace Transform in Linear System Analysis The main goal in analysis of any dynamic system is to find its response to a given input. The system response in general has two components: zero-state response

More information

Complex Analysis. PH 503 Course TM. Charudatt Kadolkar Indian Institute of Technology, Guwahati

Complex Analysis. PH 503 Course TM. Charudatt Kadolkar Indian Institute of Technology, Guwahati Complex Analysis PH 503 Course TM Charudatt Kadolkar Indian Institute of Technology, Guwahati ii Copyright 2000 by Charudatt Kadolkar Preface Preface Head These notes were prepared during the lectures

More information

$%! & (, -3 / 0 4, 5 6/ 6 +7, 6 8 9/ 5 :/ 5 A BDC EF G H I EJ KL N G H I. ] ^ _ ` _ ^ a b=c o e f p a q i h f i a j k e i l _ ^ m=c n ^

$%! & (, -3 / 0 4, 5 6/ 6 +7, 6 8 9/ 5 :/ 5 A BDC EF G H I EJ KL N G H I. ] ^ _ ` _ ^ a b=c o e f p a q i h f i a j k e i l _ ^ m=c n ^ ! #" $%! & ' ( ) ) (, -. / ( 0 1#2 ' ( ) ) (, -3 / 0 4, 5 6/ 6 7, 6 8 9/ 5 :/ 5 ;=? @ A BDC EF G H I EJ KL M @C N G H I OPQ ;=R F L EI E G H A S T U S V@C N G H IDW G Q G XYU Z A [ H R C \ G ] ^ _ `

More information

A Mixed Nonconforming Finite Element for Linear Elasticity

A Mixed Nonconforming Finite Element for Linear Elasticity A Mixed Nonconforming Finite Element for Linear Elasticity Zhiqiang Cai, 1 Xiu Ye 2 1 Department of Mathematics, Purdue University, West Lafayette, Indiana 47907-1395 2 Department of Mathematics and Statistics,

More information

THE ANALYSIS OF THE CONVECTIVE-CONDUCTIVE HEAT TRANSFER IN THE BUILDING CONSTRUCTIONS. Zbynek Svoboda

THE ANALYSIS OF THE CONVECTIVE-CONDUCTIVE HEAT TRANSFER IN THE BUILDING CONSTRUCTIONS. Zbynek Svoboda THE NLSIS OF THE CONECTIE-CONDUCTIE HET TRNSFER IN THE BUILDING CONSTRUCTIONS Zbynek Soboda Czech Technical Uniersity in Prague Faculty of Ciil Engineering 166 29 Prague 6 - Czech Republic BSTRCT The numerical

More information

AN IDENTIFICATION ALGORITHM FOR ARMAX SYSTEMS

AN IDENTIFICATION ALGORITHM FOR ARMAX SYSTEMS AN IDENTIFICATION ALGORITHM FOR ARMAX SYSTEMS First the X, then the AR, finally the MA Jan C. Willems, K.U. Leuven Workshop on Observation and Estimation Ben Gurion University, July 3, 2004 p./2 Joint

More information

ETIKA V PROFESII PSYCHOLÓGA

ETIKA V PROFESII PSYCHOLÓGA P r a ž s k á v y s o k á š k o l a p s y c h o s o c i á l n í c h s t u d i í ETIKA V PROFESII PSYCHOLÓGA N a t á l i a S l o b o d n í k o v á v e d ú c i p r á c e : P h D r. M a r t i n S t r o u

More information

ALTER TABLE Employee ADD ( Mname VARCHAR2(20), Birthday DATE );

ALTER TABLE Employee ADD ( Mname VARCHAR2(20), Birthday DATE ); !! "# $ % & '( ) # * +, - # $ "# $ % & '( ) # *.! / 0 "# "1 "& # 2 3 & 4 4 "# $ % & '( ) # *!! "# $ % & # * 1 3 - "# 1 * #! ) & 3 / 5 6 7 8 9 ALTER ; ? @ A B C D E F G H I A = @ A J > K L ; ?

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

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

Principal Secretary to Government Haryana, Town & Country Planning Department, Haryana, Chandigarh.

Principal Secretary to Government Haryana, Town & Country Planning Department, Haryana, Chandigarh. 1 From To Principal Secretary to Government Haryana, Town & Country Planning Department, Haryana, Chandigarh. The Director General, Town & Country Planning Department, Haryana, Chandigarh. Memo No. Misc-2339

More information

Key words. finite element method, partial differential equations, embedded algorithms

Key words. finite element method, partial differential equations, embedded algorithms UNIFIED EMBEDDED PARALLEL FINITE ELEMENT COMPUTATIONS VIA SOFTWARE-BASED FRÉCHET DIFFERENTIATION KEVIN LONG, ROBERT KIRBY, AND BART VAN BLOEMEN WAANDERS Abstract. Computational analysis of systems governed

More information

A Brief Introduction to Tensors

A Brief Introduction to Tensors A Brief Introduction to Tensors Jay R Walton Fall 2013 1 Preliminaries In general, a tensor is a multilinear transformation defined over an underlying finite dimensional vector space In this brief introduction,

More information

Fast Fourier Transform Solvers and Preconditioners for Quadratic Spline Collocation

Fast Fourier Transform Solvers and Preconditioners for Quadratic Spline Collocation Fast Fourier Transform Solvers and Preconditioners for Quadratic Spline Collocation Christina C. Christara and Kit Sun Ng Department of Computer Science University of Toronto Toronto, Ontario M5S 3G4,

More information

n P! " # $ % & % & ' ( ) * + % $, $ -. $ -..! " # ) & % $/ $ - 0 1 2 3 4 5 6 7 3 8 7 9 9 : 3 ; 1 7 < 9 : 5 = > : 9? @ A B C D E F G HI J G H K D L M N O P Q R S T U V M Q P W X X Y W X X Z [ Y \ ] M

More information

Hybridized Discontinuous Galerkin Methods

Hybridized Discontinuous Galerkin Methods Hybridized Discontinuous Galerkin Methods Theory and Christian Waluga Joint work with Herbert Egger (Uni Graz) 1st DUNE User Meeting, Stuttgart Christian Waluga (AICES) HDG Methods October 6-8, 2010 1

More information

Discretization of PDEs and Tools for the Parallel Solution of the Resulting Systems

Discretization of PDEs and Tools for the Parallel Solution of the Resulting Systems Discretization of PDEs and Tools for the Parallel Solution of the Resulting Systems Stan Tomov Innovative Computing Laboratory Computer Science Department The University of Tennessee Wednesday April 4,

More information

Constructive Decision Theory

Constructive Decision Theory Constructive Decision Theory Joe Halpern Cornell University Joint work with Larry Blume and David Easley Economics Cornell Constructive Decision Theory p. 1/2 Savage s Approach Savage s approach to decision

More information

Optimization of a parallel 3d-FFT with non-blocking collective operations

Optimization of a parallel 3d-FFT with non-blocking collective operations Optimization of a parallel 3d-FFT with non-blocking collective operations Chair of Computer Architecture Technical University of Chemnitz Département de Physique Théorique et Appliquée Commissariat à l

More information

3 4 5 6 7 8 9 10 11 12 13 14 15 16 17 REDCLIFF MUNICIPAL PLANNING COMMISSION FOR COMMENT/DISCUSSION DATE: TOPIC: April 27 th, 2018 Bylaw 1860/2018, proposed amendments to the Land Use Bylaw regarding cannabis

More information

Optimizing Stresses for Testing DRAM Cell Defects Using Electrical Simulation

Optimizing Stresses for Testing DRAM Cell Defects Using Electrical Simulation Optimizing Stresses for Testing RAM Cell efects Using Electrical Simulation Zaid Al-Ars Ad J. van de Goor Faculty of Information Technology and Systems Section of Computer Engineering elft University of

More information

ARPACK. A c++ implementation of ARPACK eigenvalue package.

ARPACK. A c++ implementation of ARPACK eigenvalue package. !"#!%$& '()%*,+-. (/10)24365 78$9;:!?A@ B2CED8F?GIHKJ1GML NPORQ&L8S TEJUD8F"VXWYD8FFZ\[]O ^ L8CETIFJ1T_F ; Y`baU c?d%de%c +-)?+-=fc%cgd hjikmlnio

More information

Loop parallelization using compiler analysis

Loop parallelization using compiler analysis Loop parallelization using compiler analysis Which of these loops is parallel? How can we determine this automatically using compiler analysis? Organization of a Modern Compiler Source Program Front-end

More information

AMDiS Usergroup-Meeting

AMDiS Usergroup-Meeting AMDiS Usergroup-Meeting Simon Praetorius Institut für Wissenschaftliches Rechnen 14. Oktober 2013 Simon Praetorius (TU Dresden IWR) AMDiS-Meeting 14. Oktober 2013 1 / 14 Outline 1 Linear solvers PETSc

More information

Weak Galerkin Finite Element Methods and Applications

Weak Galerkin Finite Element Methods and Applications Weak Galerkin Finite Element Methods and Applications Lin Mu mul1@ornl.gov Computational and Applied Mathematics Computationa Science and Mathematics Division Oak Ridge National Laboratory Georgia Institute

More information

ICES REPORT Direct Serendipity Finite Elements on Convex Quadrilaterals

ICES REPORT Direct Serendipity Finite Elements on Convex Quadrilaterals ICES REPORT 17-8 October 017 Direct Serendipity Finite Elements on Convex Quadrilaterals by Todd Arbogast and Zhen Tao The Institute for Computational Engineering and Sciences The University of Texas at

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

The Virtual Element Method: an introduction with focus on fluid flows

The Virtual Element Method: an introduction with focus on fluid flows The Virtual Element Method: an introduction with focus on fluid flows L. Beirão da Veiga Dipartimento di Matematica e Applicazioni Università di Milano-Bicocca VEM people (or group representatives): P.

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

SOLAR MORTEC INDUSTRIES.

SOLAR MORTEC INDUSTRIES. SOLAR MORTEC INDUSTRIES www.mortecindustries.com.au Wind Regions Region A Callytharra Springs Gascoyne Junction Green Head Kununurra Lord Howe Island Morawa Toowoomba Wittanoom Bourke Region B Adelaide

More information

Towards a High Level Quantum Programming Language

Towards a High Level Quantum Programming Language MGS Xmas 04 p.1/?? Towards a High Level Quantum Programming Language Thorsten Altenkirch University of Nottingham based on joint work with Jonathan Grattage and discussions with V.P. Belavkin supported

More information

The University of Bath School of Management is one of the oldest established management schools in Britain. It enjoys an international reputation for

The University of Bath School of Management is one of the oldest established management schools in Britain. It enjoys an international reputation for The University of Bath School of Management is one of the oldest established management schools in Britain. It enjoys an international reputation for the quality of its teaching and research. Its mission

More information

Introduction to Automated Modeling using FEniCS

Introduction to Automated Modeling using FEniCS Introduction to Automated Modeling using FEniCS L. Ridgway Scott University of Chicago Release 0.1 DO NOT DISTRIBUTE February 7, 2017 This page will contain copyright information in due course. Contents

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

AMS subject classifications. Primary, 65N15, 65N30, 76D07; Secondary, 35B45, 35J50

AMS subject classifications. Primary, 65N15, 65N30, 76D07; Secondary, 35B45, 35J50 A SIMPLE FINITE ELEMENT METHOD FOR THE STOKES EQUATIONS LIN MU AND XIU YE Abstract. The goal of this paper is to introduce a simple finite element method to solve the Stokes equations. This method is in

More information

Synopsis of Numerical Linear Algebra

Synopsis of Numerical Linear Algebra Synopsis of Numerical Linear Algebra Eric de Sturler Department of Mathematics, Virginia Tech sturler@vt.edu http://www.math.vt.edu/people/sturler Iterative Methods for Linear Systems: Basics to Research

More information

A multipoint flux mixed finite element method on hexahedra

A multipoint flux mixed finite element method on hexahedra A multipoint flux mixed finite element method on hexahedra Ross Ingram Mary F. Wheeler Ivan Yotov Abstract We develop a mixed finite element method for elliptic problems on hexahedral grids that reduces

More information

Solving PDEs in Minutes - The FEniCS Tutorial Volume I

Solving PDEs in Minutes - The FEniCS Tutorial Volume I Hans Petter Langtangen, Anders Logg Solving PDEs in Minutes - The FEniCS Tutorial Volume I Sep 19, 2016 Springer Email: hpl@simula.no. Center for Biomedical Computing, Simula Research Laboratory and Department

More information

Adorn. sans condensed Smooth. v22622x

Adorn. sans condensed Smooth. v22622x s Adorn f t sans condensed Smooth 9 0 u v22622x user s guide PART OF THE ADORN POMANDER SMOOTH COLLECTION v O P E N T Y P E FAQ : For information on how to access the swashes and alternates, visit LauraWorthingtonType.com/faqs

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

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

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

New BaBar Results on Rare Leptonic B Decays

New BaBar Results on Rare Leptonic B Decays New BaBar Results on Rare Leptonic B Decays Valerie Halyo Stanford Linear Accelerator Center (SLAC) FPCP 22 valerieh@slac.stanford.edu 1 Table of Contents Motivation to look for and Analysis Strategy Measurement

More information

HEXAHEDRAL H(DIV) AND H(CURL) FINITE ELEMENTS

HEXAHEDRAL H(DIV) AND H(CURL) FINITE ELEMENTS HEXAHEDRAL H(DIV) AND H(CURL) FINITE ELEMENTS RICHARD S. FAL, PAOLO GATTO, AND PETER MON Abstract. We study the approximation properties of some finite element subspaces of H(div; Ω) and H(curl ; Ω) defined

More information

Advancing Teaching and Research with Python

Advancing Teaching and Research with Python Advancing Teaching and Research with Python Hans Petter Langtangen Center for Biomedical Computing (CBC) at Simula Research Laboratory Dept. of Informatics, University of Oslo EuroSciPy 2010 Teaching Research

More information

" #$ P UTS W U X [ZY \ Z _ `a \ dfe ih j mlk n p q sr t u s q e ps s t x q s y i_z { U U z W } y ~ y x t i e l US T { d ƒ ƒ ƒ j s q e uˆ ps i ˆ p q y

 #$ P UTS W U X [ZY \ Z _ `a \ dfe ih j mlk n p q sr t u s q e ps s t x q s y i_z { U U z W } y ~ y x t i e l US T { d ƒ ƒ ƒ j s q e uˆ ps i ˆ p q y " #$ +. 0. + 4 6 4 : + 4 ; 6 4 < = =@ = = =@ = =@ " #$ P UTS W U X [ZY \ Z _ `a \ dfe ih j mlk n p q sr t u s q e ps s t x q s y i_z { U U z W } y ~ y x t i e l US T { d ƒ ƒ ƒ j s q e uˆ ps i ˆ p q y h

More information

February 17, 2015 REQUEST FOR PROPOSALS. For Columbus Metropolitan Library. Issued by: Purchasing Division 96 S. Grant Ave. Columbus, OH 43215

February 17, 2015 REQUEST FOR PROPOSALS. For Columbus Metropolitan Library. Issued by: Purchasing Division 96 S. Grant Ave. Columbus, OH 43215 F 7, 05 RQU FOR PROPOL P/B & O RFP L 5-006 F L : P D 96 G, OH 435 D : 3, 05 N :00 N (, O L ) W D, P P D, F D : (64) 849-034; F: (64) 849-34 @ RQU FOR PROPOL NRUON L ( L L ) R P ( RFP ) P B P N L 5-006

More information

Review of Vectors and Matrices

Review of Vectors and Matrices A P P E N D I X D Review of Vectors and Matrices D. VECTORS D.. Definition of a Vector Let p, p, Á, p n be any n real numbers and P an ordered set of these real numbers that is, P = p, p, Á, p n Then P

More information

Introduction to finite element exterior calculus

Introduction to finite element exterior calculus Introduction to finite element exterior calculus Ragnar Winther CMA, University of Oslo Norway Why finite element exterior calculus? Recall the de Rham complex on the form: R H 1 (Ω) grad H(curl, Ω) curl

More information

Obtain from theory/experiment a value for the absorbtion cross-section. Calculate the number of atoms/ions/molecules giving rise to the line.

Obtain from theory/experiment a value for the absorbtion cross-section. Calculate the number of atoms/ions/molecules giving rise to the line. Line Emission Observations of spectral lines offer the possibility of determining a wealth of information about an astronomical source. A usual plan of attack is :- Identify the line. Obtain from theory/experiment

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

Method of Finite Elements I

Method of Finite Elements I Method of Finite Elements I PhD Candidate - Charilaos Mylonas HIL H33.1 and Boundary Conditions, 26 March, 2018 Institute of Structural Engineering Method of Finite Elements I 1 Outline 1 2 Penalty method

More information

First-principles calculations of insulators in a. finite electric field

First-principles calculations of insulators in a. finite electric field Université de Liège First-principles calculations of insulators in a finite electric field M. Veithen, I. Souza, J. Íñiguez, D. Vanderbilt, K. M. Rabe and h. Ghosez Supported by: FNRS Belgium, VW Stiftung,

More information