Dissection sparse direct solver for indefinite finite element matrices and application to a semi-conductor problem

Size: px
Start display at page:

Download "Dissection sparse direct solver for indefinite finite element matrices and application to a semi-conductor problem"

Transcription

1 10th FreeFem++ days 2018, 13 Dec. Dissection sparse direct solver for indefinite finite element matrices and application to a semi-conductor problem Atsushi Suzuki 1 1 Cybermedia Center, Osaka University atsushi.suzuki@cas.cmc.osaka-u.ac.jp joint work with François-Xavier Roux, ONERA, LJLL Sorbonne Université

2 Outline Dissection solver for indefinite matrix overview of nested-dissection algorithm for sparse matrix LDU factorization with symmetric pivoting computation of a solution of singular linear system extension with 2x2 pivoting and unsymmetric pivoting kernel detection algorithm semi-conductor problem mixed finite element formulation of a semi-conductor problem Newton iteration to find a solution of stationary problem example of 3D computation

3 abstract framework V : Hilbert space with inner product (, ) and norm. bilinear form a(, ) : V V R continuous : γ > 0 a(u, v) γ u v u, v V. α 1 > 0 α 2 > 0 a(u, v) sup α 1 u u V. v V,v 0 v a(u, v) sup α 2 v v V. u V,u 0 u find u V s.t. a(u, v) = F (v) v V has a unique solution. U V subspace find u U s.t. a(u, v) = F (v) v U in general, inf-sup condition in subspace U is unclear. in discretized problem : V h V? in linear solver (subspace of V h )?

4 matrix form of mixed finite element method u R Nu, p R Np [ ] [ ] [ ] [ ] u A B T u f K = = p B ɛi p g A: coercive (A x, x ) > 0 x 0 B T : satisfies discrete inf-sup condition, i.e. kerb T = { 0} ɛ > 0 Schur complement matrix S = ɛi + BA 1 B T (S p, p ) = ɛ( p, p ) + (BA 1 B T p, p ) ɛ( p, p ) > 0 LDL T -factorization is possible for any ordering we need to set appropriate regularization ɛ > 0

5 recursive» generation» of Schur» complement by nested-dissection A11 A 21 A11 0 I1 A = 1 11 A 12 A 21 A 22 A 21 S 22 0 I 2 S 22 = A 22 A 21 A 1 11 A 12 = A 22 (A 21 U 1 11 )D 1 11 L 1 11 A 12 : recursively computed 8 9 a b c d e f aa bb 5a 5b a 2b 19 cc dd 6c 6d 3d 1b 1c 1d ee ff 7e 7f 3e 3f 1e a5 b c6 d e7 f a2 b d3 d1 e3 e1 f b1 c Schur complement by sparse solver Schur complement by Schur complement by dense solver dense factorization sparse part : completely in parallel dense part : better use of BLAS 3; dgemm, dtrsm dense solver

6 Symmetric pivoting with postponing for block strategy : 1/2 nested-dissection decomposition may produce singular sub-matrix for indefinite matrix τ : given threshold for postponing, 10 2 A(i, i) / A(i 1, i 1) < τ {A(k, j)} i k,j are postponed i 1 i invertible entries candidates of null pivot Schur complement matrix from postponed pivots is computed

7 Pivoting strategy full pivoting : A = Π T L LUΠ R find max k<i,j n A(i, j) partial pivoting : A = ΠLU find max k<i n A(i, k) k k symmetric pivoting : A = Π T LDUΠ find max k<i n A(k, k) 2 2 pivoting : A = Π T L D UΠ find max k<i,j n det A(i, i) A(i, j) A(j, i) A(j, j) k k sym. pivoting is mathematically not always possible

8 Computation of a solution of singular linear system A R N N, k = dimkera. index ordering {i 1, i 2,, i N } V N k = span[ e i1, e i2,..., e in k ] assumption 1 : V N k kera = { 0} A 1 11 Solution in the space V N k x = A f x VN k (A x f, v) = 0 v V N k» A 1 N 1 = 11 A» 12 N I 2 = A T 11 AT 21, kera = spann 2 I 1, kera T = sapnn 2 2 assumption 2 : u = A f is computable by LDU-factorization with symmetric pivot. f ImA f KerA T N T 2 f = 0 A 21 A 1 11 f 1 f 2 = 0 A A f = f ζ R k, A( u + N 1 ζ) = f u + N 1 ζ (KerA) N T 1 ( u + N 1 ζ) = 0 : algebraic inverse u + N 1 ζ VN k ζ = 0 : computational u + N 1 ζ ImA N T 2 ( u + N 1 ζ) = 0 ImA KerA = { 0} ImA KerA = { 0} N T 2 N 1 is invertible N 1 η ImA KerA N T 2 N 1 η = 0, ImA KerA = { 0} ( N T 2 N 1 η = 0 η = 0 )

9 extension with 2x2 pivoting or unsymmetric pivoting For matrix from PDE, most of part can be factorized with symmetric pivoting. ga 11 has LDU-factorization with symmetric pivot entries of S postponed pivots + some invertible entries of A g A ga 11»»» A11 A A = 12 A11 0 I11 A = 11 1 A 12 A 21 A 22 A 21 S 0 I 2 S = A 22 A 21 A 1 11 A 12 applying full pivot when S is (highly) unsymmetric, S = Π L SΠ R applying 2x2 pivot when S is symmetric + indefinite with full pivoting Π L /Π R S = Π L SΠ R =» S22 S23 S 32 S33 =» E 33 = 0 Ker S = span S 1 S I 3 2 KerA = 6 4»» S22 0 I2 S 1 S S 32 E 33 0 I 3» S 1, KerS = spanπ S R I 3 3 A 1 11 A(2) 12 A 1 11 A(3)» 12 I (2) 7 S Π S R I (3) I 3 2 S

10 novel kernel detection algorithm based on LDU A : N N unsymmetric, dimkera = k 1, dimima m. two parameters: l, n, which define size of factorization,»»» N n A11 A 12 A11 0 I1 A n A 21 A = A 21 S A12 gim 22 0 I n = span 2»Ā 1 11 A12 I 2. projection : P n : R N g Im n solution in subspace, Ā N l b =»Ā 1 11 b 1 0» b1, b = b2 N l l : computed in quadruple-precision with perturbation to simulate double-precision round-off error. kernel detection algorithm DOI: /nme.4729 n : candidate of dimension of the kernel compute for l = n 1, n, n + 1 err (n) l := max Pn max (Ā N la x x), max Ā N la x x x=[ 0 x l ] 0 x x=[ x N l 0] 0 x Ā 1 11 n = k + 1 err n 1 0 err n 0 err n+1 1 n = k err n 1 0 err n 0 err n+1 1 n = k 1 err n 1 0 err n 0 err n+1 1 Theoretically A 1 N k+1, but err(k) k 1 is computable; Ā 1 N AN IN.

11 Solution of singular system in FreeFem++ : 1/2 Navier-Stokes equations with full Dirichlet boundary conditions load "Dissection" defaulttodissection(); solve NavierStokes([u1,u2,p],[v1,v2,q], solver=sparsesolver,tolpivot=1.0e-2) = int2d(th)( [u1,u2] *[v1,v2]*rho/dt + UgradV(u1,u2,up1,up2) *[v1,v2]*rho + 2*nu *(Eps(u1,u2):Eps(v1,v2)) - p * div(v1,v2) - q *div(u1,u2)) // - eps*p*q ) - int2d(th)( [up1,up2] *[v1,v2]*rho/dt - rho*v2 ) +on(1,u1=0,u2=0) without penalization for indefinite system without penalization for Dirichlet boundary condition by tgv

12 Solution of singular system in FreeFem++ : 2/2 Accessing to kernel vectors in cavity driven flow problem load "Dissection" defaulttodissection(); varf vdns ([u1,u2,p],[v1,v2,q]) = int2d(th)( + nu * ( dx(u1)*dx(v1) + dy(u1)*dy(v1) + dx(u2)*dx(v2) + dy(u2)*dy(v2) ) + p*dx(v1)+ p*dy(v2) - dx(u1)*q- dy(u2)*q + (Ugrad(u1,u2,up1,up2) *[v1,v2] + + Ugrad(up1,up2,u1,u2) *[v1,v2]) + on(1,2,3,4,u1=1,u2=1) matrix Ans=vDNS(XXMh,XXMh,tgv=1e+30); real[int] b = vns(0,xxmh,tgv=1e+30); real[int,int] kernn(1,1), kernt(1,1); // N x kerndim int kerndim; set(ans,solver=sparsesolver,strategy=2, tolpivot=1.0e-2); dissectionkernel(ans,kerneldim=kerndim, kerneln=kernn,kernelt=kernt); cout << "kern dim = " << kerndim << endl; Thanks to Pierre Jolivet, GetSolver() added in MarticeCreuse.pp, github: develop

13 Numerical simulation of semi-conductor problem governing equation non-linear system of Drift-Diffusion equations discretization scheme to satisfy conservation law FVM : Scharfetter-Gummel method, 1969 mixed FEM + hybridization + mass lumping = FVM M-matrix property Brezzi-Marini-Pietra, 1987 nonlinear solver Gummel map (a kind of fixed point method), 1964 full Newton iteration linear solver to tread large condition number Bi-CGSTAB : van der Vorst, 1992 Pardiso : Schenk-Gärtner-Schmidthüsen-Fichtner, 1999 mixed formulation with H(div) L 2 directly written by FreeFem++ indefinite unsymmetric system is solved by Dissection stably.

14 Drift-Diffusion system at stationary state ϕ : electrostatic potential n : electron concentration p : hole concentration div(εe) = q(p n + C(x)) divj n = 0 divj p = 0 q : positive electron charge ε : dielectric constant of the materials E = ϕ D n = µ n θ, D p = µ p θ : Einstein s relation J n = q(µ n n ϕ D n n) J p = q(µ p p ϕ + D p p) Maxwell-Boltzmann statistics : p=n i exp( ϕ p ϕ )leads to θ J p = qµ p p ϕ p ϕ p : quasi-fermi level N i : intrinsic concentration of the semiconductor θ = k T/q : thermal voltage k : Boltzmann constant, T : lattice temperature

15 Drift-Diffusion system at stationary state : 2/3 dimensionless system (by De Mari scaling or unit scaling) div(λ 2 ϕ) = p n + C(x) divj n = 0 divj p = 0 J n = n n ϕ J p = ( p + p ϕ) with boundary conditions ϕ = f on Γ D n = g on Γ D p = h on Γ D ϕ ν = 0 on Γ N J n ν = 0 on Γ N n ν = 0 J p ν = 0 on Γ N p ν = 0

16 Boundary conditions for a diode device (thanks to Dr. Sho ) (4) (3) (5) (6) (2) N region : x < 1/4 y > 3/4, C(x, y) = nd = 1017 P region : others C(x, y) = na = 1020 n p = n2i, ni = charge neutrality p n + C(x, y) = 0 on (1), (4). N region p: n = n2i + C 2 /4 + C/2 ' nd P region p: p = n2i + C 2 /4 C/2 ' na (1) (1) (2), (3), (5), (6) (4) ϕ = log( nnai ) + 1 Vth ϕappl ν ϕ = 0 ϕ = log( nndi ) ni na ν n = 0 nd n= ni n= na ni ν p = 0 ni p= nd p=

17 Finite volume discretization with Scharfetter-Gummel method Slotboom variables, ξ : p = ξe ϕ p = ξ(e ϕ ) ξe ϕ ϕ = e ϕ ξ p ϕ J p = p p ϕ = e ϕ ξ approximation of e ϕ J p = ξ in an interval [x i, x i+1 ], h = x i+1 x i xi+1 x i e ϕ dx J p i+1/2 = h ξ i+1/2 (ξ i+1 ξ i ) ϕ : assumed to be linear in the interval [x i, x i+1 ] with ϕ i and ϕ i+1 xi+1 e ϕ dx = 1 [e ϕ(x)] x i+1 h = (e ϕi+1 e ϕi ) dϕ x i x i ϕ d x i+1 ϕ i J p i+1/2 (ξ i+1 ξ i ) ϕ i+1 ϕ i 1 h e ϕi+1 e ϕi = ϕ i+1 ϕ i e ϕi+1 p i+1 e ϕi p i h e ϕi+1 e ϕi = 1 h (B(ϕ i ϕ i+1 )p i+1 B(ϕ i+1 ϕ i )p i ) B(x) = x/(e x 1) : Bernoulli function

18 Mixed variational formulation : 1 / 2 Slotboom variable ξ : p = ξe ϕ div(j p ) = 0 in, e ϕ J p = ξ in. function space : H(div) = {v L 2 () 2 ; div v L 2 ()}, Σ = {v H(div) ; v ν = 0 on Γ N } integration by parts leads to e ϕ J p v = ξ v = ξ v ξv ν e ϕ J p v ξ v = he ϕ v ν Γ D ξv ν Γ N J p q = 0 q L 2 () v Σ

19 Mixed variational formulation : 2 / 2 mixed-type weak formulation find (J p, ξ) Σ L 2 () e ϕ J p v ξ v = he ϕ v ν Γ D J p q = 0 replacing ξ = e ϕ p again, v Σ q L 2 () symmetric indefinite find (J p, p) Σ L 2 () e ϕ J p v e ϕ p v = he ϕ v ν Γ D J p q = 0 v Σ q L 2 () unsymmetric indefinite hybridization of mixed formulation + mass lumping FVM

20 FreeFem++ script Finite element approximation J p H(div) : Raviar-Thomas : p L 2 () ϕ H 1 () : piecewise linear : P 1(K), : piecewise linear : P 1(K). RT 0(K) = (P 0(K)) 2 + xp 0(K), load "Dissection" defaulttodissection(); fespace Vh(Th, RT0); fespace Ph(Th, P1); fespace Xh(Th, P1); Vh [up1, up2], [v1, v2]; Ph pp, q; Xh phi; // obtained in Gummel map problem DDp([up1, up2, pp],[v1, v2, q], solver=sparsesolver,strategy=2, tolpivot=1.0e-2,tgv=1.0e+30) = int2d(th,qft=qf5pt)(exp(phi) * (up1 * v1 + up2 * v2) - exp(phi) * pp * (dx(v1) + dy(v2)) + q * (dx(up1) + dy(up2))) +int1d(th, 1)(gp1 * exp(phi) * (v1 * N.x + v2 * N.y)) +int1d(th, 4)(gp4 * exp(phi) * (v1 * N.x + v2 * N.y)) + on(2, 3, 5, 6, up1 = 0, up2 = 0);

21 Numerical result of a semi-conductor problem compute thermal equilibrium with p = n i exp( ϕ)v th and n = n i exp(ϕ)v th Newton iteration for the potential equation and fixed point iteration for the whole system : a kind of Gummel map electrostatic potential hole concentration

22 Raviart-Thomas finite element RT 0(K) = (P 0(K)) 2 + xp 0(K) (P 1(K)) 2. K : triangle element {E i } : edges of K K E i ν i : outer normal of K on E i Ei : normal to edge E i given by whole triangulation v RT 0(K) v Ei n i P 0(E i ), P i div v P 0(K) finite element basis E i Ψ i ( x) = σ i 2 K ( x P i ) σ i = E i ν i, P i : node of K finite element vector value is continuous on the middle point on E i. inner finite element approximation of H(div ; ). e ϕ h Ψj Ψ i e ϕ1λ1+ϕ2λ2+ϕ3λ3 λ k λ l by exact quadrature K K e ϕ h Ψj Ψ i 1 e P k ϕ kλ k Ψ j K Ψ i : exponential fitting K {λ 1, λ 2, λ 3 } : barycentric coordinates of K K K E i ν i

23 Numerical comparison on accuracy of quadrature relative error of each entry of the stiffness matrix m i j = during 4 iterations of the Gummel map #nnz=31,249 # 1 # 2 quadrature 1% max 1% max qf5pt qf7pt qf9pt # 3 # 4 quadrature 1% max 1% max qf5pt qf7pt qf9pt K e ϕ h Ψj Ψ i ϕ h e ϕ h

24 Nonlinear iteration to obtain the stationary state a variant of Gummel map ϕ m, n m, p m : given ϕ m+1, n m+1, p m+1 by a fixed point method Slotboom variable ξ m, η m p m = ξ m e ϕm n m = η m e ϕm to find a solution of the nonlinear eq. : div(λ 2 ϕ) = p n + C(x) F (η m, ξ m ; ϕ, ψ) = λ 2 ϕ ψ (ξ m e ϕ η m e ϕ + C)ψ = 0 differential calculus with δϕ {H 1 () ; ψ = 0 on Γ D } leads to F (η m, ξ m ; ϕ m + δϕ, ψ) F (η m, ξ m ; ϕ m, ψ) ( = λ 2 δϕ ψ ξ m e ϕm δϕ e ϕm) ( ψ η m e ϕm +δϕ e ϕm) ψ ( = λ 2 δϕ ψ + ξ m e ϕm + η m e ϕm) δϕ ψ = λ 2 δϕ ψ + (p m + n m )δϕ ψ ϕ m+1 = ϕ m + δϕ

25 mixed-type weak formulation find (ϕ, J n, n, J p, p) H 1 () H(div; ) L 2 () H(div; ) L 2 () λ 2 ϕ ψ = (p n + C)ψ ψ H 1 (), e ϕ J n v + e ϕ n v = g n e ϕ v ν v H(div; ), Γ D J n q = 0 q L 2 (), e ϕ J p v e ϕ p v = g p e ϕ v ν v H(div; ), Γ D J p q = 0 q L 2 (). Newton method + initial guess given by a solution by Gummel map coding by FreeFem++ and Dissection 1st order : P1/RT0/P1/RT0/P1 instead of P1/RT0/P0/RT0/P0

26 Newton iteration 1st order scheme twice repeated iteration of Gummel map produces a good initial guess for Newton iteration

27 3D computation : 1/2 tetrahedral mesh with refinement by tetgen # nodes = 29,107 # elements = 165,163 1st order : P1/RT0/P1/RT0/P1 DOF for ϕ = 27,942, (J n, n) = 354,756, full Newton = 73,7454

28 3D computation : 2/2 computing thermal equilibrium by Newton iteration for ϕ Gummel map : fixed point iteration for (J n, n) and (J p, p) + Newton iteration for ϕ, 3 iterations full Newton iteration after 3 Gammel iterations rhs 1e-06 1e-08 1e-10 1e-12 1e iteration Dissection solver for the 4th Newton iteration postponed entries = 8 with τ = 10 2 error = e-09, residual = e-16

29 Summary Full pivoting procedure works as a preconditioner for kernel detection algorithm based on symmetric pivoting Kernel detection routine in Dissection is accessible from FreeFem++, github develop tangent matrix of Newton method with high condition number for highly nonlinear semi-conductor problem is well factorized by Dissection ongoing merging in FreeFem++ ver. 4 quadruple precision solution from given matrix data by double precision with inner iterative refinement by Dissection source code of Dissection is accessible within FreeFem++ repository master/download/dissection under GPL linking-exception / CeCILL-C licenses

A dissection solver with kernel detection for unsymmetric matrices in FreeFem++

A dissection solver with kernel detection for unsymmetric matrices in FreeFem++ . p.1/21 11 Dec. 2014, LJLL, Paris FreeFem++ workshop A dissection solver with kernel detection for unsymmetric matrices in FreeFem++ Atsushi Suzuki Atsushi.Suzuki@ann.jussieu.fr Joint work with François-Xavier

More information

A dissection solver with kernel detection for symmetric finite element matrices on shared memory computers

A dissection solver with kernel detection for symmetric finite element matrices on shared memory computers A dissection solver with kernel detection for symmetric finite element matrices on shared memory computers Atsushi Suzuki, François-Xavier Roux To cite this version: Atsushi Suzuki, François-Xavier Roux.

More information

Numerical simulation of the Gross-Pitaevskii equation by pseudo-spectral and finite element methods comparison of GPS code and FreeFem++

Numerical simulation of the Gross-Pitaevskii equation by pseudo-spectral and finite element methods comparison of GPS code and FreeFem++ . p.1/13 10 ec. 2014, LJLL, Paris FreeFem++ workshop : BECASIM session Numerical simulation of the Gross-Pitaevskii equation by pseudo-spectral and finite element methods comparison of GPS code and FreeFem++

More information

Finite element programming by FreeFem++ advanced course

Finite element programming by FreeFem++ advanced course 1 / 37 Finite element programming by FreeFem++ advanced course Atsushi Suzuki 1 1 Cybermedia Center, Osaka University atsushi.suzuki@cas.cmc.osaka-u.ac.jp Japan SIAM tutorial 4-5, June 2016 2 / 37 Outline

More information

Mixed Finite Elements Method

Mixed Finite Elements Method Mixed Finite Elements Method A. Ratnani 34, E. Sonnendrücker 34 3 Max-Planck Institut für Plasmaphysik, Garching, Germany 4 Technische Universität München, Garching, Germany Contents Introduction 2. Notations.....................................

More information

Recent advances in HPC with FreeFem++

Recent advances in HPC with FreeFem++ Recent advances in HPC with FreeFem++ Pierre Jolivet Laboratoire Jacques-Louis Lions Laboratoire Jean Kuntzmann Fourth workshop on FreeFem++ December 6, 2012 With F. Hecht, F. Nataf, C. Prud homme. Outline

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

Preconditioners for the incompressible Navier Stokes equations

Preconditioners for the incompressible Navier Stokes equations Preconditioners for the incompressible Navier Stokes equations C. Vuik M. ur Rehman A. Segal Delft Institute of Applied Mathematics, TU Delft, The Netherlands SIAM Conference on Computational Science and

More information

A Multigrid Method for Two Dimensional Maxwell Interface Problems

A Multigrid Method for Two Dimensional Maxwell Interface Problems A Multigrid Method for Two Dimensional Maxwell Interface Problems Susanne C. Brenner Department of Mathematics and Center for Computation & Technology Louisiana State University USA JSA 2013 Outline A

More information

LibMesh Experience and Usage

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

More information

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

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

Fast Iterative Solution of Saddle Point Problems

Fast Iterative Solution of Saddle Point Problems Michele Benzi Department of Mathematics and Computer Science Emory University Atlanta, GA Acknowledgments NSF (Computational Mathematics) Maxim Olshanskii (Mech-Math, Moscow State U.) Zhen Wang (PhD student,

More information

SPARSE SOLVERS POISSON EQUATION. Margreet Nool. November 9, 2015 FOR THE. CWI, Multiscale Dynamics

SPARSE SOLVERS POISSON EQUATION. Margreet Nool. November 9, 2015 FOR THE. CWI, Multiscale Dynamics SPARSE SOLVERS FOR THE POISSON EQUATION Margreet Nool CWI, Multiscale Dynamics November 9, 2015 OUTLINE OF THIS TALK 1 FISHPACK, LAPACK, PARDISO 2 SYSTEM OVERVIEW OF CARTESIUS 3 POISSON EQUATION 4 SOLVERS

More information

A Generalization for Stable Mixed Finite Elements

A Generalization for Stable Mixed Finite Elements A Generalization for Stable Mixed Finite Elements Andrew Gillette joint work with Chandrajit Bajaj Department of Mathematics Institute of Computational Engineering and Sciences University of Texas at Austin,

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

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

J.I. Aliaga 1 M. Bollhöfer 2 A.F. Martín 1 E.S. Quintana-Ortí 1. March, 2009

J.I. Aliaga 1 M. Bollhöfer 2 A.F. Martín 1 E.S. Quintana-Ortí 1. March, 2009 Parallel Preconditioning of Linear Systems based on ILUPACK for Multithreaded Architectures J.I. Aliaga M. Bollhöfer 2 A.F. Martín E.S. Quintana-Ortí Deparment of Computer Science and Engineering, Univ.

More information

Scientific Computing: Dense Linear Systems

Scientific Computing: Dense Linear Systems Scientific Computing: Dense Linear Systems Aleksandar Donev Courant Institute, NYU 1 donev@courant.nyu.edu 1 Course MATH-GA.2043 or CSCI-GA.2112, Spring 2012 February 9th, 2012 A. Donev (Courant Institute)

More information

Lecture Note III: Least-Squares Method

Lecture Note III: Least-Squares Method Lecture Note III: Least-Squares Method Zhiqiang Cai October 4, 004 In this chapter, we shall present least-squares methods for second-order scalar partial differential equations, elastic equations of solids,

More information

Chapter 2 Finite Element Spaces for Linear Saddle Point Problems

Chapter 2 Finite Element Spaces for Linear Saddle Point Problems Chapter 2 Finite Element Spaces for Linear Saddle Point Problems Remark 2.1. Motivation. This chapter deals with the first difficulty inherent to the incompressible Navier Stokes equations, see Remark

More information

DRIFT-DIFFUSION SYSTEMS: VARIATIONAL PRINCIPLES AND FIXED POINT MAPS FOR STEADY STATE SEMICONDUCTOR MODELS

DRIFT-DIFFUSION SYSTEMS: VARIATIONAL PRINCIPLES AND FIXED POINT MAPS FOR STEADY STATE SEMICONDUCTOR MODELS DRIFT-DIFFUSION SYSTEMS: VARIATIONAL PRINCIPLES AND FIXED POINT MAPS FOR STEADY STATE SEMICONDUCTOR MODELS Joseph W. Jerome Department of Mathematics Northwestern University Evanston, IL 60208 Abstract

More information

Iterative methods for positive definite linear systems with a complex shift

Iterative methods for positive definite linear systems with a complex shift Iterative methods for positive definite linear systems with a complex shift William McLean, University of New South Wales Vidar Thomée, Chalmers University November 4, 2011 Outline 1. Numerical solution

More information

Least Squares. Tom Lyche. October 26, Centre of Mathematics for Applications, Department of Informatics, University of Oslo

Least Squares. Tom Lyche. October 26, Centre of Mathematics for Applications, Department of Informatics, University of Oslo Least Squares Tom Lyche Centre of Mathematics for Applications, Department of Informatics, University of Oslo October 26, 2010 Linear system Linear system Ax = b, A C m,n, b C m, x C n. under-determined

More information

ENERGY NORM A POSTERIORI ERROR ESTIMATES FOR MIXED FINITE ELEMENT METHODS

ENERGY NORM A POSTERIORI ERROR ESTIMATES FOR MIXED FINITE ELEMENT METHODS ENERGY NORM A POSTERIORI ERROR ESTIMATES FOR MIXED FINITE ELEMENT METHODS CARLO LOVADINA AND ROLF STENBERG Abstract The paper deals with the a-posteriori error analysis of mixed finite element methods

More information

Toward black-box adaptive domain decomposition methods

Toward black-box adaptive domain decomposition methods Toward black-box adaptive domain decomposition methods Frédéric Nataf Laboratory J.L. Lions (LJLL), CNRS, Alpines Inria and Univ. Paris VI joint work with Victorita Dolean (Univ. Nice Sophia-Antipolis)

More information

Uniform inf-sup condition for the Brinkman problem in highly heterogeneous media

Uniform inf-sup condition for the Brinkman problem in highly heterogeneous media Uniform inf-sup condition for the Brinkman problem in highly heterogeneous media Raytcho Lazarov & Aziz Takhirov Texas A&M May 3-4, 2016 R. Lazarov & A.T. (Texas A&M) Brinkman May 3-4, 2016 1 / 30 Outline

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

Efficient Augmented Lagrangian-type Preconditioning for the Oseen Problem using Grad-Div Stabilization

Efficient Augmented Lagrangian-type Preconditioning for the Oseen Problem using Grad-Div Stabilization Efficient Augmented Lagrangian-type Preconditioning for the Oseen Problem using Grad-Div Stabilization Timo Heister, Texas A&M University 2013-02-28 SIAM CSE 2 Setting Stationary, incompressible flow problems

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

Robust Domain Decomposition Preconditioners for Abstract Symmetric Positive Definite Bilinear Forms

Robust Domain Decomposition Preconditioners for Abstract Symmetric Positive Definite Bilinear Forms www.oeaw.ac.at Robust Domain Decomposition Preconditioners for Abstract Symmetric Positive Definite Bilinear Forms Y. Efendiev, J. Galvis, R. Lazarov, J. Willems RICAM-Report 2011-05 www.ricam.oeaw.ac.at

More information

Schur Complements on Hilbert Spaces and Saddle Point Systems

Schur Complements on Hilbert Spaces and Saddle Point Systems Schur Complements on Hilbert Spaces and Saddle Point Systems Constantin Bacuta Mathematical Sciences, University of Delaware, 5 Ewing Hall 976 Abstract For any continuous bilinear form defined on a pair

More information

Fast solvers for steady incompressible flow

Fast solvers for steady incompressible flow ICFD 25 p.1/21 Fast solvers for steady incompressible flow Andy Wathen Oxford University wathen@comlab.ox.ac.uk http://web.comlab.ox.ac.uk/~wathen/ Joint work with: Howard Elman (University of Maryland,

More information

Divergence-conforming multigrid methods for incompressible flow problems

Divergence-conforming multigrid methods for incompressible flow problems Divergence-conforming multigrid methods for incompressible flow problems Guido Kanschat IWR, Universität Heidelberg Prague-Heidelberg-Workshop April 28th, 2015 G. Kanschat (IWR, Uni HD) Hdiv-DG Práha,

More information

An (incomplete) Introduction to FreeFem++

An (incomplete) Introduction to FreeFem++ An (incomplete) Introduction to FreeFem++ Nathaniel Mays Wheeling Jesuit University November 12, 2011 Nathaniel Mays (Wheeling Jesuit University)An (incomplete) Introduction to FreeFem++ November 12, 2011

More information

Locally chosen grad-div stabilization parameters for finite element discretizations of incompressible flow problems

Locally chosen grad-div stabilization parameters for finite element discretizations of incompressible flow problems Locally chosen grad-div stabilization parameters for finite element discretizations of incompressible flow problems Nathan D. Heavner Sponsor: Leo G. Rebholz Abstract Grad-div stabilization has recently

More information

Optimal multilevel preconditioning of strongly anisotropic problems.part II: non-conforming FEM. p. 1/36

Optimal multilevel preconditioning of strongly anisotropic problems.part II: non-conforming FEM. p. 1/36 Optimal multilevel preconditioning of strongly anisotropic problems. Part II: non-conforming FEM. Svetozar Margenov margenov@parallel.bas.bg Institute for Parallel Processing, Bulgarian Academy of Sciences,

More information

The WKB local discontinuous Galerkin method for the simulation of Schrödinger equation in a resonant tunneling diode

The WKB local discontinuous Galerkin method for the simulation of Schrödinger equation in a resonant tunneling diode The WKB local discontinuous Galerkin method for the simulation of Schrödinger equation in a resonant tunneling diode Wei Wang and Chi-Wang Shu Division of Applied Mathematics Brown University Providence,

More information

OUTLINE ffl CFD: elliptic pde's! Ax = b ffl Basic iterative methods ffl Krylov subspace methods ffl Preconditioning techniques: Iterative methods ILU

OUTLINE ffl CFD: elliptic pde's! Ax = b ffl Basic iterative methods ffl Krylov subspace methods ffl Preconditioning techniques: Iterative methods ILU Preconditioning Techniques for Solving Large Sparse Linear Systems Arnold Reusken Institut für Geometrie und Praktische Mathematik RWTH-Aachen OUTLINE ffl CFD: elliptic pde's! Ax = b ffl Basic iterative

More information

Solving PDEs with freefem++

Solving PDEs with freefem++ Solving PDEs with freefem++ Tutorials at Basque Center BCA Olivier Pironneau 1 with Frederic Hecht, LJLL-University of Paris VI 1 March 13, 2011 Do not forget That everything about freefem++ is at www.freefem.org

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

7.4 The Saddle Point Stokes Problem

7.4 The Saddle Point Stokes Problem 346 CHAPTER 7. APPLIED FOURIER ANALYSIS 7.4 The Saddle Point Stokes Problem So far the matrix C has been diagonal no trouble to invert. This section jumps to a fluid flow problem that is still linear (simpler

More information

Parallelism in FreeFem++.

Parallelism in FreeFem++. Parallelism in FreeFem++. Guy Atenekeng 1 Frederic Hecht 2 Laura Grigori 1 Jacques Morice 2 Frederic Nataf 2 1 INRIA, Saclay 2 University of Paris 6 Workshop on FreeFem++, 2009 Outline 1 Introduction Motivation

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

Scientific Computing: Solving Linear Systems

Scientific Computing: Solving Linear Systems Scientific Computing: Solving Linear Systems Aleksandar Donev Courant Institute, NYU 1 donev@courant.nyu.edu 1 Course MATH-GA.2043 or CSCI-GA.2112, Spring 2012 September 17th and 24th, 2015 A. Donev (Courant

More information

Numerical Methods in Matrix Computations

Numerical Methods in Matrix Computations Ake Bjorck Numerical Methods in Matrix Computations Springer Contents 1 Direct Methods for Linear Systems 1 1.1 Elements of Matrix Theory 1 1.1.1 Matrix Algebra 2 1.1.2 Vector Spaces 6 1.1.3 Submatrices

More information

LibMesh Experience and Usage

LibMesh Experience and Usage LibMesh Experience and Usage John W. Peterson peterson@cfdlab.ae.utexas.edu Univ. of Texas at Austin January 12, 2007 1 Introduction 2 Weighted Residuals 3 Poisson Equation 4 Other Examples 5 Essential

More information

Sparse Tensor Galerkin Discretizations for First Order Transport Problems

Sparse Tensor Galerkin Discretizations for First Order Transport Problems Sparse Tensor Galerkin Discretizations for First Order Transport Problems Ch. Schwab R. Hiptmair, E. Fonn, K. Grella, G. Widmer ETH Zürich, Seminar for Applied Mathematics IMA WS Novel Discretization Methods

More information

LECTURE 3: DISCRETE GRADIENT FLOWS

LECTURE 3: DISCRETE GRADIENT FLOWS LECTURE 3: DISCRETE GRADIENT FLOWS Department of Mathematics and Institute for Physical Science and Technology University of Maryland, USA Tutorial: Numerical Methods for FBPs Free Boundary Problems and

More information

DELFT UNIVERSITY OF TECHNOLOGY

DELFT UNIVERSITY OF TECHNOLOGY DELFT UNIVERSITY OF TECHNOLOGY REPORT 13-07 On preconditioning incompressible non-newtonian flow problems Xin He, Maya Neytcheva and Cornelis Vuik ISSN 1389-6520 Reports of the Delft Institute of Applied

More information

Scharfetter Gummel Schemes for Non-Boltzmann Statistics

Scharfetter Gummel Schemes for Non-Boltzmann Statistics Scharfetter Gummel Schemes for Non-Boltzmann Statistics Patricio Farrell Weierstrass Institute (WIAS) Joint work with: T. oprucki, J. Fuhrmann, N. Rotundo, H. Doan ECMI 2016 Numerical methods for interesting

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

Chapter 2. General concepts. 2.1 The Navier-Stokes equations

Chapter 2. General concepts. 2.1 The Navier-Stokes equations Chapter 2 General concepts 2.1 The Navier-Stokes equations The Navier-Stokes equations model the fluid mechanics. This set of differential equations describes the motion of a fluid. In the present work

More information

Incomplete Cholesky preconditioners that exploit the low-rank property

Incomplete Cholesky preconditioners that exploit the low-rank property anapov@ulb.ac.be ; http://homepages.ulb.ac.be/ anapov/ 1 / 35 Incomplete Cholesky preconditioners that exploit the low-rank property (theory and practice) Artem Napov Service de Métrologie Nucléaire, Université

More information

Math 102, Winter Final Exam Review. Chapter 1. Matrices and Gaussian Elimination

Math 102, Winter Final Exam Review. Chapter 1. Matrices and Gaussian Elimination Math 0, Winter 07 Final Exam Review Chapter. Matrices and Gaussian Elimination { x + x =,. Different forms of a system of linear equations. Example: The x + 4x = 4. [ ] [ ] [ ] vector form (or the column

More information

n N D n p = n i p N A

n N D n p = n i p N A Summary of electron and hole concentration in semiconductors Intrinsic semiconductor: E G n kt i = pi = N e 2 0 Donor-doped semiconductor: n N D where N D is the concentration of donor impurity Acceptor-doped

More information

A simple FEM solver and its data parallelism

A simple FEM solver and its data parallelism A simple FEM solver and its data parallelism Gundolf Haase Institute for Mathematics and Scientific Computing University of Graz, Austria Chile, Jan. 2015 Partial differential equation Considered Problem

More information

Finite Elements for Magnetohydrodynamics and its Optimal Control

Finite Elements for Magnetohydrodynamics and its Optimal Control Finite Elements for Magnetohydrodynamics and its Karl Kunisch Marco Discacciati (RICAM) FEM Symposium Chemnitz September 25 27, 2006 Overview 1 2 3 What is Magnetohydrodynamics? Magnetohydrodynamics (MHD)

More information

Lecture 7 - Carrier Drift and Diffusion (cont.) February 20, Non-uniformly doped semiconductor in thermal equilibrium

Lecture 7 - Carrier Drift and Diffusion (cont.) February 20, Non-uniformly doped semiconductor in thermal equilibrium 6.720J/3.43J - Integrated Microelectronic Devices - Spring 2007 Lecture 7-1 Lecture 7 - Carrier Drift and Diffusion (cont.) February 20, 2007 Contents: 1. Non-uniformly doped semiconductor in thermal equilibrium

More information

20. A Dual-Primal FETI Method for solving Stokes/Navier-Stokes Equations

20. A Dual-Primal FETI Method for solving Stokes/Navier-Stokes Equations Fourteenth International Conference on Domain Decomposition Methods Editors: Ismael Herrera, David E. Keyes, Olof B. Widlund, Robert Yates c 23 DDM.org 2. A Dual-Primal FEI Method for solving Stokes/Navier-Stokes

More information

Finite element programming by FreeFem++ intermediate course

Finite element programming by FreeFem++ intermediate course 1 / 73 Finite element programming by FreeFem++ intermediate course Atsushi Suzuki 1 1 Cybermedia Center, Osaka University atsushi.suzuki@cas.cmc.osaka-u.ac.jp Japan SIAM tutorial 11-12, February 2016 2

More information

Multigrid Methods for Saddle Point Problems

Multigrid Methods for Saddle Point Problems Multigrid Methods for Saddle Point Problems Susanne C. Brenner Department of Mathematics and Center for Computation & Technology Louisiana State University Advances in Mathematics of Finite Elements (In

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

A Two-Grid Stabilization Method for Solving the Steady-State Navier-Stokes Equations

A Two-Grid Stabilization Method for Solving the Steady-State Navier-Stokes Equations A Two-Grid Stabilization Method for Solving the Steady-State Navier-Stokes Equations Songul Kaya and Béatrice Rivière Abstract We formulate a subgrid eddy viscosity method for solving the steady-state

More information

A Review of Preconditioning Techniques for Steady Incompressible Flow

A Review of Preconditioning Techniques for Steady Incompressible Flow Zeist 2009 p. 1/43 A Review of Preconditioning Techniques for Steady Incompressible Flow David Silvester School of Mathematics University of Manchester Zeist 2009 p. 2/43 PDEs Review : 1984 2005 Update

More information

S09 MTH 371 Linear Algebra NEW PRACTICE QUIZ 4, SOLUTIONS Prof. G.Todorov February 15, 2009 Please, justify your answers.

S09 MTH 371 Linear Algebra NEW PRACTICE QUIZ 4, SOLUTIONS Prof. G.Todorov February 15, 2009 Please, justify your answers. S09 MTH 37 Linear Algebra NEW PRACTICE QUIZ 4, SOLUTIONS Prof. G.Todorov February, 009 Please, justify your answers. 3 0. Let A = 0 3. 7 Determine whether the column vectors of A are dependent or independent.

More information

Iterative Methods for Linear Systems

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

More information

Discontinuous Petrov-Galerkin Methods

Discontinuous Petrov-Galerkin Methods Discontinuous Petrov-Galerkin Methods Friederike Hellwig 1st CENTRAL School on Analysis and Numerics for Partial Differential Equations, November 12, 2015 Motivation discontinuous Petrov-Galerkin (dpg)

More information

Lecture 15 - The pn Junction Diode (I) I-V Characteristics. November 1, 2005

Lecture 15 - The pn Junction Diode (I) I-V Characteristics. November 1, 2005 6.012 - Microelectronic Devices and Circuits - Fall 2005 Lecture 15-1 Lecture 15 - The pn Junction Diode (I) I-V Characteristics November 1, 2005 Contents: 1. pn junction under bias 2. I-V characteristics

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

ETNA Kent State University

ETNA Kent State University Electronic Transactions on Numerical Analysis. Volume 11, pp. 1-24, 2000. Copyright 2000,. ISSN 1068-9613. ETNA NEUMANN NEUMANN METHODS FOR VECTOR FIELD PROBLEMS ANDREA TOSELLI Abstract. In this paper,

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

Projected Schur Complement Method for Solving Non-Symmetric Saddle-Point Systems (Arising from Fictitious Domain Approaches)

Projected Schur Complement Method for Solving Non-Symmetric Saddle-Point Systems (Arising from Fictitious Domain Approaches) Projected Schur Complement Method for Solving Non-Symmetric Saddle-Point Systems (Arising from Fictitious Domain Approaches) Jaroslav Haslinger, Charles University, Prague Tomáš Kozubek, VŠB TU Ostrava

More information

MULTIGRID PRECONDITIONING IN H(div) ON NON-CONVEX POLYGONS* Dedicated to Professor Jim Douglas, Jr. on the occasion of his seventieth birthday.

MULTIGRID PRECONDITIONING IN H(div) ON NON-CONVEX POLYGONS* Dedicated to Professor Jim Douglas, Jr. on the occasion of his seventieth birthday. MULTIGRID PRECONDITIONING IN H(div) ON NON-CONVEX POLYGONS* DOUGLAS N ARNOLD, RICHARD S FALK, and RAGNAR WINTHER Dedicated to Professor Jim Douglas, Jr on the occasion of his seventieth birthday Abstract

More information

A Finite Element Method for the Surface Stokes Problem

A Finite Element Method for the Surface Stokes Problem J A N U A R Y 2 0 1 8 P R E P R I N T 4 7 5 A Finite Element Method for the Surface Stokes Problem Maxim A. Olshanskii *, Annalisa Quaini, Arnold Reusken and Vladimir Yushutin Institut für Geometrie und

More information

Towards parametric model order reduction for nonlinear PDE systems in networks

Towards parametric model order reduction for nonlinear PDE systems in networks Towards parametric model order reduction for nonlinear PDE systems in networks MoRePas II 2012 Michael Hinze Martin Kunkel Ulrich Matthes Morten Vierling Andreas Steinbrecher Tatjana Stykel Fachbereich

More information

Lecture 8 - Carrier Drift and Diffusion (cont.) September 21, 2001

Lecture 8 - Carrier Drift and Diffusion (cont.) September 21, 2001 6.720J/3.43J - Integrated Microelectronic Devices - Fall 2001 Lecture 8-1 Lecture 8 - Carrier Drift and Diffusion (cont.) September 21, 2001 Contents: 1. Non-uniformly doped semiconductor in thermal equilibrium

More information

A spacetime DPG method for acoustic waves

A spacetime DPG method for acoustic waves A spacetime DPG method for acoustic waves Rainer Schneckenleitner JKU Linz January 30, 2018 ( JKU Linz ) Spacetime DPG method January 30, 2018 1 / 41 Overview 1 The transient wave problem 2 The broken

More information

Department of Computer Science, University of Illinois at Urbana-Champaign

Department of Computer Science, University of Illinois at Urbana-Champaign Department of Computer Science, University of Illinois at Urbana-Champaign Probing for Schur Complements and Preconditioning Generalized Saddle-Point Problems Eric de Sturler, sturler@cs.uiuc.edu, http://www-faculty.cs.uiuc.edu/~sturler

More information

Efficient domain decomposition methods for the time-harmonic Maxwell equations

Efficient domain decomposition methods for the time-harmonic Maxwell equations Efficient domain decomposition methods for the time-harmonic Maxwell equations Marcella Bonazzoli 1, Victorita Dolean 2, Ivan G. Graham 3, Euan A. Spence 3, Pierre-Henri Tournier 4 1 Inria Saclay (Defi

More information

Boundary Value Problems and Iterative Methods for Linear Systems

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

More information

Solving Large Nonlinear Sparse Systems

Solving Large Nonlinear Sparse Systems Solving Large Nonlinear Sparse Systems Fred W. Wubs and Jonas Thies Computational Mechanics & Numerical Mathematics University of Groningen, the Netherlands f.w.wubs@rug.nl Centre for Interdisciplinary

More information

Global Maxwellians over All Space and Their Relation to Conserved Quantites of Classical Kinetic Equations

Global Maxwellians over All Space and Their Relation to Conserved Quantites of Classical Kinetic Equations Global Maxwellians over All Space and Their Relation to Conserved Quantites of Classical Kinetic Equations C. David Levermore Department of Mathematics and Institute for Physical Science and Technology

More information

FINITE ELEMENT APPROXIMATION OF STOKES-LIKE SYSTEMS WITH IMPLICIT CONSTITUTIVE RELATION

FINITE ELEMENT APPROXIMATION OF STOKES-LIKE SYSTEMS WITH IMPLICIT CONSTITUTIVE RELATION Proceedings of ALGORITMY pp. 9 3 FINITE ELEMENT APPROXIMATION OF STOKES-LIKE SYSTEMS WITH IMPLICIT CONSTITUTIVE RELATION JAN STEBEL Abstract. The paper deals with the numerical simulations of steady flows

More information

Challenges for Matrix Preconditioning Methods

Challenges for Matrix Preconditioning Methods Challenges for Matrix Preconditioning Methods Matthias Bollhoefer 1 1 Dept. of Mathematics TU Berlin Preconditioning 2005, Atlanta, May 19, 2005 supported by the DFG research center MATHEON in Berlin Outline

More information

Key words. preconditioned conjugate gradient method, saddle point problems, optimal control of PDEs, control and state constraints, multigrid method

Key words. preconditioned conjugate gradient method, saddle point problems, optimal control of PDEs, control and state constraints, multigrid method PRECONDITIONED CONJUGATE GRADIENT METHOD FOR OPTIMAL CONTROL PROBLEMS WITH CONTROL AND STATE CONSTRAINTS ROLAND HERZOG AND EKKEHARD SACHS Abstract. Optimality systems and their linearizations arising in

More information

Hybrid Discontinuous Galerkin methods for incompressible flow problems

Hybrid Discontinuous Galerkin methods for incompressible flow problems Hybrid Discontinuous Galerkin methods incompressible flow problems Christoph Lehrenfeld, Joachim Schöberl MathCCES Computational Mathematics in Engineering Workshop Linz, May 31 - June 1, 2010 Contents

More information

X. He and M. Neytcheva. Preconditioning the incompressible Navier-Stokes equations with variable viscosity. J. Comput. Math., in press, 2012.

X. He and M. Neytcheva. Preconditioning the incompressible Navier-Stokes equations with variable viscosity. J. Comput. Math., in press, 2012. List of papers This thesis is based on the following papers, which are referred to in the text by their Roman numerals. I II III IV V VI M. Neytcheva, M. Do-Quang and X. He. Element-by-element Schur complement

More information

Key words. inf-sup constant, iterative solvers, preconditioning, saddle point problems

Key words. inf-sup constant, iterative solvers, preconditioning, saddle point problems NATURAL PRECONDITIONING AND ITERATIVE METHODS FOR SADDLE POINT SYSTEMS JENNIFER PESTANA AND ANDREW J. WATHEN Abstract. The solution of quadratic or locally quadratic extremum problems subject to linear(ized)

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

Two-scale Dirichlet-Neumann preconditioners for boundary refinements

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

More information

Efficient Solvers for the Navier Stokes Equations in Rotation Form

Efficient Solvers for the Navier Stokes Equations in Rotation Form Efficient Solvers for the Navier Stokes Equations in Rotation Form Computer Research Institute Seminar Purdue University March 4, 2005 Michele Benzi Emory University Atlanta, GA Thanks to: NSF (MPS/Computational

More information

Discontinuous Galerkin methods for nonlinear elasticity

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

More information

NORMS ON SPACE OF MATRICES

NORMS ON SPACE OF MATRICES NORMS ON SPACE OF MATRICES. Operator Norms on Space of linear maps Let A be an n n real matrix and x 0 be a vector in R n. We would like to use the Picard iteration method to solve for the following system

More information

Research Article A Two-Grid Method for Finite Element Solutions of Nonlinear Parabolic Equations

Research Article A Two-Grid Method for Finite Element Solutions of Nonlinear Parabolic Equations Abstract and Applied Analysis Volume 212, Article ID 391918, 11 pages doi:1.1155/212/391918 Research Article A Two-Grid Method for Finite Element Solutions of Nonlinear Parabolic Equations Chuanjun Chen

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

TD 1: Hilbert Spaces and Applications

TD 1: Hilbert Spaces and Applications Université Paris-Dauphine Functional Analysis and PDEs Master MMD-MA 2017/2018 Generalities TD 1: Hilbert Spaces and Applications Exercise 1 (Generalized Parallelogram law). Let (H,, ) be a Hilbert space.

More information

Multilevel and Adaptive Iterative Substructuring Methods. Jan Mandel University of Colorado Denver

Multilevel and Adaptive Iterative Substructuring Methods. Jan Mandel University of Colorado Denver Multilevel and Adaptive Iterative Substructuring Methods Jan Mandel University of Colorado Denver The multilevel BDDC method is joint work with Bedřich Sousedík, Czech Technical University, and Clark Dohrmann,

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

phenomena during acupuncture Yannick Deleuze Yannick Deleuze

phenomena during acupuncture Yannick Deleuze Yannick Deleuze Modeling FreeFem++, and a PDEs simulation solver : Basic on Tutorial transport phenomena during acupuncture Yannick Deleuze Yannick Deleuze Laboratoire Jacques-Louis Lions, Sorbonne Universités, UPMC Univ

More information