IsogEometric Tearing and Interconnecting

Size: px
Start display at page:

Download "IsogEometric Tearing and Interconnecting"

Transcription

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

2 IETI-DP Implementation of primal variables 1. Choosing W Π and constructing the basis 2. Application of K 3. Application of the preconditioner Numerical examples Conclusion Hofer, Mitter JKU Linz 2 / 24

3 : Motivation In 2D, using vertex primal variables works quite well. In 3D, condition number grows with H/h(1 + log H/h) 2. 2D 3D #dofs H/h κ It. #dofs H/h κ It Using continuous edge/face averages gives (1 + log(h/h)) 2. Implementation gets a bit more tricky. Present method for arbitrary linear primal variables. Pechstein, C. (2012). Finite and boundary element tearing and interconnecting solvers for multiscale problems (Vol. 90). Springer Science & Business Media. Hofer, Mitter JKU Linz 3 / 24

4 : Motivation In 2D, using vertex primal variables works quite well. In 3D, condition number grows with H/h(1 + log H/h) 2. 2D 3D #dofs H/h κ It. #dofs H/h κ It Using continuous edge/face averages gives (1 + log(h/h)) 2. Implementation gets a bit more tricky. Present method for arbitrary linear primal variables. Pechstein, C. (2012). Finite and boundary element tearing and interconnecting solvers for multiscale problems (Vol. 90). Springer Science & Business Media. Hofer, Mitter JKU Linz 3 / 24

5 : Problem formulation - cg setting Find u h V D,h : a(u h, v h ) = F, v h v h V D,h, where V D,h is a conforming discrete subspaces of V D, e.g. a(u, v) = α u v dx, F, v = fv dx + g N v ds Ω Ω Γ N V D = {u H 1 : γ 0 u = 0 on Γ D }, V D,h = k span{n (k) i,p } H1 (Ω). The variational equation is equivalent to Ku = f. Hofer, Mitter JKU Linz 4 / 24

6 IETI-DP : Overview IETI-DP Implementation of primal variables 1. Choosing W Π and constructing the basis 2. Application of K 3. Application of the preconditioner Numerical examples Conclusion Hofer, Mitter JKU Linz 4 / 24

7 IETI-DP : IETI-DP Given K (k) and f (k), we can reformulate [ Ke B Ku = f T ] [ ] u = B 0 λ where K e = diag(k (k) ) and f e = [f (k) ]. [ ] fe, 0 Since K e is not invertible, we need additional primal variables incorporated in K e K, B, f: continuous vertex values continuous edge/face averages Hofer, Mitter JKU Linz 5 / 24

8 IETI-DP : IETI-DP Given K (k) and f (k), we can reformulate [ Ke B Ku = f T ] [ ] u = B 0 λ where K e = diag(k (k) ) and f e = [f (k) ]. [ ] fe, 0 Since K e is not invertible, we need additional primal variables incorporated in K e K, B, f: continuous vertex values continuous edge/face averages Hofer, Mitter JKU Linz 5 / 24

9 IETI-DP : IETI-DP Find (u, λ) [ K BT B 0 ] [u ] = λ [ ] fe. 0 K is SPD, hence, we can define: F := B K BT d := B K f The saddle point system is equivalent to solving: Using the preconditioner M sd find λ U : F λ = d., we obtain: κ(m sd F ker( B T ) ) C max 1 k N ( 1 + log ( Hk h k )) 2, Hofer, Mitter JKU Linz 6 / 24

10 IETI-DP : A bit more on primal variables W (k) := V (k) h, W := k W (k), Ŵ := V h. Intermediate space W : Ŵ W W, K := K W is SPD. Let Ψ Vh be a set of linearly independent primal variables, W := {w W : ψ Ψ : ψ(w i ) = ψ(w j )} n W := W (k) k=0 W = W Π W, W Π Ŵ (there are many choices for W Π) where W (k) := {w W (k) : ψ Ψ : ψ(w k ) = 0} If W ker(k) = {0}, then K is invertible. Hofer, Mitter JKU Linz 7 / 24

11 IETI-DP : A bit more on primal variables W (k) := V (k) h, W := k W (k), Ŵ := V h. Intermediate space W : Ŵ W W, K := K W is SPD. Let Ψ Vh be a set of linearly independent primal variables, W := {w W : ψ Ψ : ψ(w i ) = ψ(w j )} n W := W (k) k=0 W = W Π W, W Π Ŵ (there are many choices for W Π) where W (k) := {w W (k) : ψ Ψ : ψ(w k ) = 0} If W ker(k) = {0}, then K is invertible. Hofer, Mitter JKU Linz 7 / 24

12 IETI-DP : Typical examples of Ψ and ψ Choices for ψ: Vertex evaluation: ψ V (v) = v(v) Edge averages: ψ E (v) = 1 E E v ds Face averages: ψ F (v) = 1 F Choices for Ψ: Algorithm A: Ψ = {ψ V } F v ds Algorithm B: Ψ = {ψ V } {ψ E } {ψ F } Algorithm C: Ψ = {ψ V } {ψ E } Hofer, Mitter JKU Linz 8 / 24

13 IETI-DP : Since W W, there is a natural embedding Ĩ : W W. We can define: B := BĨ : W U, B T = ĨT B T : U W, f := ĨT f W As before, we can write our saddle point problem as: Find (u, λ) W U : [ ] [u ] [ ] K BT f =, B 0 λ 0 Hofer, Mitter JKU Linz 9 / 24

14 IETI-DP : Since W W, there is a natural embedding Ĩ : W W. We can define: B := BĨ : W U, B T = ĨT B T : U W, f := ĨT f W As before, we can write our saddle point problem as: Find (u, λ) W U : [ ] [u ] [ ] K BT f =, B 0 λ 0 Hofer, Mitter JKU Linz 9 / 24

15 Implementation of primal variables : Overview IETI-DP Implementation of primal variables 1. Choosing W Π and constructing the basis 2. Application of K 3. Application of the preconditioner Numerical examples Conclusion Hofer, Mitter JKU Linz 9 / 24

16 Implementation of primal variables : CG Algorithm The equation F λ = d, is solved via the PCG algorithm: λ 0 given r 0 = d F λ 0, k = 0, β = 0 repeat s k = M sd r k β k = (r k,s k ) (r k,s k ) p k = s k + β k p k α k = (r k,s k ) (F p k,p k ) λ k+1 = r k + α k p k r k+1 = r k α k F p k k = k + 1 until stopping criterion fulfilled Hofer, Mitter JKU Linz 10 / 24

17 Implementation of primal variables : Required realizations In order to use the CG-algorithm, we need Application of F := B K BT Application of M sd := B DS e B T D Representation of W : K : W W, K : W W W = W Π W (k) representation of w W as {w Π, {w (k) } k} representation of f W as {f Π, {f (k) } k} Hofer, Mitter JKU Linz 11 / 24

18 Implementation of primal variables : Required realizations In order to use the CG-algorithm, we need Application of F := B K BT Application of M sd := B DS e B T D Representation of W : K : W W, K : W W W = W Π W (k) representation of w W as {w Π, {w (k) } k} representation of f W as {f Π, {f (k) } k} Hofer, Mitter JKU Linz 11 / 24

19 Implementation of primal variables : Required realizations W = W Π W (k) Construction of the primal space W Π and its basis. We choose the so called energy minimizing primal subspaces. The basis should be at least local and nodal. 2 possibilities to realize the dual space W : Transformation of basis: construction of basis, such that the primal variables vanishes. Realization with local constraints: constraints are added to the matrix to enforce vanishing of primal variables. Hofer, Mitter JKU Linz 12 / 24

20 Implementation of primal variables : Required realizations W = W Π W (k) Construction of the primal space W Π and its basis. We choose the so called energy minimizing primal subspaces. The basis should be at least local and nodal. 2 possibilities to realize the dual space W : Transformation of basis: construction of basis, such that the primal variables vanishes. Realization with local constraints: constraints are added to the matrix to enforce vanishing of primal variables. Hofer, Mitter JKU Linz 12 / 24

21 Implementation of primal variables : Required realizations In any case, a block LDL T factorization yields: [ ] KΠΠ K K = Π ( ) K Π K [ ] [ K I 0 S = K K Π I where S Π = K ΠΠ K Π K K Π. Π 0 0 K ] [ I KΠ K ], 0 I In order to apply K, one needs a realization of the individual subcomponents. If only continuous vertex values are use, one obtains ( ) just by reordering. (as in the previous talk) Hofer, Mitter JKU Linz 13 / 24

22 Implementation of primal variables : Required realizations In any case, a block LDL T factorization yields: [ ] KΠΠ K K = Π ( ) K Π K [ ] [ K I 0 S = K K Π I where S Π = K ΠΠ K Π K K Π. Π 0 0 K ] [ I KΠ K ], 0 I In order to apply K, one needs a realization of the individual subcomponents. If only continuous vertex values are use, one obtains ( ) just by reordering. (as in the previous talk) Hofer, Mitter JKU Linz 13 / 24

23 Implementation of primal variables : Choosing W Π and constructing the basis Overview IETI-DP Implementation of primal variables 1. Choosing W Π and constructing the basis 2. Application of K 3. Application of the preconditioner Numerical examples Conclusion Hofer, Mitter JKU Linz 13 / 24

24 Implementation of primal variables : Choosing W Π and constructing the basis A nice subspace W Π and its basis energy minimizing primal subspaces: W Π := W K W Π is K-orthogonal to W, i.e. Kw Π, w = 0 w Π W Π, w W. [ ] KΠΠ 0 K = = 0 K K = [ ] K ΠΠ 0 0 K Hofer, Mitter JKU Linz 14 / 24

25 Implementation of primal variables : Choosing W Π and constructing the basis A nice subspace W Π and its basis energy minimizing primal subspaces: W Π := W K W Π is K-orthogonal to W, i.e. Kw Π, w = 0 w Π W Π, w W. [ ] KΠΠ 0 K = = 0 K K = [ ] K ΠΠ 0 0 K Hofer, Mitter JKU Linz 14 / 24

26 Implementation of primal variables : Choosing W Π and constructing the basis Choosing W Π and constructing the basis Nodal basis φ : ψ i ( φ j ) = δ i,j. For each patch k we define: C (k) : W (k) R n Π,k The basis functions { φ (k) j } n Π,k j=1 [ (C (k) v) l = ψ i(k,l) (v) v W (k), l K (k) C (k)t C (k) 0 are the solution of: ] [ φ(k) ] µ (k) = [ ] 0 I For each patch the LU factorization is computed and stored. Hofer, Mitter JKU Linz 15 / 24

27 Implementation of primal variables : Choosing W Π and constructing the basis Choosing W Π and constructing the basis Nodal basis φ : ψ i ( φ j ) = δ i,j. For each patch k we define: C (k) : W (k) R n Π,k The basis functions { φ (k) j } n Π,k j=1 [ (C (k) v) l = ψ i(k,l) (v) v W (k), l K (k) C (k)t C (k) 0 are the solution of: ] [ φ(k) ] µ (k) = [ ] 0 I For each patch the LU factorization is computed and stored. Hofer, Mitter JKU Linz 15 / 24

28 Implementation of primal variables : Application of K Overview IETI-DP Implementation of primal variables 1. Choosing W Π and constructing the basis 2. Application of K 3. Application of the preconditioner Numerical examples Conclusion Hofer, Mitter JKU Linz 15 / 24

29 Implementation of primal variables : Application of K Application of K Given f := {f Π, {f (k) }} W, Find w := {w Π, {w (k) }} W : K = The application of K reduces to w = K f [ ] K ΠΠ 0 0 K w Π = K ΠΠ f Π w (k) = K(k) (k) f k = 0,..., n Hofer, Mitter JKU Linz 16 / 24

30 Implementation of primal variables : Application of K Application of K (k) The application of K (k) corresponds to K (k) w k = f (k) with the constraint C (k) w k = 0. This is equivalent to: [ ] [wk ] K (k) C (k)t C (k) = 0 [ ] f (k) 0 Hofer, Mitter JKU Linz 17 / 24

31 Implementation of primal variables : Application of K Application of K (k) The application of K (k) corresponds to K (k) w k = f (k) with the constraint C (k) w k = 0. This is equivalent to: [ ] [wk ] K (k) C (k)t C (k) = 0 [ ] f (k) 0 Hofer, Mitter JKU Linz 17 / 24

32 Implementation of primal variables : Application of K Application of K ΠΠ K ΠΠ can be assembled from the patch local matrices K (k) ΠΠ. Due to our special construction of φ (k), we have ( K (k) ΠΠ )i,j = K = = µ (k) i,j (k) φ(k) i, µ (k) i, C φ (k) j (k) φ(k) j = C (k)t µ (k) i, =, e (k) µ (k) i j (k) φ j Once K ΠΠ is assembled, one can calculate its LU factorization. Hofer, Mitter JKU Linz 18 / 24

33 Implementation of primal variables : Application of K Summary for application of F = BK BT Given λ U: 1. Application of B T : {f (k) } n k=0 = BT λ 2. Application of ĨT : {f Π, {f (k) }n k=0 } = ( ĨT {f (k) } n ) k=0 3. Application of K : w Π = K w (k) ΠΠ f Π (k) f = K(k) k = 0,..., n ( ) 4. Application of Ĩ : {w(k) } n k=0 = Ĩ {w Π, {w (k) }n k=0 } 5. Application of B : ν = B ( {w (k) } n ) k=0 It remains to investigate Ĩ and ĨT. Hofer, Mitter JKU Linz 19 / 24

34 Implementation of primal variables : Application of K Application of Ĩ and ĨT embedding operator: Ĩ : W W {w Π, {w (k) } k} ΦA T w Π + w partial assembling operator: ĨT : W W f {AΦ T f, {(I C T Φ T )f} k } Φ... basis of W Π (block version) C... matrix representation of primal variables W Π (block version) A... assembling operator A T... distribution operator Hofer, Mitter JKU Linz 20 / 24

35 Implementation of primal variables : Application of the preconditioner Overview IETI-DP Implementation of primal variables 1. Choosing W Π and constructing the basis 2. Application of K 3. Application of the preconditioner Numerical examples Conclusion Hofer, Mitter JKU Linz 20 / 24

36 Implementation of primal variables : Application of the preconditioner Application of M sd The application of the preconditioner M sd = B DSBD T the application of S: is basically S = diag(s (k) ) S (k) = K (k) BB K(k) BI (K(k) II ) K (k) IB The calculation of v (k) = S (k) w (k) consists of 2 steps: 1. Solve: K (k) II x(k) = K (k) IB w(k) (Dirichlet problem) 2. v (k) = K (k) BB w(k) + K (k) BI x(k) Again, a LU factorization of K (k) II can be computed and stored. Hofer, Mitter JKU Linz 21 / 24

37 Implementation of primal variables : Application of the preconditioner Application of M sd The application of the preconditioner M sd = B DSBD T the application of S: is basically S = diag(s (k) ) S (k) = K (k) BB K(k) BI (K(k) II ) K (k) IB The calculation of v (k) = S (k) w (k) consists of 2 steps: 1. Solve: K (k) II x(k) = K (k) IB w(k) (Dirichlet problem) 2. v (k) = K (k) BB w(k) + K (k) BI x(k) Again, a LU factorization of K (k) II can be computed and stored. Hofer, Mitter JKU Linz 21 / 24

38 Numerical examples : Overview IETI-DP Implementation of primal variables 1. Choosing W Π and constructing the basis 2. Application of K 3. Application of the preconditioner Numerical examples Conclusion Hofer, Mitter JKU Linz 21 / 24

39 Numerical examples : Example with α 1, p = 4 2D 3D V V #dofs H/h κ It. #dofs H/h κ It V + E V + E + F Hofer, Mitter JKU Linz 22 / 24

40 Numerical examples : p-dependence: 2D + 3D & different multiplicity keeping multiplicity & increasing smoothness ( ) increasing multiplicity & keeping smoothness ( ) increase mult. keep mult. cg - dependence on p (2D) increase mult. keep mult. cg - dependence on p (3D) condition number - κ condition number - κ degree - p degree - p Hofer, Mitter JKU Linz 23 / 24

41 Conclusion : Overview IETI-DP Implementation of primal variables 1. Choosing W Π and constructing the basis 2. Application of K 3. Application of the preconditioner Numerical examples Conclusion Hofer, Mitter JKU Linz 23 / 24

42 Conclusion : Conclusion and Extensions Also other primal variables can be realized in an efficient way. Provides application of IETI-DP to 3D problems. With suitable scaling robustness wrt. jumping coefficients. Method can be combined with dg-formulation. Parallelization wrt. patches (distributed memory setting). Instead of LU-factorization, one can use Multigrid (inexact IETI). Extension to nonlinear problems Apply IETI to linearized equation Apply IETI to non-linear equation and use Newton on each subdomain. Hofer, Mitter JKU Linz 24 / 24

Dual-Primal Isogeometric Tearing and Interconnecting Solvers for Continuous and Discontinuous Galerkin IgA Equations

Dual-Primal Isogeometric Tearing and Interconnecting Solvers for Continuous and Discontinuous Galerkin IgA Equations Dual-Primal Isogeometric Tearing and Interconnecting Solvers for Continuous and Discontinuous Galerkin IgA Equations Christoph Hofer and Ulrich Langer Doctoral Program Computational Mathematics Numerical

More information

Coupled FETI/BETI for Nonlinear Potential Problems

Coupled FETI/BETI for Nonlinear Potential Problems Coupled FETI/BETI for Nonlinear Potential Problems U. Langer 1 C. Pechstein 1 A. Pohoaţǎ 1 1 Institute of Computational Mathematics Johannes Kepler University Linz {ulanger,pechstein,pohoata}@numa.uni-linz.ac.at

More information

Inexact Data-Sparse BETI Methods by Ulrich Langer. (joint talk with G. Of, O. Steinbach and W. Zulehner)

Inexact Data-Sparse BETI Methods by Ulrich Langer. (joint talk with G. Of, O. Steinbach and W. Zulehner) Inexact Data-Sparse BETI Methods by Ulrich Langer (joint talk with G. Of, O. Steinbach and W. Zulehner) Radon Institute for Computational and Applied Mathematics Austrian Academy of Sciences http://www.ricam.oeaw.ac.at

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

Substructuring for multiscale problems

Substructuring for multiscale problems Substructuring for multiscale problems Clemens Pechstein Johannes Kepler University Linz (A) jointly with Rob Scheichl Marcus Sarkis Clark Dohrmann DD 21, Rennes, June 2012 Outline 1 Introduction 2 Weighted

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

A FETI-DP Method for Mortar Finite Element Discretization of a Fourth Order Problem

A FETI-DP Method for Mortar Finite Element Discretization of a Fourth Order Problem A FETI-DP Method for Mortar Finite Element Discretization of a Fourth Order Problem Leszek Marcinkowski 1 and Nina Dokeva 2 1 Department of Mathematics, Warsaw University, Banacha 2, 02 097 Warszawa, Poland,

More information

A Domain Decomposition Method for Quasilinear Elliptic PDEs Using Mortar Finite Elements

A Domain Decomposition Method for Quasilinear Elliptic PDEs Using Mortar Finite Elements W I S S E N T E C H N I K L E I D E N S C H A F T A Domain Decomposition Method for Quasilinear Elliptic PDEs Using Mortar Finite Elements Matthias Gsell and Olaf Steinbach Institute of Computational Mathematics

More information

Short title: Total FETI. Corresponding author: Zdenek Dostal, VŠB-Technical University of Ostrava, 17 listopadu 15, CZ Ostrava, Czech Republic

Short title: Total FETI. Corresponding author: Zdenek Dostal, VŠB-Technical University of Ostrava, 17 listopadu 15, CZ Ostrava, Czech Republic Short title: Total FETI Corresponding author: Zdenek Dostal, VŠB-Technical University of Ostrava, 17 listopadu 15, CZ-70833 Ostrava, Czech Republic mail: zdenek.dostal@vsb.cz fax +420 596 919 597 phone

More information

Dual-Primal Isogeometric Tearing and Interconnecting Solvers for large-scale systems of multipatch continuous Galerkin IgA equations

Dual-Primal Isogeometric Tearing and Interconnecting Solvers for large-scale systems of multipatch continuous Galerkin IgA equations www.oeaw.ac.at Dual-Primal Isogeometric Tearing and Interconnecting Solvers for large-scale systems of multipatc continuous Galerkin IgA equations C. Hofer, U. Langer RICAM-Report 2015-44 www.ricam.oeaw.ac.at

More information

Space-time Finite Element Methods for Parabolic Evolution Problems

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

More information

Adaptive Coarse Space Selection in BDDC and FETI-DP Iterative Substructuring Methods: Towards Fast and Robust Solvers

Adaptive Coarse Space Selection in BDDC and FETI-DP Iterative Substructuring Methods: Towards Fast and Robust Solvers Adaptive Coarse Space Selection in BDDC and FETI-DP Iterative Substructuring Methods: Towards Fast and Robust Solvers Jan Mandel University of Colorado at Denver Bedřich Sousedík Czech Technical University

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

CONVERGENCE ANALYSIS OF A BALANCING DOMAIN DECOMPOSITION METHOD FOR SOLVING A CLASS OF INDEFINITE LINEAR SYSTEMS

CONVERGENCE ANALYSIS OF A BALANCING DOMAIN DECOMPOSITION METHOD FOR SOLVING A CLASS OF INDEFINITE LINEAR SYSTEMS CONVERGENCE ANALYSIS OF A BALANCING DOMAIN DECOMPOSITION METHOD FOR SOLVING A CLASS OF INDEFINITE LINEAR SYSTEMS JING LI AND XUEMIN TU Abstract A variant of balancing domain decomposition method by constraints

More information

All-Floating Coupled Data-Sparse Boundary and Interface-Concentrated Finite Element Tearing and Interconnecting Methods

All-Floating Coupled Data-Sparse Boundary and Interface-Concentrated Finite Element Tearing and Interconnecting Methods All-Floating Coupled Data-Sparse Boundary and Interface-Concentrated Finite Element Tearing and Interconnecting Methods Ulrich Langer 1,2 and Clemens Pechstein 2 1 Institute of Computational Mathematics,

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

Convergence analysis of a balancing domain decomposition method for solving a class of indefinite linear systems

Convergence analysis of a balancing domain decomposition method for solving a class of indefinite linear systems NUMERICAL LINEAR ALGEBRA WITH APPLICATIONS Numer. Linear Algebra Appl. 2000; 00:1 6 [Version: 2002/09/18 v1.02] Convergence analysis of a balancing domain decomposition method for solving a class of indefinite

More information

ASM-BDDC Preconditioners with variable polynomial degree for CG- and DG-SEM

ASM-BDDC Preconditioners with variable polynomial degree for CG- and DG-SEM ASM-BDDC Preconditioners with variable polynomial degree for CG- and DG-SEM C. Canuto 1, L. F. Pavarino 2, and A. B. Pieri 3 1 Introduction Discontinuous Galerkin (DG) methods for partial differential

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

Iterative Methods for Linear Systems of Equations

Iterative Methods for Linear Systems of Equations Iterative Methods for Linear Systems of Equations Projection methods (3) ITMAN PhD-course DTU 20-10-08 till 24-10-08 Martin van Gijzen 1 Delft University of Technology Overview day 4 Bi-Lanczos method

More information

Auxiliary space multigrid method for elliptic problems with highly varying coefficients

Auxiliary space multigrid method for elliptic problems with highly varying coefficients Auxiliary space multigrid method for elliptic problems with highly varying coefficients Johannes Kraus 1 and Maria Lymbery 2 1 Introduction The robust preconditioning of linear systems of algebraic equations

More information

The Conjugate Gradient Method

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

More information

Selecting Constraints in Dual-Primal FETI Methods for Elasticity in Three Dimensions

Selecting Constraints in Dual-Primal FETI Methods for Elasticity in Three Dimensions Selecting Constraints in Dual-Primal FETI Methods for Elasticity in Three Dimensions Axel Klawonn 1 and Olof B. Widlund 2 1 Universität Duisburg-Essen, Campus Essen, Fachbereich Mathematik, (http://www.uni-essen.de/ingmath/axel.klawonn/)

More information

An Iterative Substructuring Method for Mortar Nonconforming Discretization of a Fourth-Order Elliptic Problem in two dimensions

An Iterative Substructuring Method for Mortar Nonconforming Discretization of a Fourth-Order Elliptic Problem in two dimensions An Iterative Substructuring Method for Mortar Nonconforming Discretization of a Fourth-Order Elliptic Problem in two dimensions Leszek Marcinkowski Department of Mathematics, Warsaw University, Banacha

More information

A Balancing Algorithm for Mortar Methods

A Balancing Algorithm for Mortar Methods A Balancing Algorithm for Mortar Methods Dan Stefanica Baruch College, City University of New York, NY 11, USA Dan Stefanica@baruch.cuny.edu Summary. The balancing methods are hybrid nonoverlapping Schwarz

More information

BETI for acoustic and electromagnetic scattering

BETI for acoustic and electromagnetic scattering BETI for acoustic and electromagnetic scattering O. Steinbach, M. Windisch Institut für Numerische Mathematik Technische Universität Graz Oberwolfach 18. Februar 2010 FWF-Project: Data-sparse Boundary

More information

ISOGEOMETRIC BDDC PRECONDITIONERS WITH DELUXE SCALING TR

ISOGEOMETRIC BDDC PRECONDITIONERS WITH DELUXE SCALING TR ISOGOMTRIC BDDC PRCONDITIONRS WITH DLUX SCALING L. BIRÃO DA VIGA, L.. PAVARINO, S. SCACCHI, O. B. WIDLUND, AND S. ZAMPINI TR2013-955 Abstract. A BDDC (Balancing Domain Decomposition by Constraints) preconditioner

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

Implicit Solution of Viscous Aerodynamic Flows using the Discontinuous Galerkin Method

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

More information

Parallel Sums and Adaptive BDDC Deluxe

Parallel Sums and Adaptive BDDC Deluxe 249 Parallel Sums and Adaptive BDDC Deluxe Olof B. Widlund 1 and Juan G. Calvo 2 1 Introduction There has recently been a considerable activity in developing adaptive methods for the selection of primal

More information

18. Balancing Neumann-Neumann for (In)Compressible Linear Elasticity and (Generalized) Stokes Parallel Implementation

18. Balancing Neumann-Neumann for (In)Compressible Linear Elasticity and (Generalized) Stokes Parallel Implementation Fourteenth nternational Conference on Domain Decomposition Methods Editors: smael Herrera, David E Keyes, Olof B Widlund, Robert Yates c 23 DDMorg 18 Balancing Neumann-Neumann for (n)compressible Linear

More information

Multispace and Multilevel BDDC. Jan Mandel University of Colorado at Denver and Health Sciences Center

Multispace and Multilevel BDDC. Jan Mandel University of Colorado at Denver and Health Sciences Center Multispace and Multilevel BDDC Jan Mandel University of Colorado at Denver and Health Sciences Center Based on joint work with Bedřich Sousedík, UCDHSC and Czech Technical University, and Clark R. Dohrmann,

More information

A Balancing Algorithm for Mortar Methods

A Balancing Algorithm for Mortar Methods A Balancing Algorithm for Mortar Methods Dan Stefanica Baruch College, City University of New York, NY, USA. Dan_Stefanica@baruch.cuny.edu Summary. The balancing methods are hybrid nonoverlapping Schwarz

More information

arxiv: v1 [math.na] 11 Jul 2011

arxiv: v1 [math.na] 11 Jul 2011 Multigrid Preconditioner for Nonconforming Discretization of Elliptic Problems with Jump Coefficients arxiv:07.260v [math.na] Jul 20 Blanca Ayuso De Dios, Michael Holst 2, Yunrong Zhu 2, and Ludmil Zikatanov

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

Application of Preconditioned Coupled FETI/BETI Solvers to 2D Magnetic Field Problems

Application of Preconditioned Coupled FETI/BETI Solvers to 2D Magnetic Field Problems Application of Preconditioned Coupled FETI/BETI Solvers to 2D Magnetic Field Problems U. Langer A. Pohoaţǎ O. Steinbach 27th September 2004 Institute of Computational Mathematics Johannes Kepler University

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

Multigrid and Iterative Strategies for Optimal Control Problems

Multigrid and Iterative Strategies for Optimal Control Problems Multigrid and Iterative Strategies for Optimal Control Problems John Pearson 1, Stefan Takacs 1 1 Mathematical Institute, 24 29 St. Giles, Oxford, OX1 3LB e-mail: john.pearson@worc.ox.ac.uk, takacs@maths.ox.ac.uk

More information

SOME PRACTICAL ASPECTS OF PARALLEL ADAPTIVE BDDC METHOD

SOME PRACTICAL ASPECTS OF PARALLEL ADAPTIVE BDDC METHOD Conference Applications of Mathematics 2012 in honor of the 60th birthday of Michal Křížek. Institute of Mathematics AS CR, Prague 2012 SOME PRACTICAL ASPECTS OF PARALLEL ADAPTIVE BDDC METHOD Jakub Šístek1,2,

More information

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

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

More information

Numerical Solutions to Partial Differential Equations

Numerical Solutions to Partial Differential Equations Numerical Solutions to Partial Differential Equations Zhiping Li LMAM and School of Mathematical Sciences Peking University Variational Problems of the Dirichlet BVP of the Poisson Equation 1 For the homogeneous

More information

Multipatch Space-Time Isogeometric Analysis of Parabolic Diffusion Problems. Ulrich Langer, Martin Neumüller, Ioannis Toulopoulos. G+S Report No.

Multipatch Space-Time Isogeometric Analysis of Parabolic Diffusion Problems. Ulrich Langer, Martin Neumüller, Ioannis Toulopoulos. G+S Report No. Multipatch Space-Time Isogeometric Analysis of Parabolic Diffusion Problems Ulrich Langer, Martin Neumüller, Ioannis Toulopoulos G+S Report No. 56 May 017 Multipatch Space-Time Isogeometric Analysis of

More information

Multilevel spectral coarse space methods in FreeFem++ on parallel architectures

Multilevel spectral coarse space methods in FreeFem++ on parallel architectures Multilevel spectral coarse space methods in FreeFem++ on parallel architectures Pierre Jolivet Laboratoire Jacques-Louis Lions Laboratoire Jean Kuntzmann DD 21, Rennes. June 29, 2012 In collaboration with

More information

Indefinite and physics-based preconditioning

Indefinite and physics-based preconditioning Indefinite and physics-based preconditioning Jed Brown VAW, ETH Zürich 2009-01-29 Newton iteration Standard form of a nonlinear system F (u) 0 Iteration Solve: Update: J(ũ)u F (ũ) ũ + ũ + u Example (p-bratu)

More information

M.A. Botchev. September 5, 2014

M.A. Botchev. September 5, 2014 Rome-Moscow school of Matrix Methods and Applied Linear Algebra 2014 A short introduction to Krylov subspaces for linear systems, matrix functions and inexact Newton methods. Plan and exercises. M.A. Botchev

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

Regularity Theory a Fourth Order PDE with Delta Right Hand Side

Regularity Theory a Fourth Order PDE with Delta Right Hand Side Regularity Theory a Fourth Order PDE with Delta Right Hand Side Graham Hobbs Applied PDEs Seminar, 29th October 2013 Contents Problem and Weak Formulation Example - The Biharmonic Problem Regularity Theory

More information

Domain Decomposition Preconditioners for Isogeometric Discretizations

Domain Decomposition Preconditioners for Isogeometric Discretizations Domain Decomposition Preconditioners for Isogeometric Discretizations Luca F Pavarino, Università di Milano, Italy Lorenzo Beirao da Veiga, Università di Milano, Italy Durkbin Cho, Dongguk University,

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

The Discontinuous Galerkin Finite Element Method

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

More information

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

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

Various ways to use a second level preconditioner

Various ways to use a second level preconditioner Various ways to use a second level preconditioner C. Vuik 1, J.M. Tang 1, R. Nabben 2, and Y. Erlangga 3 1 Delft University of Technology Delft Institute of Applied Mathematics 2 Technische Universität

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

Scalable Domain Decomposition Preconditioners For Heterogeneous Elliptic Problems

Scalable Domain Decomposition Preconditioners For Heterogeneous Elliptic Problems Scalable Domain Decomposition Preconditioners For Heterogeneous Elliptic Problems Pierre Jolivet, F. Hecht, F. Nataf, C. Prud homme Laboratoire Jacques-Louis Lions Laboratoire Jean Kuntzmann INRIA Rocquencourt

More information

for three dimensional problems are often more complicated than the quite simple constructions that work well for problems in the plane; see [23] for a

for three dimensional problems are often more complicated than the quite simple constructions that work well for problems in the plane; see [23] for a DUAL-PRIMAL FETI METHODS FOR THREE-DIMENSIONAL ELLIPTIC PROBLEMS WITH HETEROGENEOUS COEFFICIENTS AEL KLAWONN Λ, OLOF B. WIDLUND y, AND MAKSYMILIAN DRYJA z Abstract. In this paper, certain iterative substructuring

More information

Weak Galerkin Finite Element Scheme and Its Applications

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

More information

FETI domain decomposition method to solution of contact problems with large displacements

FETI domain decomposition method to solution of contact problems with large displacements FETI domain decomposition method to solution of contact problems with large displacements Vít Vondrák 1, Zdeněk Dostál 1, Jiří Dobiáš 2, and Svatopluk Pták 2 1 Dept. of Appl. Math., Technical University

More information

Construction of a New Domain Decomposition Method for the Stokes Equations

Construction of a New Domain Decomposition Method for the Stokes Equations Construction of a New Domain Decomposition Method for the Stokes Equations Frédéric Nataf 1 and Gerd Rapin 2 1 CMAP, CNRS; UMR7641, Ecole Polytechnique, 91128 Palaiseau Cedex, France 2 Math. Dep., NAM,

More information

Parallel Scalable Iterative Substructuring: Robust Exact and Inexact FETI-DP Methods with Applications to Elasticity

Parallel Scalable Iterative Substructuring: Robust Exact and Inexact FETI-DP Methods with Applications to Elasticity Parallel Scalable Iterative Substructuring: Robust Exact and Inexact FETI-DP Methods with Applications to Elasticity Oliver Rheinbach geboren in Hilden Fachbereich Mathematik Universität Duisburg-Essen

More information

Nonoverlapping Domain Decomposition Methods with Simplified Coarse Spaces for Solving Three-dimensional Elliptic Problems

Nonoverlapping Domain Decomposition Methods with Simplified Coarse Spaces for Solving Three-dimensional Elliptic Problems Nonoverlapping Domain Decomposition Methods with Simplified Coarse Spaces for Solving Three-dimensional Elliptic Problems Qiya Hu 1, Shi Shu 2 and Junxian Wang 3 Abstract In this paper we propose a substructuring

More information

AN ADAPTIVE CHOICE OF PRIMAL CONSTRAINTS FOR BDDC DOMAIN DECOMPOSITION ALGORITHMS

AN ADAPTIVE CHOICE OF PRIMAL CONSTRAINTS FOR BDDC DOMAIN DECOMPOSITION ALGORITHMS lectronic Transactions on Numerical Analysis. Volume 45, pp. 524 544, 2016. Copyright c 2016,. ISSN 1068 9613. TNA AN ADAPTIV CHOIC O PRIMAL CONSTRAINTS OR BDDC DOMAIN DCOMPOSITION ALGORITHMS JUAN G. CALVO

More information

Preconditioners for ill conditioned (block) Toeplitz systems: facts a

Preconditioners for ill conditioned (block) Toeplitz systems: facts a Preconditioners for ill conditioned (block) Toeplitz systems: facts and ideas Department of Informatics, Athens University of Economics and Business, Athens, Greece. Email:pvassal@aueb.gr, pvassal@uoi.gr

More information

Multigrid Methods for Elliptic Obstacle Problems on 2D Bisection Grids

Multigrid Methods for Elliptic Obstacle Problems on 2D Bisection Grids Multigrid Methods for Elliptic Obstacle Problems on 2D Bisection Grids Long Chen 1, Ricardo H. Nochetto 2, and Chen-Song Zhang 3 1 Department of Mathematics, University of California at Irvine. chenlong@math.uci.edu

More information

On the Use of Inexact Subdomain Solvers for BDDC Algorithms

On the Use of Inexact Subdomain Solvers for BDDC Algorithms On the Use of Inexact Subdomain Solvers for BDDC Algorithms Jing Li a, and Olof B. Widlund b,1 a Department of Mathematical Sciences, Kent State University, Kent, OH, 44242-0001 b Courant Institute of

More information

Numerical Solutions to Partial Differential Equations

Numerical Solutions to Partial Differential Equations Numerical Solutions to Partial Differential Equations Zhiping Li LMAM and School of Mathematical Sciences Peking University Nonconformity and the Consistency Error First Strang Lemma Abstract Error Estimate

More information

A STOKES INTERFACE PROBLEM: STABILITY, FINITE ELEMENT ANALYSIS AND A ROBUST SOLVER

A STOKES INTERFACE PROBLEM: STABILITY, FINITE ELEMENT ANALYSIS AND A ROBUST SOLVER European Congress on Computational Methods in Applied Sciences and Engineering ECCOMAS 2004 P. Neittaanmäki, T. Rossi, K. Majava, and O. Pironneau (eds.) O. Nevanlinna and R. Rannacher (assoc. eds.) Jyväskylä,

More information

Linear Solvers. Andrew Hazel

Linear Solvers. Andrew Hazel Linear Solvers Andrew Hazel Introduction Thus far we have talked about the formulation and discretisation of physical problems...... and stopped when we got to a discrete linear system of equations. Introduction

More information

cfl Jing Li All rights reserved, 22

cfl Jing Li All rights reserved, 22 NYU-CS-TR83 Dual-Primal FETI Methods for Stationary Stokes and Navier-Stokes Equations by Jing Li A dissertation submitted in partial fulfillment of the requirements for the degree of Doctor of Philosophy

More information

A Unified Framework for Adaptive BDDC

A Unified Framework for Adaptive BDDC www.oeaw.ac.at A Unified Framework for Adaptive BDDC C. Pechstein, C.R. Dohrmann RICAM-Report 2016-20 www.ricam.oeaw.ac.at A UNIFIED FRAMEWORK FOR ADAPTIVE BDDC CLEMENS PECHSTEIN 1 AND CLARK R. 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

The All-floating BETI Method: Numerical Results

The All-floating BETI Method: Numerical Results The All-floating BETI Method: Numerical Results Günther Of Institute of Computational Mathematics, Graz University of Technology, Steyrergasse 30, A-8010 Graz, Austria, of@tugraz.at Summary. The all-floating

More information

On Iterative Substructuring Methods for Multiscale Problems

On Iterative Substructuring Methods for Multiscale Problems On Iterative Substructuring Methods for Multiscale Problems Clemens Pechstein Introduction Model Problem Let Ω R 2 or R 3 be a Lipschitz polytope with boundary Ω = Γ D Γ N, where Γ D Γ N = /0. We are interested

More information

Construction of wavelets. Rob Stevenson Korteweg-de Vries Institute for Mathematics University of Amsterdam

Construction of wavelets. Rob Stevenson Korteweg-de Vries Institute for Mathematics University of Amsterdam Construction of wavelets Rob Stevenson Korteweg-de Vries Institute for Mathematics University of Amsterdam Contents Stability of biorthogonal wavelets. Examples on IR, (0, 1), and (0, 1) n. General domains

More information

Linear algebra issues in Interior Point methods for bound-constrained least-squares problems

Linear algebra issues in Interior Point methods for bound-constrained least-squares problems Linear algebra issues in Interior Point methods for bound-constrained least-squares problems Stefania Bellavia Dipartimento di Energetica S. Stecco Università degli Studi di Firenze Joint work with Jacek

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

Electronic Transactions on Numerical Analysis Volume 49, 2018

Electronic Transactions on Numerical Analysis Volume 49, 2018 Electronic Transactions on Numerical Analysis Volume 49, 2018 Contents 1 Adaptive FETI-DP and BDDC methods with a generalized transformation of basis for heterogeneous problems. Axel Klawonn, Martin Kühn,

More information

A DECOMPOSITION RESULT FOR BIHARMONIC PROBLEMS AND THE HELLAN-HERRMANN-JOHNSON METHOD

A DECOMPOSITION RESULT FOR BIHARMONIC PROBLEMS AND THE HELLAN-HERRMANN-JOHNSON METHOD Electronic ransactions on Numerical Analysis. Volume 45, pp. 257 282, 2016. Copyright c 2016,. ISSN 1068 9613. ENA A DECOMPOSIION RESUL FOR BIHARMONIC PROBLEMS AND HE HELLAN-HERRMANN-JOHNSON MEHOD WOLFGANG

More information

Extending the theory for domain decomposition algorithms to less regular subdomains

Extending the theory for domain decomposition algorithms to less regular subdomains Extending the theory for domain decomposition algorithms to less regular subdomains Olof Widlund Courant Institute of Mathematical Sciences New York University http://www.cs.nyu.edu/cs/faculty/widlund/

More information

7.3 The Jacobi and Gauss-Siedel Iterative Techniques. Problem: To solve Ax = b for A R n n. Methodology: Iteratively approximate solution x. No GEPP.

7.3 The Jacobi and Gauss-Siedel Iterative Techniques. Problem: To solve Ax = b for A R n n. Methodology: Iteratively approximate solution x. No GEPP. 7.3 The Jacobi and Gauss-Siedel Iterative Techniques Problem: To solve Ax = b for A R n n. Methodology: Iteratively approximate solution x. No GEPP. 7.3 The Jacobi and Gauss-Siedel Iterative Techniques

More information

Chapter 7. Iterative methods for large sparse linear systems. 7.1 Sparse matrix algebra. Large sparse matrices

Chapter 7. Iterative methods for large sparse linear systems. 7.1 Sparse matrix algebra. Large sparse matrices Chapter 7 Iterative methods for large sparse linear systems In this chapter we revisit the problem of solving linear systems of equations, but now in the context of large sparse systems. The price to pay

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

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

FETI-DPH: A DUAL-PRIMAL DOMAIN DECOMPOSITION METHOD FOR ACOUSTIC SCATTERING

FETI-DPH: A DUAL-PRIMAL DOMAIN DECOMPOSITION METHOD FOR ACOUSTIC SCATTERING Journal of Computational Acoustics, c IMACS FETI-DPH: A DUAL-PRIMAL DOMAIN DECOMPOSITION METHOD FOR ACOUSTIC SCATTERING Charbel Farhat, Philip Avery and Radek Tezaur Department of Mechanical Engineering

More information

Mesh Grading towards Singular Points Seminar : Elliptic Problems on Non-smooth Domain

Mesh Grading towards Singular Points Seminar : Elliptic Problems on Non-smooth Domain Mesh Grading towards Singular Points Seminar : Elliptic Problems on Non-smooth Domain Stephen Edward Moore Johann Radon Institute for Computational and Applied Mathematics Austrian Academy of Sciences,

More information

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

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

More information

Tsung-Ming Huang. Matrix Computation, 2016, NTNU

Tsung-Ming Huang. Matrix Computation, 2016, NTNU Tsung-Ming Huang Matrix Computation, 2016, NTNU 1 Plan Gradient method Conjugate gradient method Preconditioner 2 Gradient method 3 Theorem Ax = b, A : s.p.d Definition A : symmetric positive definite

More information

UNIFORM PRECONDITIONERS FOR A PARAMETER DEPENDENT SADDLE POINT PROBLEM WITH APPLICATION TO GENERALIZED STOKES INTERFACE EQUATIONS

UNIFORM PRECONDITIONERS FOR A PARAMETER DEPENDENT SADDLE POINT PROBLEM WITH APPLICATION TO GENERALIZED STOKES INTERFACE EQUATIONS UNIFORM PRECONDITIONERS FOR A PARAMETER DEPENDENT SADDLE POINT PROBLEM WITH APPLICATION TO GENERALIZED STOKES INTERFACE EQUATIONS MAXIM A. OLSHANSKII, JÖRG PETERS, AND ARNOLD REUSKEN Abstract. We consider

More information

An Efficient FETI Implementation on Distributed Shared Memory Machines with Independent Numbers of Subdomains and Processors

An Efficient FETI Implementation on Distributed Shared Memory Machines with Independent Numbers of Subdomains and Processors Contemporary Mathematics Volume 218, 1998 B 0-8218-0988-1-03024-7 An Efficient FETI Implementation on Distributed Shared Memory Machines with Independent Numbers of Subdomains and Processors Michel Lesoinne

More information

Parallel scalability of a FETI DP mortar method for problems with discontinuous coefficients

Parallel scalability of a FETI DP mortar method for problems with discontinuous coefficients Parallel scalability of a FETI DP mortar method for problems with discontinuous coefficients Nina Dokeva and Wlodek Proskurowski University of Southern California, Department of Mathematics Los Angeles,

More information

Parallel Scalability of a FETI DP Mortar Method for Problems with Discontinuous Coefficients

Parallel Scalability of a FETI DP Mortar Method for Problems with Discontinuous Coefficients Parallel Scalability of a FETI DP Mortar Method for Problems with Discontinuous Coefficients Nina Dokeva and Wlodek Proskurowski Department of Mathematics, University of Southern California, Los Angeles,

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

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

Trust-Region SQP Methods with Inexact Linear System Solves for Large-Scale Optimization

Trust-Region SQP Methods with Inexact Linear System Solves for Large-Scale Optimization Trust-Region SQP Methods with Inexact Linear System Solves for Large-Scale Optimization Denis Ridzal Department of Computational and Applied Mathematics Rice University, Houston, Texas dridzal@caam.rice.edu

More information

A Robust Preconditioner for the Hessian System in Elliptic Optimal Control Problems

A Robust Preconditioner for the Hessian System in Elliptic Optimal Control Problems A Robust Preconditioner for the Hessian System in Elliptic Optimal Control Problems Etereldes Gonçalves 1, Tarek P. Mathew 1, Markus Sarkis 1,2, and Christian E. Schaerer 1 1 Instituto de Matemática Pura

More information

An introduction to the mathematical theory of finite elements

An introduction to the mathematical theory of finite elements Master in Seismic Engineering E.T.S.I. Industriales (U.P.M.) Discretization Methods in Engineering An introduction to the mathematical theory of finite elements Ignacio Romero ignacio.romero@upm.es October

More information

Time-dependent Dirichlet Boundary Conditions in Finite Element Discretizations

Time-dependent Dirichlet Boundary Conditions in Finite Element Discretizations Time-dependent Dirichlet Boundary Conditions in Finite Element Discretizations Peter Benner and Jan Heiland November 5, 2015 Seminar Talk at Uni Konstanz Introduction Motivation A controlled physical processes

More information

Some Domain Decomposition Methods for Discontinuous Coefficients

Some Domain Decomposition Methods for Discontinuous Coefficients Some Domain Decomposition Methods for Discontinuous Coefficients Marcus Sarkis WPI RICAM-Linz, October 31, 2011 Marcus Sarkis (WPI) Domain Decomposition Methods RICAM-2011 1 / 38 Outline Discretizations

More information

Two new enriched multiscale coarse spaces for the Additive Average Schwarz method

Two new enriched multiscale coarse spaces for the Additive Average Schwarz method 346 Two new enriched multiscale coarse spaces for the Additive Average Schwarz method Leszek Marcinkowski 1 and Talal Rahman 2 1 Introduction We propose additive Schwarz methods with spectrally enriched

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