Massively Parallel Domain Decomposition Preconditioner for the High-Order Galerkin Least Squares Finite Element Method

Size: px
Start display at page:

Download "Massively Parallel Domain Decomposition Preconditioner for the High-Order Galerkin Least Squares Finite Element Method"

Transcription

1 Massively Parallel Domain Decomposition Preconditioner for the High-Order Galerkin Least Squares Finite Element Method Masayuki Yano Massachusetts Institute of Technology Department of Aeronautics and Astronautics January 26, 2009 M. Yano (MIT) Qualifier Examination January 26, / 67

2 Outline 1 Introduction 2 High-Order Galerkin Least Squares 3 Balancing Domain Decomposition by Constraint 4 Results 5 Conclusion and Future Work M. Yano (MIT) Qualifier Examination January 26, / 67

3 Outline 1 Introduction 2 High-Order Galerkin Least Squares 3 Balancing Domain Decomposition by Constraint 4 Results 5 Conclusion and Future Work M. Yano (MIT) Qualifier Examination January 26, / 67

4 Motivation Discretization Requirements Discretization should support High-Order: Simulation of unsteady flows with multiple scales benefits from higher-order methods Turbulence (DNS/LES) Acoustics / wave propagation Even in steady aerodynamics, high-order methods are more efficient in terms of error/dof [Barth, 1997][Venkatakrishnan, 2003] Unstructured Mesh: Handling complex geometries Selected Previous Work on High-Order Methods High-order schemes have been designed for various frameworks Finite difference [Lele, 1992] Finite volume [Barth, 1993][Wang, 2004] Finite element [Babuska, 1981][Patera, 1984] M. Yano (MIT) Qualifier Examination January 26, / 67

5 Motivation Example: High-Order Discretization Drag convergence for NACA 0012 [Fidkowski, 2005] Decay of turbulent kinetic energy in LES modeling [Kosovic, 2000] High-order schemes can significantly improve time to achieve engineering required accuracy. M. Yano (MIT) Qualifier Examination January 26, / 67

6 Motivation Massively Parallel Algorithms Modern supercomputers are massively parallel (1000+ procs). Parallelization is essential for problems of practical interests. Flow over large, complex geometries Unsteady simulations (e.g. DNS/LES) Trend of High Performance Computing in Past 15 Years FLOPS #1 #500 Average JNWT FUN3D Cart3D Processors Largest Smallest Average JNWT FUN3D Cart3D 10 8 Statistics from Top500.org Statistics from Top500.org M. Yano (MIT) Qualifier Examination January 26, / 67

7 Motivation High-Performance Computing in Aeronautics Typical large jobs remain in O(100) procs. Range of scales present in viscous flows requires implicit solvers The scalability of most of [CFD] codes tops out around 512 cpus... [Mavriplis, 2007] Exceptions: FUN3D inviscid matrix-free Newton-Krylov-Schwarz solver using 2048 procs [1999] Cart3D inviscid multigrid-accelerated Runge-Kutta solver using 2048 procs [2005] NSU3D RANS multigrid solver with line implicit solver in boundary layers using 2048 procs [2005] Need highly scalable implicit solver to take advantage of the future computers with 10,000+ procs. M. Yano (MIT) Qualifier Examination January 26, / 67

8 Objectives and Approaches Objectives 1 High-order discretization on unstructured mesh 2 Highly scalable solution algorithm for massively parallel systems Approaches 1 Galerkin Least Squares (GLS) Study behavior of high-order GLS discretization. Use h/p scaling artificial viscosity for subcell shock capturing. 2 Domain Decomposition (DD) Preconditioner Solve Schur complement system using preconditioned GMRES based on DD. Test the preconditioner for high-order discretization of advection-dominated flows. M. Yano (MIT) Qualifier Examination January 26, / 67

9 Outline 1 Introduction 2 High-Order Galerkin Least Squares 3 Balancing Domain Decomposition by Constraint 4 Results 5 Conclusion and Future Work M. Yano (MIT) Qualifier Examination January 26, / 67

10 Galerkin Least Squares Discretization Background Stabilized FEM for advection-dominated flows SUPG developed by Hughes [1982]; analyzed by Johnson [1984] SUPG extended to GLS by Hughes [1989] GLS Discretization for Advection-Diffusion Differential operator and bilinear form Lu β u (ν u) = f a(u,φ) = (β u,φ) Ω + (ν u, φ) Ω, Find u V s.t. a(u,φ) + (Lu,τLφ) Ω,Th = (f,φ) Ω + (f,τlφ) Ω,Th, where (, ) Ω,Th = K K dk and τ ( h, P e 1 h 2, P e 1 u,φ V H 1 (Ω) φ V. M. Yano (MIT) Qualifier Examination January 26, / 67

11 Stabilization Matrix Stability and A Priori Error Estimate for Hyperbolic Case (ν = 0) a(u, u) h β u 2 L 2 (Ω) h β (u uh ) L2 (Ω) + u u h L2 (Ω) Ch p+ 1 2 u H p+1 (Ω) High-Order Stabilization Matrix In order to keep cond(l stabilized) cond(l unstabilized ) = O(1) as p or h 0, τ h 2 /p 2, P e 1 One choice of τ in R d d+1 τ 1 = β ξ i p 2 d d + d i=1 i=1 j=1 ξ i x k ξ j x l ν kl M. Yano (MIT) Qualifier Examination January 26, / 67

12 Outline 1 Introduction 2 High-Order Galerkin Least Squares 3 Balancing Domain Decomposition by Constraint 4 Results 5 Conclusion and Future Work M. Yano (MIT) Qualifier Examination January 26, / 67

13 Domain Decomposition Preconditioners Motivation Performance of ILU degrades with number of processors even with line partitioning [Diosady, 2007]. Data parallelism alone is not sufficient to obtain good performance in massively parallel environment (1000+ procs.) Selected Previous Work (Elliptic) Bourgat proposes Neumann-Neumann method for Schur complement system [1988]. Mandel improves scalability with Balancing DD [1993]. Dorhmann extends BDD to BDDC [2003]. M. Yano (MIT) Qualifier Examination January 26, / 67

14 Schur Complement System Discrete Harmonic Extension (Elliptic Equation) Decompose Ω into non-overlapping domains Ω i and define Γ i = Ω i \ Ω and Γ = N i=1 Γ i. Decompose V h H 1 (Ω) into V h (Ω \ Γ) = {v V h : v Γ = 0} V h (Γ) = {v V h : a(v,φ) = 0, φ V h (Ω \ Γ)} V h (Γ) is called the space of discrete harmonic extensions. Variational Problem Find u = ů + ū V h (Ω \ Γ) V h (Γ) s.t. a(ů,ψ) = (f,ψ) Ω, ψ V h (Ω \ Γ) a(ū,φ) = (f,φ) Ω, φ V h (Γ) Ω i Γ Ωk ů requires local Dirichlet solves Ω j ū requires global interface solve M. Yano (MIT) Qualifier Examination January 26, / 67

15 Schur Complement System Schur Complement Operator Schur complement operator S : V h (Γ) V h (Γ) defined by Sv,φ = a(v,φ), v,φ V h (Γ) where,, : W W R s.t. F, v F(v), F W, v W. Schur Complement Problem Find u V h (Γ) s.t. Su,φ = (f,φ) Ω, φ V h (Γ) Forming S is expensive; action of S on v V h (Γ) is computed via local Dirichlet solves and minimal communication. Problem solved using a Krylov space method (e.g. GMRES) Scalable preconditioner needed to accelerate convergence M. Yano (MIT) Qualifier Examination January 26, / 67

16 BDDC Spaces Features of BDDC Equipped with a coarse space that makes subdomain problems wellposed provides global communication Example of primal constrains Values at corners of Ω i Averages on the edges of Ω i V h (Γ) Spaces V h (Γ) = global discrete harmonic extension N i=1 V N i=1 h(γ i ) = collection of local discrete V h(γ i ) harmonic extensions (i.e. discontinuous across Γ) Ṽ h (Γ) = {v N i=1v h (Γ i ) : v continuous on primal constraints} Ṽ h (Γ) M. Yano (MIT) Qualifier Examination January 26, / 67

17 BDDC Spaces Dual and Primal Spaces Decompose Ṽh(Γ) into i V h, (Γ i ) and V h,π (Γ). Dual problems are decoupled Ṽ h (Γ) Primal problem has DOF of O(N) Dual Space ( ): V h, (Γ i ) = {v V h (Γ i ) : v = 0 on primal constraint} Primal Space (Π): V h,π (Γ) = {v Ṽh(Γ) : X Ni=1 ã i (v Ωi, φ Ωi ) = 0, φ N i=1v h, (Γ i )} M. Yano (MIT) Qualifier Examination January 26, / 67

18 BDDC Preconditioner Primal and Dual Schur Complement Primal Schur complement: S Π : V h,π (Γ) V h,π (Γ) S Π v Π,φ Π = N i=1 ã i (v Ωi,φ Ωi ), v Π,φ Π V h,π (Γ) Local dual Schur complement: S,i : V h, (Γ i ) V h, (Γ i) S,i v,i,φ,i = ã i (v,i,φ,i ) v,i,φ,i V h, (Γ i ) BDDC Preconditioner M 1 BDDC = N i=1 R T D,i (T sub,i + T coarse )R D,i where T sub,i = R T Γ,i S 1,i R Γ,i and T coarse = R T ΓΠ S 1 Π R ΓΠ Condition Number Estimate for Coercive, Symmetric a(, ) κ(m 1 BDDC S) C(1 + log2 (H/h)) M. Yano (MIT) Qualifier Examination January 26, / 67

19 Robin-Robin Interface Condition (IC) Background Adaptation of N-N condition to nonsymmetric bilinear form Proposed by Achdou for BDD [1997] Applied to FETI [Toselli, 2001] and BDDC [Tu, 2008] Robin-Robin IC Subtract Γ i 1 2 β ˆn iuφ from interfaces. Modified local bilinear form is ã i (u,φ) = (ν u, φ) Ωi (β u,φ) Ω i 1 2 (β φ, u) Ω i (u, vβ ˆn) Ω i Ω N ã i (, ) is positive in local space V h (Ω i ): ã i (u, u) ν u H 1 (Ω i ). Resulting IC on Γ i is Robin type ( ν u 1 2 β) ˆn = 0 on Γ i M. Yano (MIT) Qualifier Examination January 26, / 67

20 Outline 1 Introduction 2 High-Order Galerkin Least Squares 3 Balancing Domain Decomposition by Constraint 4 Results 5 Conclusion and Future Work M. Yano (MIT) Qualifier Examination January 26, / 67

21 Poisson Equation Poisson Equation Objectives Test scaling with : Number of subdomains Size of subdomain p for different primal constraints Solution Partitioning Examples M. Yano (MIT) Qualifier Examination January 26, / 67

22 Poisson Equation Scaling with Number of Subdomains and Subdomain Size GMRES iteration is independent of number of subdomains and size of subdomain (p = 1). Corner + state average (C+SA) primal constraint requires approx. half the iterations of just corner constraint (C). GMRES iterations x 4 Subdomain (C) 8 x 8 Subdomain (C) 4 x 4 Subdomain (C+SA) 8 x 8 Subdomain (C+SA) Number of Subdomains GMRES iterations Subdomains (C) 16 Subdomains (C) 4 Subdomains (C+SA) 16 Subdomains (C+SA) (DOF per subdomain) 1/2 M. Yano (MIT) Qualifier Examination January 26, / 67

23 Poisson Equation Scaling with p Poisson equation solved on unstructured mesh 8000 elem. Number of iterations nearly independent of p when C+SA primal constraints are used. 40 Size of Primal Problem Corners only: N subdomain Corners + Edge State Average: 3 N subdomain GMRES iterations p = 1 (C) p = 4 (C) 5 p = 1 (C+SA) p = 4 (C+SA) Number of Subdomains M. Yano (MIT) Qualifier Examination January 26, / 67

24 Advection Diffusion: Boundary Layer Boundary Layer Equation Objectives Study effect of: interface conditions (Neumann-Neumann vs. Robin-Robin) τ scaling (h 2 vs. h 2 /p 2 ) Solution (ν = 10 3 ) Anisotropic Mesh and Partitioning M. Yano (MIT) Qualifier Examination January 26, / 67

25 Advection Diffusion: Boundary Layer Interface Conditions (IC) Robin-Robin IC performs significantly better than Neumann-Neumann IC in advection dominated cases. Interface conditions are identical as ν N N (p=1) R R (p=1) N N (p=1) R R (p=1) GMRES iterations advection diffusion ν GMRES iterations advection diffusion ν N subdomain = 16 N subdomain = 64 M. Yano (MIT) Qualifier Examination January 26, / 67

26 Advection Diffusion: Boundary Layer τ Matrix Scaling Performance of preconditioner degrades for p > 1 if τ h 2 in diffusion dominated cases. With τ h 2 /p 2, the preconditioner performs similar to p = 1 case. GMRES iterations p=1 p=3, τ v ~h 2 p=3, τ v ~h 2 /p 2 5 advection diffusion ν N subdomain = 64 M. Yano (MIT) Qualifier Examination January 26, / 67

27 Outline 1 Introduction 2 High-Order Galerkin Least Squares 3 Balancing Domain Decomposition by Constraint 4 Results 5 Conclusion and Future Work M. Yano (MIT) Qualifier Examination January 26, / 67

28 Conclusion and Future Work Conclusion BDDC preconditioner shows good scalability for: Both diffusion-dominated and advection-dominated flows with Robin-Robin interface condition All ranges of interpolation order p with proper choices of τ and primal constraints Future Work Extension to 3D Inexact solvers for subdomain problems Complex geometries and highly anisotropic mesh M. Yano (MIT) Qualifier Examination January 26, / 67

29 Questions

30 Supplemental Slides

31 Instability of the Standard Galerkin Method Discretization Advection-diffusion equation Lu β u (ν u) = f 1D Boundary Layer Galerkin: Find u V H 1 (Ω) s.t. a(u,φ) = (f,φ) Ω, φ V where a(u,φ) = Ω φβ u + ν φ u P e = βh 2ν = 1/4 1.8 Stability and A Priori Error Estimate a(u, u) ν u 2 L 2 (Ω) = ν u 2 H 1 (Ω) ν u u h H 1 (Ω) Chp u H p+1 (Ω) Not coercive in H 1 (Ω) as ν 0. P e = 5 M. Yano (MIT) Qualifier Examination January 26, / 67

32 Stabilized Finite Element Methods Stabilized Methods for Advection-Dominated Flows Streamline-Upwind Petrov-Galerkin (SUPG) [Hughes 1982] Galerkin Least-Squares (GLS) [Hughes 1989] Residual Free Bubbles (RFB) [Brezzi 1994] Variational Multiscale based on local Green s function [Hughes 1995] M. Yano (MIT) Qualifier Examination January 26, / 67

33 Finite Element vs. Finite Volume Advantages of Finite Element Method Maintains element-wise compact stencil for high-order discretization. Ease of boundary condition treatment. Reduces communication volume for DD. Straightfoward treatment of elliptic operator. Rigorous mathematical framework for a priori error estimation and DD convergence estimation. Disadvantages of Finite Element Method Requires stabilization term for H 1 (Ω) stability. DOF increases with the solution order. M. Yano (MIT) Qualifier Examination January 26, / 67

34 High-Order Galerkin Basis Basis Function Types Three types of basis functions (in 2D): Node, Edge, Element. Basis type defined by its support. The continuity constraint must be enforced on nodal and edge basis during assembly. Node Edge Element M. Yano (MIT) Qualifier Examination January 26, / 67

35 High-Order Galerkin: Matrix Storage Object-based Block Storage Jacobian stored blockwise, with the varying size of blocks Matrix converted to CRS format before solved with UMFPACK Jacobian of 3 3 Mesh (18 elem, p = 5, arbitrary basis) nz = 7186 Galerkin M. Yano (MIT) nz = DG (with compact lifting) Qualifier Examination January 26, / 67

36 Comparison with Discontinuous Galerkin Features (common to DG) High-order discretization on unstructured mesh H 1 (Ω) stability for advection-dominated flows Advantages (compared to DG) Straightforward treatment of elliptic operators (no lifting required) Fewer DOF required to represent a solution in H 1 (Ω) Disadvantages Potentially expensive calculation of stabilization terms Absence of block-wise compact stencil (more complex preconditioning strategy required) M. Yano (MIT) Qualifier Examination January 26, / 67

37 High-Order SUPG vs. GLS p-refinement with Traditional τ If h ν/ β, SUPG p-refinement fails to converge. Asymptotic convergence rates as h 0 are identical ( e H 1 (Ω) hp ) p=1 p=3 0.2 p=5 p=7 exact p=1 p=3 0.2 p=5 p=7 exact SUPG GLS Solution to advection-diffusion equation (h = 0.1, ν/ β = 0.01) M. Yano (MIT) Qualifier Examination January 26, / 67

38 High-Order SUPG vs. GLS p-refinement with High-Order Modified τ With the high-order modified τ, both SUPG and GLS p-refinement converge to the exact solution. GLS converges much rapidly than SUPG with p p=1 p=3 0.2 p=5 p=7 exact p=1 p=3 0.2 p=5 p=7 exact SUPG GLS Solution to advection-diffusion equation (h = 0.1, ν/ β = 0.01) M. Yano (MIT) Qualifier Examination January 26, / 67

39 Shock Capturing Background Artificial viscosity can regularize underresolved features. Method applied to DG by Persson [2006] and Barter [2007] to achieve subcell shock capturing. Resolution Indicator and h/p-scaling Artificial Viscosity high-order resolution indicator based on orthogonal polynomial expansion [Persson, 2006] S e = (u Πp 1 u, u Π p 1 u) K (u, u) K, u P p (K) where Π p 1 is the L 2 (K) projection onto P p 1 (K). If log 10 (S e ) s 0, add piecewise constant viscosity ν h/p to the element. M. Yano (MIT) Qualifier Examination January 26, / 67

40 Shock Capturing: Result Burger s Equation Burger s equation solved on 450 element mesh. ( ) 1 x 2 u2 + u y + (ν artificial(u) u) = Solution (p = 5) Resolution Indicator M. Yano (MIT) Qualifier Examination January 26, / 67

41 Euler Equation: Gaussian Bump Formulation Symmetric form using Hughes entropy variables [1986] ( s + γ + 1 V = ρe ) γ 1 p, ρu i p, ρ p The governing equation becomes à 0 V,t + ÃiV,xi = 0 where A 0 is SPD and A i is symmetric (K ij is SPSD for N-S). Gaussian Bump: Pressure and Partitioning M. Yano (MIT) Qualifier Examination January 26, / 67

42 Euler Equation: Gaussian Bump Euler Equation BDDC with R-R IC performs well for Euler equation. With N-N IC, 400+ GMRES iteration required for 32 subdomains. 60 GMRES iterations elem/subdom (p=1) elem/subdom (p=3) 80 elem/subdom (p=1) Number of Subdomains Average of GMRES iterations required for last three Newton steps M. Yano (MIT) Qualifier Examination January 26, / 67

43 Parallel Scalability of ILU Scalability of ILU for DG Discretization [Diosady 2007] Navier-Stokes equation Partitioning based on line connectivity Line-ordered ILU with p-multigrid within each subdomain 600 Linear Iterations vs. Number of Processors None Lines 16 Speed Up vs Number of Processors None Lines LinearIterations 300 Speedup Number of Processors Number of Processors Iterations vs. Processors Parallel Speed-Up M. Yano (MIT) Qualifier Examination January 26, / 67

44 Schur Complement for Non-Self-Adjoint Operator Discrete Harmonic Extension (Non-Self-Adjoint) Decompose V h H 1 (Ω) into V h (Ω \ Γ) = {v V h : v Γ = 0} V h (Γ) = {v V h : a(v,φ) = 0, φ V h (Ω \ Γ)} Vh (Γ) = {ψ V h : a(w,ψ) = 0, w V h (Ω \ Γ)} Find u = ů + ū V h (Ω \ Γ) V h (Γ) s.t. a(ů,φ) = (f,φ) Ω, φ V h (Ω \ Γ) a(ū,ψ) = (f,ψ) Ω, ψ Vh (Γ) Schur Complement Operator Schur complement S : V h (Γ) V h (Γ) s.t. Sv,ψ = a(v,ψ), v V h (Γ), ψ V h (Γ) M. Yano (MIT) Qualifier Examination January 26, / 67

45 Neumann-Neumann Preconditioner Local Spaces and Local Schur Complement Decompose V h (Ω i ) H 1 (Ω i ) of Ω i into V h (Ω i \ Γ i ) = {v i V h (Ω i ) : v Ωi = 0} V h (Γ i ) = {v i V h (Ω i ) : ã i (v i, φ) = 0, φ V h (Ω i \ Γ i )} Local Schur complement: S i : V h (Γ i ) V h (Γ i ) S i v i,φ i = ã i (v i,φ i ), v i,φ i V h (Γ i ) V h (Γ) Interpolation and Weighting Function Interpolation: R T i : V h (Γ i ) V h (Γ) s.t. N i=1 RT i V h (Γ i ) = V h (Γ) Weighting Function: D i V h (Γ i ) s.t. D i = 1/(# of Ω i sharing DOF on Γ) N i=1 V h(γ i ) Note, v = N i=1 R T i D i v Ωi, v V h (Γ) M. Yano (MIT) Qualifier Examination January 26, / 67

46 Neumann-Neumann Preconditioner Neumann-Neumann (N-N) Preconditioner Precondition S by applying S 1 i : V (Γ i ) V(Γ i ) on each Ω i and interpolate the result back to V(Γ) M 1 NN = N i=1 Ri T D i S 1 D i R i For ã i (u,φ) = ( u, φ) Ωi, application of S 1 i corresponds to solving a local problem with Neumann interface condition on Γ i ( u) ˆn = 0 on Γ i i Condition Number Estimate for Coercive, Symmetric a(, ) κ(m 1 NN S) C H2(1 + log(h/h))2 M. Yano (MIT) Qualifier Examination January 26, / 67

47 Balancing Domain Decompositions Problems of Neumann-Neumann Preconditioner Local Schur complement S i may be singular Limited scalability due to lack of coarse space Coarse Space Introduce coarse space V h,0 that makes subdomain problems well-posed provides global communication DOF coarse = O(N) Examples of DD with a Coarse Space BDD: Balancing Domain Decomposition [Mandel, 1993] BDDC: BDD by Constraints [Dohrmann, 2003] M. Yano (MIT) Qualifier Examination January 26, / 67

48 Balancing Domain Decomposition Balancing Domain Decomposition Define a coarse space: V h,0 (Ω) = span { } Ri T δ i, Kernel(S i ) V h,0 Define projection P 0 : V h (Ω) V h,0 (Ω), P 0 = R0 T S 1 0 R 0S Apply Neumann-Neumann preconditioner to balanced problem M 1 BDD = RT 0 S 1 0 R 0 + (I P 0 ) Examples of DD with a Coarse Space ( Ni=1 Ri T D i S 1 i D i R i S ) (I P 0 ) BDD: Balancing Domain Decomposition [Mandel, 1993] V h,0 = N i=1 Kernel(S i). Apply multiplicative coarse correction such that residual of subdomain problem is in range(s i ). (i.e. balanced problem) BDDC: BDD by Constraints [Dohrmann 2003] V h,0 = {Ψ i }, harmonic extensions satisfying primal constraints. Solve additive coarse and constrained subdomain problems. M. Yano (MIT) Qualifier Examination January 26, / 67

49 Comparison of Primal and Dual Substructuring Methods Primal Type Preconditions the Schur complement system by solving Neumann problems using the flux jumps. Neumann-Neumann method [Bourgat 1988] Balancing Domain Decomposition (BDD) [Mandel, 1993] BDD by Constraints (BDDC) [Dohrmann 2003] Dual Type Preconditions the flux equations by solving Dirichlet problems using function jumps. Finite Element Tearing and Interconnecting (FETI) [Farhat 1991] Dual-Primal FETI (FETI-DP) [Farhat 2001] Spectrum of BDDC and FETI-DP preconditioned operators are identical [Mandel 2005][Li 2005] M. Yano (MIT) Qualifier Examination January 26, / 67

50 BDDC Spaces Partially Assembled Spaces Collection of V h (Γ i ): W h N i=1 V h(γ i ) V h (Γ) Fully assembled FE space: Ŵ h V h (Γ) = N i=1 RT i V h (Γ i ) Partially assembled space: Wh V h,0 (Γ) + N i=1 RT i RΓ,i T V h(γ i ) Idea: BDDC preconditioner applies inverse of S : Wh W h to Shucr complement system. Ŵ h Wh W h M. Yano (MIT) Qualifier Examination January 26, / 67

51 Schur Complement System: Matrix Form Schur Complement Decompose local stiffness matrix and load vector into ( ) ( A (i) = A (i) II A (i) ΓI A (i) IΓ A (i) ΓΓ Schur complement system is given by Ŝu Γ = ĝ and f (i) = f (i) I f (i) Γ ) where Ŝ = ĝ = N R (j),t S (j) R (j), j=1 N R (j),t g (j), j=1 ( S (j) = A (j) ΓΓ A(j) ΓI g (j) = f (j) Γ ( A(j) ΓI A (j) II A (j) II ) 1 f (j) ) 1 A (j) IΓ I M. Yano (MIT) Qualifier Examination January 26, / 67

52 Application of Schur Complement Application of S (j) Calculation of u (j) Γ = S(j) v (j) corresponds to solving a local Dirichlet problem: Application of ( S (j)) 1 ( S (j) v (j) = A (j) ΓΓ v(j) A (j) ΓI Calculation of u (j) Γ = (S(j) ) 1 v (j) Γ Neumann problem: ( A (j) II A (j) ΓI A (j) IΓ A (j) ΓΓ A (j) II ) 1 A (j) IΓ v(j) corresponds to solving a local )( u (j) I u (j) Γ ) = ( 0 v (j) Γ ) M. Yano (MIT) Qualifier Examination January 26, / 67

53 BDDC: Coarse Correction Coarse Correction Coarse-level correction operator is given by T coarse = Ψ(Ψ T SΨ) 1 Ψ T where Ψ ( Ψ (1),T,,Ψ (N),T) T R DOF( V h (Γ i )) N primal Coarse Basis The local coarse basis, Ψ (i) is the harmonic extension to Ω i that satisfies the primal constraints, i.e. ( S (i) C (i),t )( ) ( ) Ψ (i) 0 C (i) 0 Λ (i) = R (i) Π where C (i) enforces primal constraints and Λ (i) is Lagrange multiplier. M. Yano (MIT) Qualifier Examination January 26, / 67

54 BDDC: Subdomain Correction Subdomain Correction Subdomain correction is given by N ( ) ( T sub = R (i),t S (i) C (i),t Γ 0 C (i) 0 i=1 ) 1 ( R (i) Γ 0 ) Provides subdomain corrections for which all coarse level, primal variables vanish. Primal constraints ensure the local problem is invertible. M. Yano (MIT) Qualifier Examination January 26, / 67

55 BDDC: Change of Basis Idea [Klawonn, 2004] Change basis functions on interface to make primal constraints explicit. Removes the need for the Lagrange multipliers as primal continuity constraints are satisfied by construction. Example: State Average Change of basis ψ k ψ l such that Dual Variables: edge ψ l(ξ)dξ = 0, l = 1,...,n 1 Primal Variable: ψ n (ξ) = 1, ξ edge Let T COB be the weighting matrix that maps from ψ to φ, then new stiffness matrix is A ψ,ij = a(ψ i,ψ j ) = (T T COB A φt COB ) i,j M. Yano (MIT) Qualifier Examination January 26, / 67

56 Abstract Additive Schwarz Preconditioner Assumption Consider symmetric, coercive a(, ) : V V and a i (, ) : V i V i. Assume C 0, ω, E = (ǫ ij ) N i,j=1 such that Stable Decomposition Local Stability v V, v i V i : N i=0 a i (v i, v i ) C 0 a(v, v) i = 1,...,N, v i V i : a(v i, v i ) ωa i (v i, v i ) Strengthened Cauchy-Shwarz Inequality i, j = 1,..., N, u i V i, v j V j : a(u i, v j ) ǫ ij a(u i, u i )a(v j, v j ) Conditioner Number Estimate [Dryja, 1995] κ C 0 ω (1 + ρ(e)) M. Yano (MIT) Qualifier Examination January 26, / 67

57 BDDC Condition Number Estimate Rayleigh Quotient Applying Rayleigh quotient formula to the inner product M BDDC,, ( ) λ min M 1 BDDC S = min v 0 λ max ( M 1 BDDC S ) = max v 0 min v=r T D RT ΓΠ v Π+ P N i=1 RT D,i RT Γ,i v,i v Π V h,π (Γ),v,i V h, (Γ i ) Sv, v ( S Π v Π, v Π + ) N i=1 S,iv,i, v i Sv, v ( min v=r T D RT ΓΠ v Π+ P N i=1 RT D,i RT Γ,i v S,i Π v Π, v Π + ) N i=1 S,iv,i, v i v Π V h,π (Γ),v,i V h, (Γ i ) M. Yano (MIT) Qualifier Examination January 26, / 67

58 Eigenvalues: Lower Bound Schur Complement on Ṽh(Γ) Sv,φ = N i=1 ã i (v Ωi,φ Ωi ), v,φ Ṽh(Ω) Derivation S Π v Π, v Π + N i=1 S,i v,i, v,i = Sv Π, v Π + N i=1 ã i (v,i, v,i ) Sv, v min v=r T D RT ΓΠ v Π+ P N i=1 RT D,i RT Γ,i v,i v Π V h,π (Γ),v,i V h, (Γ i ) = Sv Π, v Π + Sv, v = S(v Π + v ), (v Π + v ) = Sv, v ( ) N S Π v Π, v Π + S,i v,i, v i λ min ( M 1 BDDC S ) 1 i=1 M. Yano (MIT) Qualifier Examination January 26, / 67

59 Eigenvalues: Upper Bound Derivation Sv, v 2[ SRD T RT ΓΠ v Π, RD T RT ΓΠ v Π + S( N i=1 RD,iR T Γ,iv T,i ), ( N i=k RD,kR T Γ,kv T,k ) ] SRDR T ΓΠv T Π, RDR T ΓΠv T Π + N i=1 S(RD,iR T Γ,iv T,i ), (RD,iR T Γ,iv T,i ) For symmetric, coercive bilinear form with p = 1, SRD T RT ΓΠ v Π, RD T RT ΓΠ v Π (1 + log 2 (H/h)) S Π v Π, v Π S(RD,i T RT Γ,i v,i), (RD,i T RT Γ,i v,i) (1 + log 2 (H/h)) S,i v,i, v,i Thus, ««Sv, v 1 + log 2 H min h v=rd T RT ΓΠ v Π+ P N i=1 RD,i T RT Γ,i v,i v Π V h,π (Γ),v,i V h, (Γ i )! NX S Π v Π, v Π + S,i v,i, v i i=1 ( ) ( ) λ max M 1 BDDC S C 1 + log 2 (H/h) M. Yano (MIT) Qualifier Examination January 26, / 67

60 BDDC: GMRES Convergence Estimate GMRES Residual Bound [Eisenstat, 1983] Let c anc C 2 be such that c 0 u, u u, Tu Tu, Tu C0 2 u, u Then, ( ) m/2 r m r o 1 c2 0 C0 2 Advection-Diffusion Convergence Estimate [Tu, 2008] With state and flux average as primal constraints, BDDC (R-R) satisfies c 0 = 1 CH(H/h)(1 + log(h/h)) C 0 = C(1 + log(h/h)) 4 M. Yano (MIT) Qualifier Examination January 26, / 67

61 Nonlinear Equation Solution Scheme Discrete form using Galerkin Method M h du h dt + R h (U h (t)) = 0 Time Stepping Scheme U m+1 h For steady problems t. ( 1 = U m h t M h + R ) 1 h R h (U m h U ) h Linear System A h x h = b h must be solved at each time step A = 1 t M h + R h U h x = U m h b = R h (U m h ) M. Yano (MIT) Qualifier Examination January 26, / 67

62 Parallel GLS Solver GLS Solver Features Many ideas borrowed from ProjectX (Discontinuous Galerkin solver developed at ACDL since 2002) High-order GLS discretization on unstructured mesh h/p-scaling artificial viscosity for shock capturing. Parallel communication via MPI Local direct solve using UMFPACK Equation set: Poisson, advection-diffusion, Burger, Euler 70, 000 lines of C code M. Yano (MIT) Qualifier Examination January 26, / 67

63 BDDC Spaces Primal and Dual Spaces Decompose Ṽh(Γ) = (V h,π (Γ)) ( N i=1 V h, (Γ i )) Local Dual: V h, (Γ i ) = {v V h (Γ i ) : v = 0 on primal constraint} Primal: V h,π (Γ) = {v Ṽh(Γ) : N i=1 ã i (v Ωi, φ Ωi ) = 0, φ N i=1 V h, (Γ i )} Dual space V h, (Γ) = N i=1 V h, (Γ i ) is completely localized Primal space has DOF of O(N) Primal and Dual Schur Complement Primal Schur complement: S Π : V h,π (Γ) V h,π (Γ) S Π v Π,φ Π = N i=1 ã i (v Ωi,φ Ωi ), v Π,φ Π V h,π (Γ) Local dual Schur complement: S,i : V h, (Γ i ) V h, (Γ i) S,i v,i,φ,i = ã i (v,i,φ,i ) v,i,φ,i V h, (Γ i ) M. Yano (MIT) Qualifier Examination January 26, / 67

64 BDDC Preconditioner Injections and Averaging Operator R T ΓΠ : V h,π(γ) Ṽh(Γ) R T Γ : V h, (Γ i ) Ṽh(Γ) R T D,i : Ṽh(Γ) V h (Γ) s.t. v = N i=1 R T D,i v Ω i, v V h (Γ) BDDC Preconditioner BDDC preconditioner is given by M 1 BDDC = N i=1 R T D,i (T sub,i + T coarse )D i R D,i where T sub,i = R T Γ,i S 1,i R Γ,i and T coarse = R ΓΠ S 1 Π RT ΓΠ Condition Number Estimate for Coercive, Symmetric a(, ) κ(m 1 BDDC S) C(1 + log2 (H/h)) M. Yano (MIT) Qualifier Examination January 26, / 67

65 Galerkin Least Squares Discretization Background SUPG developed by Hughes [1982]; analyzed by Johnson [1984] SUPG extended to GLS by Hughes [1989] GLS Discretization Find u V H 1 (Ω) s.t. a(u,φ) + (Lu,τLφ) Ω,Th = (f,φ) Ω + (f,τlφ) Ω,Th, where (, ) Ω,Th = K K dk and τ ( h, P e 1 h 2, P e 1. φ V Stability and A Priori Error Estimate for Hyperbolic Case (ν = 0) a(u, u) h β u 2 L 2 (Ω) h β (u uh ) L2 (Ω) + u u h L2 (Ω) Ch p+ 1 2 u H p+1 (Ω) M. Yano (MIT) Qualifier Examination January 26, / 67

66 Stabilization Matrix High-Order Stabilization Matrix In order to keep cond(l stabilized) cond(l unstabilized ) = O(1) as p and h 0, τ h 2 /p 2, P e 1 One choice of τ in R d d+1 τ 1 = β ξ i p 2 d d + d i=1 Topics Studied in High-Order GLS Comparison of SUPG and GLS i=1 j=1 ξ i x k ξ j x l ν kl Subcell-shock capturing using h/p scaling artificial viscosity and resolution based shock indicator GLS for highly anisotropic mesh M. Yano (MIT) Qualifier Examination January 26, / 67

67 BDDC Preconditioner Features of BDDC Equipped with a coarse space (primal space) that provides global communication and makes subdomain problems well-posed. Operates on partially assembled space: Ṽh(Γ) Ṽ h (Γ) = {v L 2 (Ω) : v N i=1 V h(γ i ) and v is continuous on primal constraints} Examples of primal constraints Values at the corners of Ω i State averages on the edges of Ω i V h (Γ) Ṽ h (Γ) N i=1 V h(γ i ) M. Yano (MIT) Qualifier Examination January 26, / 67

68 BDDC Spaces Primal and Dual Spaces Decompose Ṽh(Γ) = (V h,π (Γ)) ( N i=1 V h, (Γ i )) Local Dual: V h, (Γ i ) = {v V h (Γ i ) : v = 0 on primal constraint} Primal: V h,π (Γ) = {v Ṽh(Γ) : N i=1 ã i (v Ωi, φ Ωi ) = 0, φ N i=1 V h, (Γ i )} Dual space V h, (Γ) = N i=1 V h, (Γ i ) is completely localized Primal space has DOF of O(N) -Space Π-Space M. Yano (MIT) Qualifier Examination January 26, / 67

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

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 11, USA Dan Stefanica@baruch.cuny.edu Summary. The balancing methods are hybrid nonoverlapping Schwarz

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

An Efficient Low Memory Implicit DG Algorithm for Time Dependent Problems

An Efficient Low Memory Implicit DG Algorithm for Time Dependent Problems An Efficient Low Memory Implicit DG Algorithm for Time Dependent Problems P.-O. Persson and J. Peraire Massachusetts Institute of Technology 2006 AIAA Aerospace Sciences Meeting, Reno, Nevada January 9,

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

An Introduction to the Discontinuous Galerkin Method

An Introduction to the Discontinuous Galerkin Method An Introduction to the Discontinuous Galerkin Method Krzysztof J. Fidkowski Aerospace Computational Design Lab Massachusetts Institute of Technology March 16, 2005 Computational Prototyping Group Seminar

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

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

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

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

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

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

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

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

A Linear Multigrid Preconditioner for the solution of the Navier-Stokes Equations using a Discontinuous Galerkin Discretization. Laslo Tibor Diosady

A Linear Multigrid Preconditioner for the solution of the Navier-Stokes Equations using a Discontinuous Galerkin Discretization. Laslo Tibor Diosady A Linear Multigrid Preconditioner for the solution of the Navier-Stokes Equations using a Discontinuous Galerkin Discretization by Laslo Tibor Diosady B.A.Sc., University of Toronto (2005) Submitted to

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

1st Committee Meeting

1st Committee Meeting 1st Committee Meeting Eric Liu Committee: David Darmofal, Qiqi Wang, Masayuki Yano Massachusetts Institute of Technology Department of Aeronautics and Astronautics Aerospace Computational Design Laboratory

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

IsogEometric Tearing and Interconnecting

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

More information

HYPERSONIC AERO-THERMO-DYNAMIC HEATING PREDICTION WITH HIGH-ORDER DISCONTINOUS GALERKIN SPECTRAL ELEMENT METHODS

HYPERSONIC AERO-THERMO-DYNAMIC HEATING PREDICTION WITH HIGH-ORDER DISCONTINOUS GALERKIN SPECTRAL ELEMENT METHODS 1 / 36 HYPERSONIC AERO-THERMO-DYNAMIC HEATING PREDICTION WITH HIGH-ORDER DISCONTINOUS GALERKIN SPECTRAL ELEMENT METHODS Jesús Garicano Mena, E. Valero Sánchez, G. Rubio Calzado, E. Ferrer Vaccarezza Universidad

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

INSTITUTE OF MATHEMATICS THE CZECH ACADEMY OF SCIENCES. A virtual overlapping Schwarz method for scalar elliptic problems in two dimensions

INSTITUTE OF MATHEMATICS THE CZECH ACADEMY OF SCIENCES. A virtual overlapping Schwarz method for scalar elliptic problems in two dimensions INSTITUTE OF MATHEMATICS THE CZECH ACADEMY OF SCIENCES A virtual overlapping Schwarz method for scalar elliptic problems in two dimensions Juan Gabriel Calvo Preprint No. 25-2017 PRAHA 2017 A VIRTUAL

More information

From Direct to Iterative Substructuring: some Parallel Experiences in 2 and 3D

From Direct to Iterative Substructuring: some Parallel Experiences in 2 and 3D From Direct to Iterative Substructuring: some Parallel Experiences in 2 and 3D Luc Giraud N7-IRIT, Toulouse MUMPS Day October 24, 2006, ENS-INRIA, Lyon, France Outline 1 General Framework 2 The direct

More information

AProofoftheStabilityoftheSpectral Difference Method For All Orders of Accuracy

AProofoftheStabilityoftheSpectral Difference Method For All Orders of Accuracy AProofoftheStabilityoftheSpectral Difference Method For All Orders of Accuracy Antony Jameson 1 1 Thomas V. Jones Professor of Engineering Department of Aeronautics and Astronautics Stanford University

More information

Multispace and Multilevel BDDC

Multispace and Multilevel BDDC Multispace and Multilevel BDDC Jan Mandel Bedřich Sousedík Clark R. Dohrmann February 11, 2018 arxiv:0712.3977v2 [math.na] 21 Jan 2008 Abstract BDDC method is the most advanced method from the Balancing

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

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

Is My CFD Mesh Adequate? A Quantitative Answer

Is My CFD Mesh Adequate? A Quantitative Answer Is My CFD Mesh Adequate? A Quantitative Answer Krzysztof J. Fidkowski Gas Dynamics Research Colloqium Aerospace Engineering Department University of Michigan January 26, 2011 K.J. Fidkowski (UM) GDRC 2011

More information

A High-Performance Parallel Hybrid Method for Large Sparse Linear Systems

A High-Performance Parallel Hybrid Method for Large Sparse Linear Systems Outline A High-Performance Parallel Hybrid Method for Large Sparse Linear Systems Azzam Haidar CERFACS, Toulouse joint work with Luc Giraud (N7-IRIT, France) and Layne Watson (Virginia Polytechnic Institute,

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

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

Numerical Analysis of Higher Order Discontinuous Galerkin Finite Element Methods

Numerical Analysis of Higher Order Discontinuous Galerkin Finite Element Methods Numerical Analysis of Higher Order Discontinuous Galerkin Finite Element Methods Contents Ralf Hartmann Institute of Aerodynamics and Flow Technology DLR (German Aerospace Center) Lilienthalplatz 7, 3808

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

Space-time Discontinuous Galerkin Methods for Compressible Flows

Space-time Discontinuous Galerkin Methods for Compressible Flows Space-time Discontinuous Galerkin Methods for Compressible Flows Jaap van der Vegt Numerical Analysis and Computational Mechanics Group Department of Applied Mathematics University of Twente Joint Work

More information

A high-order discontinuous Galerkin solver for 3D aerodynamic turbulent flows

A high-order discontinuous Galerkin solver for 3D aerodynamic turbulent flows A high-order discontinuous Galerkin solver for 3D aerodynamic turbulent flows F. Bassi, A. Crivellini, D. A. Di Pietro, S. Rebay Dipartimento di Ingegneria Industriale, Università di Bergamo CERMICS-ENPC

More information

A Space-Time Expansion Discontinuous Galerkin Scheme with Local Time-Stepping for the Ideal and Viscous MHD Equations

A Space-Time Expansion Discontinuous Galerkin Scheme with Local Time-Stepping for the Ideal and Viscous MHD Equations A Space-Time Expansion Discontinuous Galerkin Scheme with Local Time-Stepping for the Ideal and Viscous MHD Equations Ch. Altmann, G. Gassner, F. Lörcher, C.-D. Munz Numerical Flow Models for Controlled

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

First, Second, and Third Order Finite-Volume Schemes for Diffusion

First, Second, and Third Order Finite-Volume Schemes for Diffusion First, Second, and Third Order Finite-Volume Schemes for Diffusion Hiro Nishikawa 51st AIAA Aerospace Sciences Meeting, January 10, 2013 Supported by ARO (PM: Dr. Frederick Ferguson), NASA, Software Cradle.

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

Preconditioning of Saddle Point Systems by Substructuring and a Penalty Approach

Preconditioning of Saddle Point Systems by Substructuring and a Penalty Approach Preconditioning of Saddle Point Systems by Substructuring and a Penalty Approach Clark R. Dohrmann 1 Sandia National Laboratories, crdohrm@sandia.gov. Sandia is a multiprogram laboratory operated by Sandia

More information

Multigrid Solution for High-Order Discontinuous Galerkin Discretizations of the Compressible Navier-Stokes Equations. Todd A.

Multigrid Solution for High-Order Discontinuous Galerkin Discretizations of the Compressible Navier-Stokes Equations. Todd A. Multigrid Solution for High-Order Discontinuous Galerkin Discretizations of the Compressible Navier-Stokes Equations by Todd A. Oliver B.S., Massachusetts Institute of Technology (22) Submitted to the

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

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

OVERLAPPING SCHWARZ ALGORITHMS FOR ALMOST INCOMPRESSIBLE LINEAR ELASTICITY TR

OVERLAPPING SCHWARZ ALGORITHMS FOR ALMOST INCOMPRESSIBLE LINEAR ELASTICITY TR OVERLAPPING SCHWARZ ALGORITHMS FOR ALMOST INCOMPRESSIBLE LINEAR ELASTICITY MINGCHAO CAI, LUCA F. PAVARINO, AND OLOF B. WIDLUND TR2014-969 Abstract. Low order finite element discretizations of the linear

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

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

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

Block-Structured Adaptive Mesh Refinement

Block-Structured Adaptive Mesh Refinement Block-Structured Adaptive Mesh Refinement Lecture 2 Incompressible Navier-Stokes Equations Fractional Step Scheme 1-D AMR for classical PDE s hyperbolic elliptic parabolic Accuracy considerations Bell

More information

INSTITUTE OF MATHEMATICS THE CZECH ACADEMY OF SCIENCES

INSTITUTE OF MATHEMATICS THE CZECH ACADEMY OF SCIENCES INSTITUTE OF MATHEMATICS THE CZECH ACADEMY OF SCIENCES On the approximation of a virtual coarse space for domain decomposition methods in two dimensions Juan Gabriel Calvo Preprint No. 31-2017 PRAHA 2017

More information

High Order Discontinuous Galerkin Methods for Aerodynamics

High Order Discontinuous Galerkin Methods for Aerodynamics High Order Discontinuous Galerkin Methods for Aerodynamics Per-Olof Persson Massachusetts Institute of Technology Collaborators: J. Peraire, J. Bonet, N. C. Nguyen, A. Mohnot Symposium on Recent Developments

More information

Zonal modelling approach in aerodynamic simulation

Zonal modelling approach in aerodynamic simulation Zonal modelling approach in aerodynamic simulation and Carlos Castro Barcelona Supercomputing Center Technical University of Madrid Outline 1 2 State of the art Proposed strategy 3 Consistency Stability

More information

Entropy-stable discontinuous Galerkin nite element method with streamline diusion and shock-capturing

Entropy-stable discontinuous Galerkin nite element method with streamline diusion and shock-capturing Entropy-stable discontinuous Galerkin nite element method with streamline diusion and shock-capturing Siddhartha Mishra Seminar for Applied Mathematics ETH Zurich Goal Find a numerical scheme for conservation

More information

RANS Solutions Using High Order Discontinuous Galerkin Methods

RANS Solutions Using High Order Discontinuous Galerkin Methods RANS Solutions Using High Order Discontinuous Galerkin Methods Ngoc Cuong Nguyen, Per-Olof Persson and Jaime Peraire Massachusetts Institute of Technology, Cambridge, MA 2139, U.S.A. We present a practical

More information

Optimal Left and Right Additive Schwarz Preconditioning for Minimal Residual Methods with Euclidean and Energy Norms

Optimal Left and Right Additive Schwarz Preconditioning for Minimal Residual Methods with Euclidean and Energy Norms Optimal Left and Right Additive Schwarz Preconditioning for Minimal Residual Methods with Euclidean and Energy Norms Marcus Sarkis Worcester Polytechnic Inst., Mass. and IMPA, Rio de Janeiro and Daniel

More information

A STUDY OF MULTIGRID SMOOTHERS USED IN COMPRESSIBLE CFD BASED ON THE CONVECTION DIFFUSION EQUATION

A STUDY OF MULTIGRID SMOOTHERS USED IN COMPRESSIBLE CFD BASED ON THE CONVECTION DIFFUSION EQUATION ECCOMAS Congress 2016 VII European Congress on Computational Methods in Applied Sciences and Engineering M. Papadrakakis, V. Papadopoulos, G. Stefanou, V. Plevris (eds.) Crete Island, Greece, 5 10 June

More information

Multigrid Algorithms for High-Order Discontinuous Galerkin Discretizations of the Compressible Navier-Stokes Equations

Multigrid Algorithms for High-Order Discontinuous Galerkin Discretizations of the Compressible Navier-Stokes Equations Multigrid Algorithms for High-Order Discontinuous Galerkin Discretizations of the Compressible Navier-Stokes Equations Khosro Shahbazi,a Dimitri J. Mavriplis b Nicholas K. Burgess b a Division of Applied

More information

Acceleration of a Domain Decomposition Method for Advection-Diffusion Problems

Acceleration of a Domain Decomposition Method for Advection-Diffusion Problems Acceleration of a Domain Decomposition Method for Advection-Diffusion Problems Gert Lube 1, Tobias Knopp 2, and Gerd Rapin 2 1 University of Göttingen, Institute of Numerical and Applied Mathematics (http://www.num.math.uni-goettingen.de/lube/)

More information

The hybridized DG methods for WS1, WS2, and CS2 test cases

The hybridized DG methods for WS1, WS2, and CS2 test cases The hybridized DG methods for WS1, WS2, and CS2 test cases P. Fernandez, N.C. Nguyen and J. Peraire Aerospace Computational Design Laboratory Department of Aeronautics and Astronautics, MIT 5th High-Order

More information

Algebraic Coarse Spaces for Overlapping Schwarz Preconditioners

Algebraic Coarse Spaces for Overlapping Schwarz Preconditioners Algebraic Coarse Spaces for Overlapping Schwarz Preconditioners 17 th International Conference on Domain Decomposition Methods St. Wolfgang/Strobl, Austria July 3-7, 2006 Clark R. Dohrmann Sandia National

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

arxiv: v1 [cs.na] 12 Jan 2017

arxiv: v1 [cs.na] 12 Jan 2017 SPACE-TIME BALANCING DOMAIN DECOMPOSITION SANTIAGO BADIA AND MARC OLM arxiv:171.3477v1 [cs.na] 1 Jan 17 Abstract. In this work, we propose two-level space-time domain decomposition preconditioners for

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

J. Liou Tulsa Research Center Amoco Production Company Tulsa, OK 74102, USA. Received 23 August 1990 Revised manuscript received 24 October 1990

J. Liou Tulsa Research Center Amoco Production Company Tulsa, OK 74102, USA. Received 23 August 1990 Revised manuscript received 24 October 1990 Computer Methods in Applied Mechanics and Engineering, 94 (1992) 339 351 1 A NEW STRATEGY FOR FINITE ELEMENT COMPUTATIONS INVOLVING MOVING BOUNDARIES AND INTERFACES THE DEFORMING-SPATIAL-DOMAIN/SPACE-TIME

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

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

Schwarz Preconditioner for the Stochastic Finite Element Method

Schwarz Preconditioner for the Stochastic Finite Element Method Schwarz Preconditioner for the Stochastic Finite Element Method Waad Subber 1 and Sébastien Loisel 2 Preprint submitted to DD22 conference 1 Introduction The intrusive polynomial chaos approach for uncertainty

More information

Index. higher order methods, 52 nonlinear, 36 with variable coefficients, 34 Burgers equation, 234 BVP, see boundary value problems

Index. higher order methods, 52 nonlinear, 36 with variable coefficients, 34 Burgers equation, 234 BVP, see boundary value problems Index A-conjugate directions, 83 A-stability, 171 A( )-stability, 171 absolute error, 243 absolute stability, 149 for systems of equations, 154 absorbing boundary conditions, 228 Adams Bashforth methods,

More information

Parallel Implementation of BDDC for Mixed-Hybrid Formulation of Flow in Porous Media

Parallel Implementation of BDDC for Mixed-Hybrid Formulation of Flow in Porous Media Parallel Implementation of BDDC for Mixed-Hybrid Formulation of Flow in Porous Media Jakub Šístek1 joint work with Jan Březina 2 and Bedřich Sousedík 3 1 Institute of Mathematics of the AS CR Nečas Center

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

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

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

Domain Decomposition Algorithms for an Indefinite Hypersingular Integral Equation in Three Dimensions

Domain Decomposition Algorithms for an Indefinite Hypersingular Integral Equation in Three Dimensions Domain Decomposition Algorithms for an Indefinite Hypersingular Integral Equation in Three Dimensions Ernst P. Stephan 1, Matthias Maischak 2, and Thanh Tran 3 1 Institut für Angewandte Mathematik, Leibniz

More information

A Fast, Parallel Potential Flow Solver

A Fast, Parallel Potential Flow Solver Advisor: Jaime Peraire December 16, 2012 Outline 1 Introduction to Potential FLow 2 The Boundary Element Method 3 The Fast Multipole Method 4 Discretization 5 Implementation 6 Results 7 Conclusions Why

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

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

A recovery-assisted DG code for the compressible Navier-Stokes equations

A recovery-assisted DG code for the compressible Navier-Stokes equations A recovery-assisted DG code for the compressible Navier-Stokes equations January 6 th, 217 5 th International Workshop on High-Order CFD Methods Kissimmee, Florida Philip E. Johnson & Eric Johnsen Scientific

More information

Uncertainty analysis of large-scale systems using domain decomposition

Uncertainty analysis of large-scale systems using domain decomposition Center for Turbulence Research Annual Research Briefs 2007 143 Uncertainty analysis of large-scale systems using domain decomposition By D. Ghosh, C. Farhat AND P. Avery 1. Motivation and objectives A

More information

Nonparametric density estimation for elliptic problems with random perturbations

Nonparametric density estimation for elliptic problems with random perturbations Nonparametric density estimation for elliptic problems with random perturbations, DqF Workshop, Stockholm, Sweden, 28--2 p. /2 Nonparametric density estimation for elliptic problems with random perturbations

More information

Constrained Minimization and Multigrid

Constrained Minimization and Multigrid Constrained Minimization and Multigrid C. Gräser (FU Berlin), R. Kornhuber (FU Berlin), and O. Sander (FU Berlin) Workshop on PDE Constrained Optimization Hamburg, March 27-29, 2008 Matheon Outline Successive

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

Performance tuning of Newton-GMRES methods for discontinuous Galerkin discretizations of the Navier-Stokes equations

Performance tuning of Newton-GMRES methods for discontinuous Galerkin discretizations of the Navier-Stokes equations Fluid Dynamics and Co-located Conferences June 24-27, 2013, San Diego, CA 21st AIAA Computational Fluid Dynamics Conference AIAA 2013-2685 Performance tuning of Newton-GMRES methods for discontinuous Galerkin

More information

Progress in Mesh-Adaptive Discontinuous Galerkin Methods for CFD

Progress in Mesh-Adaptive Discontinuous Galerkin Methods for CFD Progress in Mesh-Adaptive Discontinuous Galerkin Methods for CFD German Aerospace Center Seminar Krzysztof Fidkowski Department of Aerospace Engineering The University of Michigan May 4, 2009 K. Fidkowski

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

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

Une méthode de pénalisation par face pour l approximation des équations de Navier-Stokes à nombre de Reynolds élevé

Une méthode de pénalisation par face pour l approximation des équations de Navier-Stokes à nombre de Reynolds élevé Une méthode de pénalisation par face pour l approximation des équations de Navier-Stokes à nombre de Reynolds élevé CMCS/IACS Ecole Polytechnique Federale de Lausanne Erik.Burman@epfl.ch Méthodes Numériques

More information

Goal. Robust A Posteriori Error Estimates for Stabilized Finite Element Discretizations of Non-Stationary Convection-Diffusion Problems.

Goal. Robust A Posteriori Error Estimates for Stabilized Finite Element Discretizations of Non-Stationary Convection-Diffusion Problems. Robust A Posteriori Error Estimates for Stabilized Finite Element s of Non-Stationary Convection-Diffusion Problems L. Tobiska and R. Verfürth Universität Magdeburg Ruhr-Universität Bochum www.ruhr-uni-bochum.de/num

More information

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

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

More information

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

An Efficient Low Memory Implicit DG Algorithm for Time Dependent Problems

An Efficient Low Memory Implicit DG Algorithm for Time Dependent Problems An Efficient Low Memory Implicit DG Algorithm for Time Dependent Problems Per-Olof Persson and Jaime Peraire Massachusetts Institute of Technology, Cambridge, MA 02139, U.S.A. We present an efficient implicit

More information

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

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

More information

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

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

More information

Hybrid (DG) Methods for the Helmholtz Equation

Hybrid (DG) Methods for the Helmholtz Equation Hybrid (DG) Methods for the Helmholtz Equation Joachim Schöberl Computational Mathematics in Engineering Institute for Analysis and Scientific Computing Vienna University of Technology Contributions by

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

FOR many computational fluid dynamics (CFD) applications, engineers require information about multiple solution

FOR many computational fluid dynamics (CFD) applications, engineers require information about multiple solution AIAA Aviation 13-17 June 2016, Washington, D.C. 46th AIAA Fluid Dynamics Conference AIAA 2016-3809 Improved Functional-Based Error Estimation and Adaptation without Adjoints William C. Tyson *, Katarzyna

More information

On the relationship of local projection stabilization to other stabilized methods for one-dimensional advection-diffusion equations

On the relationship of local projection stabilization to other stabilized methods for one-dimensional advection-diffusion equations On the relationship of local projection stabilization to other stabilized methods for one-dimensional advection-diffusion equations Lutz Tobiska Institut für Analysis und Numerik Otto-von-Guericke-Universität

More information

Shock Capturing for Discontinuous Galerkin Methods using Finite Volume Sub-cells

Shock Capturing for Discontinuous Galerkin Methods using Finite Volume Sub-cells Abstract We present a shock capturing procedure for high order Discontinuous Galerkin methods, by which shock regions are refined in sub-cells and treated by finite volume techniques Hence, our approach

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

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