arxiv: v1 [math.na] 28 Feb 2008

Size: px
Start display at page:

Download "arxiv: v1 [math.na] 28 Feb 2008"

Transcription

1 BDDC by a frontal solver and the stress computation in a hip joint replacement arxiv: v1 [math.na] 28 Feb 2008 Jakub Šístek a, Jaroslav Novotný b, Jan Mandel c, Marta Čertíková a, Pavel Burda a a Department of Mathematics, Faculty of Mechanical Engineering Czech Technical University in Prague b Institute of Thermomechanics, Academy of Sciences of the Czech Republic Abstract c Department of Mathematical Sciences, University of Colorado Denver A parallel implementation of the BDDC method using the frontal solver is employed to solve systems of linear equations from finite element analysis, and incorporated into a standard finite element system for engineering analysis by linear elasticity. Results of computation of stress in a hip replacement are presented. The part is made of titanium and loaded by the weight of human body. Key words: domain decomposition, iterative substructuring, finite elements, linear elasticity, parallel algorithms 1 Introduction Parallel numerical solution of linear problems arising from linearized isotropic elasticity discretized by finite elements is important in many areas of engineering. The matrix of the system is typically large, sparse, and illconditioned. The classical frontal solver [4] has became a popular direct method for solving problems with such matrices arising from finite element analyses. However, for large problems, the computational cost of direct solvers makes them less competitive compared to iterative methods, such as the addresses: jakub.sistek@fs.cvut.cz (Jakub Šístek), novotny@it.cas.cz (Jaroslav Novotný), jan.mandel@cudenver.edu (Jan Mandel), marta.certikova@fs.cvut.cz (Marta Čertíková), pavel.burda@fs.cvut.cz (Pavel Burda). Preprint submitted to Elsevier 6 January 2018

2 preconditioned conjugate gradients (PCG). The goal is then to design efficient preconditioners that result in a lower overall cost and can be implemented in parallel, which has given rise to the field of domain decomposition and iterative substructuring [10]. The Balancing Domain Decomposition based on Constraints (BDDC) [3] is one of the most advanced preconditioners of this class. However, the additional custom coding effort required can be an obstacle to the use of the method in an existing finite element code. We propose an implementation of BDDC built on top of common components of existing finite element codes, namely the frontal solver and the element stiffness matrix generation. The implementation requires only a minimal amount of additional code and it is therefore of interest. For an important alternative implementation of BDDC, see [5]. The frontal solver was used to implement a limited variant of BDDC in [1,9]. The implementation takes advantage of the existing integration of the frontal solver into the finite element methodology and of its implementation of constraints, which is well-suited for BDDC. However, the frontal solver treats naturally only point constraints, while an efficient BDDC method in three dimensions requires constraints on averages [6]. In this paper, we extend the implementation to constraints on averages and apply it to a problem in biomechanics. 2 Mathematical formulation of BDDC Consider the problem in a variational form a(u, v) = f, v v V, (1) where V is a finite element space of R 3 -valued piecewise polynomial functions v continuous on a given domain Ω R 3, satisfying homogeneous Dirichlet boundary conditions, and a(u, v) = Ω (λ div u div v µ ( u + T u) : ( v + T v)). (2) Solution u V represents the vector field of displacement. It is known that a(u, v) is a symmetric positive definite bilinear form on V. An equivalent formulation of (1) is to find a solution u to a linear system Au = f, where A = (a ij ) is the stiffness matrix computed as a ij = a(φ i, φ j ), where {φ i } is a finite element basis of V, corresponding to set of unknowns, also called degrees of freedom, defined as values of displacement at the nodes of a given triangulation of the domain. The domain Ω is decomposed into nonoverlapping subdomains Ω i, i = 1,... N, also called substructures. Unknowns common to 2

3 at least two subdomains are called boundary unknowns and the union of all boundary unknowns is called the interface Γ. The first step is the reduction of the problem to the interface. The space V is decomposed as the a-orthogonal direct sum V = V 1 V N V Γ, where V i is the space of all functions from V with nonzero values only inside Ω i (in particular, they are zero on Γ), and V Γ is the a-orthogonal complement of all spaces V i ; V Γ = {v V : a(v, w) = 0 w V i, i = 1,... N}. Functions from V Γ are fully determined by their values at unknowns on Γ and the discrete harmonic condition that they have minimal energy on every subdomain. They are represented in the computation by their values on the interface Γ. The solution satisfies u = u Γ + N i u i, where u i are solutions of the local problems A i u i = f i on every Ω i, with zero Dirichlet boundary condition on interface Γ, and u Γ solves the Schur complement problem in the space of discrete harmonic functions V Γ, Su Γ = f Γ. Once the solution u Γ on the interface Γ is found, the solutions u i in interiors of subdomains are computed prescribing the solution on Γ as Dirichlet boundary condition. See [10] for more details. The BDDC method is a particular kind of preconditioner for the reduced problem Su Γ = f Γ. The main idea of the BDDC preconditioner in an abstract form [8] is to construct an auxiliary finite dimensional space W such that V Γ W and extend the bilinear form a (, ) to a form ã (, ) defined on W W and such that solving the variational problem (1) with ã (, ) in place of a (, ) is cheaper and can be split into independent computations done in parallel. Then the solution restricted to V Γ is used for the preconditioning of S. More precisely, let E : W V Γ be a given projection of W onto V Γ, and r = f Γ Su Γ the residual. Then the output of the BDDC preconditioner is v = Ew, where w W : ã (w, z) = (r, Ez) z W. (3) In terms of operators, v = E S 1 E T r, where S is the operator associated with the bilinear form ã (but not computed explicitly as a matrix). The choice of the space W and the projection E are standard [3,8]. All functions from V Γ are continuous on the domain Ω. In order to design the space W, we relax the continuity on the interface Γ. On Γ, we select coarse degrees of freedom and define W as the space of finite element functions with minimal energy on every subdomain, continuous across Γ only at coarse degrees of freedom. The coarse degrees of freedom can be values at subdomain corners or averages over subdomain faces or edges. The continuity condition then means that the values of the corresponding unknowns, resp. averages, on neighbouring subdomains coincide. The bilinear form a (, ) from (2) is extended to ã (, ) on W W by integrating over the subdomains Ω i separately and adding the results. The projection E : W V Γ is realized as a weighted average of values from different subdomains at unknowns on the interface Γ, thus resulting in functions continuous across the interface, and the solutions of 3

4 local subdomain problems to make the averaged function discrete harmonic. To assure good performance regardless of different stiffness of the subdomains [6], the weights are chosen proportional to the corresponding diagonal entries of the subdomain stiffness matrices. The space W is further decomposed as ã-orthogonal direct sum W = W 1 W N W C, where W i is the space of functions with nonzero values only in Ω i (i.e. they have zero values at coarse unknowns and they are generally not continuous at other unknowns on Γ) and W C is the coarse space, defined as the ã-orthogonal complement of all spaces W i ; W C = {v W : ã(v, w) = 0 w W i, i = 1,... N}. Functions from W C are fully determined by their values at coarse degrees of freedom (where they are continuous) and have minimal energy. Thus, they are generally discontinuous across Γ outside of coarse unknowns. The solution w W from (3) is now split accordingly as w = w C + N i=1 w i, where w C, determined by w C W C : ã (w C, v) = (r, Ev) v W C, (4) is called the coarse correction, and w i, determined by w i W i : ã (w i, v) = (r, Ev) v W i, (5) are the corrections from the substructures Ω i. See [6,7,8] for further details. 3 BDDC implementation based on frontal solver The frontal solver implements the solution of a square linear system with some of the variables having prescribed fixed values. Equations that correspond to the fixed variables are omitted and the values of these variables are substituted into the solution vector directly. The output of the solver consists of the solution and the resulting imbalance in the equations, called reaction forces. More precisely, consider a block decomposition of the vector of unknowns x with the second block consisting of all fixed variables, and write a system matrix A with the same block decomposition. Then on exit from the frontal solver, A 11 A 12 x 1 = f 1 + 0, (6) A 21 A 22 x 2 f 2 r 2 where fixed variable values x 2 and the load vectors f 1 and f 2 are the inputs, while the solution x 1 and the reaction r 2 are the outputs. In this section, we drop the subdomain subscript i and we write subdomain vectors w in the block form with the second block consisting of unknowns that are also coarse degrees of freedom (from now on, coarse unknowns), denoted 4

5 by the subscript c, and the first block consisting of the remaining degrees of freedom, denoted by the subscript f. The vector of the coarse degrees of freedom given by averages is written as Cw, where each row of C contains the coefficients of the average that makes that degrees of freedom; zeros and ones for arithmetic averages. Then subdomain vectors w W are characterized by w c = 0, Cw = 0. Assume that C = [C f C c ], with C c = 0, that is, the averages do not involve single variable coarse degrees of freedom; then Cw = C f w f. Denote the substructure local stiffness matrix by K. This matrix is obtained by the subassembly of element matrices only of elements in the substructure. The matrix K is singular for floating subdomains (subdomains not touching Dirichlet boundary conditions), but the block K ff is nonsingular if there are enough coarse unknowns to eliminate the rigid body modes, which will be assumed. We now show how to solve (4) and (5) using the frontal solver. In the case when there are no averages as coarse degrees of freedom, we recover the previous method from [1,9]. The local substructure problems (5) are written in the frontal solver form (6) as K ff K fc Cf T w f r 0 K cf K cc 0 w c = 0 + Rea, (7) C f 0 0 µ 0 0 where w c = 0, r is the part in the f block of the residual in the PCG method distributed to the substructures by the operator E T, and Rea is the reaction. The constraint w c = 0 is enforced by marking the w c unknowns as fixed, while the remaining constraints C f w f = 0 are enforced via the Lagrange multiplier µ. Using the fact that w c = 0, we get from (7) that K ff w f = C T f µ + r, (8) K cf w f = Rea, (9) C f w f = 0. (10) ( From (8), w f = Kff 1 C T f µ + r ). Now substituting w f into (10), we get the dual problem for µ, C f Kff 1 CT f µ = C f Kff 1 r. (11) The matrix C f Kff 1 CT f is dense but small, with the order equal to the number of averages on the subdomain, and it is constructed by solving the system K ff U = Cf T with multiple right hand sides by the frontal solver and then the multiplication C f U. After solving problem (11), we substitute for µ in (8) and find w f from (8) (9) by the frontal solver, considering both w c = 0 and µ fixed. The factorization in the frontal solver for (7) and the factorization of 5

6 the dual matrix C f K 1 ff CT f need to be computed only once in the setup phase. Note that while the residual in the PCG method applied to the reduced problem is given at the interface only, the right hand side in (7) has the dimension of all degrees of freedom on the subdomain. This is corrected naturally by extending the residual to subdomain interiors by zeros, which is required by the condition that the solution w of (7) is discrete harmonic inside subdomain. Similarly, only interface values of w i are used after solution of (7) in further PCG computation. Such approach is equivalent to computing with explicit Schur complements. Aware of this, we make no distinction in notation between these vectors given on the whole subdomain and on the corresponding interface. The coarse problem (4) is solved by the frontal solver just like a finite element problem, with the subdomains playing the role of elements. It only remains to specify the basis functions of W C on the subdomain and compute the local subdomain coarse matrix efficiently. Each coarse basis function is a column vector of values of unknowns on the subdomain and it is associated with one coarse degree of freedom, which has value 1, while all other coarse degrees of freedom have value 0. Denote by ψ c the matrix whose colums are coarse basis functions associated with the coarse unknowns at corners, and ψ avg the matrix made out of the coarse basis functions associated with averages. To find the coarse basis functions, we proceed similarly as in (7) and write the equations for the coarse basis functions in the frontal solver form, now with multiple right-hand sides, K ff K fc Cf T ψf c ψ avg f K cf K cc 0 I 0 = Rea c Rea avg, (12) C f 0 0 λ c λ avg 0 I 0 0 [ ] where Rea c and Rea avg are matrices of reactions. Denote ψ f = ψf c ψ avg, f [ ] [ ] [ ] [ ] ψ c = ψc c ψc avg = I 0, λ = λ c λ avg, Rea = Rea c Rea avg, and [ ] R = 0 I with blocks of the same size. Then (12) becomes K ff ψ f + K fc ψ c = C T f λ, (13) K cf ψ f + K cc ψ c = Rea, (14) C f ψ f = R. (15) ( From (13), we get ψ f = Kff 1 Kfc ψ c + Cf T λ ). Substituting ψ f into (15), we derive the dual problem for Lagrange multipliers C f K 1 ff CT f λ = ( R + C f K 1 ff K fcψ c ), (16) 6

7 Fig. 1. Hip joint replacement, von Mises stresses in improved design. which is solved for λ by solving the system (16) for multiple right hand sides. Since ψ c is known, we can use frontal solver to solve (13)-(14) to find ψ f. Finally, we construct the local coarse matrix corresponding to the subdomain as K C = ψ T Kψ = ψ T CT [ ] f λ = ψf T ψc T Cf T λ = ψf T Cf T λ + I Rea, Rea Rea 0 where ψ = [ ψ c ψ avg ]. At the end of the setup phase, the matrix of coarse problem is factored by frontal solver, using subdomain coarse matrices as input. Note that the factorizations in the subdomain solution and in the computation of the coarse basis functions are the same, and need to be computed only once in the setup phase. 4 Numerical results The structural analysis of the replacement of the hip joint construction loaded by pressure from body weight is an important problem in bioengineering. The hip replacement consists of several parts made of titanium; here we consider the central part of the replacement joint. The problem was simplified to stationary linearized elasticity. The highest stress was reached in the notches of the holders. In the original design, holders of the hip replacement had thickness of 2 mm which led to maximal von Mises stress about 1,500 MPa. As the yield point of titanium is about 800 MPa, the geometry of the construction had to 7

8 Fig. 2. Hip joint replacement, division into 32 subdomains be modified. The thickness of the holders was increased to 3 mm, radiuses of the notches were increased, and the notches were made smaller, as is in Fig. 1. The maximal von Mises stress on this new construction was only about 540 MPa, which satisfed the demands for the strength of the construction [2,11]. The computation needs 400 minutes when using a serial frontal solver on Compaq Alpha server ES47 at the Institute of Thermomechanics, Academy of Sciences of the Czech Republic. With 32 subdomains and corner coarse degrees of freedom only, BDDC on a single Alpha processor took 10 times less, only 40 minutes. Further improvement (Tables 1 and 2) was obtained by adding averages and using a parallel computer, namely GHz Intel Itanium 2 processors of SGI Altix 4700 computer in CTU Supercomputing Centre, Prague. The decompositions into 16 and 32 subdomains were obtained by the package METIS. The mesh consists of 33,186 quadratic elements resulting in 544,734 unknowns. In the case of 16 subdomains, the interface was divided into 100 corners, 12 edges, and 35 faces, and in the case of 32 subdomains, into 200 corners, 12 edges, and 66 faces. In the first column of the tables, no additional averages are considered and only corners were used in the construction of W C. Then we enforce the equality of arithmetic averages over all edges, over all faces and over all edges and faces, respectively. We observe, that while the implementation of averages leads to a negligible increase in the computational cost of the factorizations, it considerably improves the condition number, and thus reduces the overall time of solution. Also, the decomposition into 32 subdomains leads to significantly lower computational times than the division into 16 subdomains. 8

9 coarse problem corners corners+edges corners+faces corners+edges+faces iterations cond. number est. 1,173 1, factorization (sec) pcg iter (sec) total (sec) Table 1 Hip joint replacement, 16 subdomains coarse problem corners corners+edges corners+faces corners+edges+faces iterations cond. number est. 15, factorization (sec) pcg iter (sec) total (sec) Table 2 Hip joint replacement, 32 subdomains 5 Conclusion We have presented an application of a standard frontal solver within the iterative substructuring method BDDC. The method was applied to an industrial stress analysis problem. The numerical results show that the improvement of preconditioning by additional constraints on edges and faces is significant and leads to a considerable savings of computational time, while the additional cost is negligible. In addition, the total time was lower for more subdomains. For a large number of subdomains, of course, the solution of the coarse problem will eventually become a bottleneck. Acknowledgements This research has been supported by the Czech Science Foundation under grant 106/08/0403 and by the U.S. National Science Foundation under grant DMS A part of this work was done while Jakub Šístek was visiting 9

10 at the University of Colorado Denver. The authors would also like to thank Bedřich Sousedík for his help in both typesetting and proofreading of the manuscript. References [1] P. Burda, M. Čertíková, J. Novotný, and J. Šístek, BDDC method with simplified coarse problem and its parallel implementation, Proceedings of MIS 2007, Josefův Důl, Czech Republic, January 13 20, pp Matfyzpress, Praha, [2] M. Čertíková, J. Tuzar, B Sousedík, and J. Novotný. Stress computation of the hip joint replacement using the finite element method. In Proceedings of Software a algoritmy numerické matematiky, Srní, Czech Republic, September, pp Charles University, Praha, [3] C. R. Dohrmann. A preconditioner for substructuring based on constrained energy minimization. SIAM J. Sci. Comput., 25: , [4] B. M. Irons. A frontal solution scheme for finite element analysis. Int. J. Numer. Methods Eng., 2:5 32, [5] J. Li and O. B. Widlund. FETI-DP, BDDC, and block Cholesky methods. Internat. J. Numer. Methods Engrg., 66: , [6] J. Mandel and C.R. Dohrmann. Convergence of a balancing domain decomposition by constraints and energy minimization. Numer. Linear Algebra Appl., 10: , [7] J. Mandel, C. R. Dohrmann, and R. Tezaur, An algebraic theory for primal and dual substructuring methods by constraints. Appl. Numer. Math., 54: , [8] J. Mandel and B. Sousedík. BDDC and FETI-DP under minimalist assumptions. Computing, 81: , [9] J. Šístek, M. Čertíková, P. Burda, E. Neumanová, S. Pták, J. Novotný, and A. Damašek. Development of an efficient parallel BDDC solver for linear elasticity problems. In: Blaheta, R. and Starý, J., eds, Proceedings of Seminar on Numerical Analysis, SNA 07, Ostrava, Czech Republic, January 22 26, pp Institute of Geonics AS CR, Ostrava, [10] A. Toselli and O. Widlund. Domain Decomposition Methods - Algorithms and Theory. Springer-Verlag, Berlin Heidelberg, [11] J. Tuzar. Mathematical modeling of hip joint replacement. (Matematické modelování náhrady kyčelního kloubu, in Czech), Master thesis, CVUT. 10

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

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

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

PANM 17. Marta Čertíková; Jakub Šístek; Pavel Burda Different approaches to interface weights in the BDDC method in 3D

PANM 17.  Marta Čertíková; Jakub Šístek; Pavel Burda Different approaches to interface weights in the BDDC method in 3D PANM 17 Marta Čertíková; Jakub Šístek; Pavel Burda Different approaches to interface weights in the BDDC method in 3D In: Jan Chleboun and Petr Přikryl and Karel Segeth and Jakub Šístek and Tomáš Vejchodský

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

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

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

INSTITUTE of MATHEMATICS. ACADEMY of SCIENCES of the CZECH REPUBLIC. Adaptive-Multilevel BDDC and its parallel implementation

INSTITUTE of MATHEMATICS. ACADEMY of SCIENCES of the CZECH REPUBLIC. Adaptive-Multilevel BDDC and its parallel implementation my Cze of Scie ch R n epu ces blic INSTITUTE of MATHEMATICS Aca de ACADEMY of SCIENCES of the CZECH REPUBLIC INSTITU TE THEMATICS MA of Adaptive-Multilevel BDDC and its parallel implementation Bedřich

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

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

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

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

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

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

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

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

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

Schwarz-type methods and their application in geomechanics

Schwarz-type methods and their application in geomechanics Schwarz-type methods and their application in geomechanics R. Blaheta, O. Jakl, K. Krečmer, J. Starý Institute of Geonics AS CR, Ostrava, Czech Republic E-mail: stary@ugn.cas.cz PDEMAMIP, September 7-11,

More information

ETNA Kent State University

ETNA Kent State University Electronic Transactions on Numerical Analysis. Volume 31, pp. 384-402, 2008. Copyright 2008,. ISSN 1068-9613. ETNA ON THE EQUIVALENCE OF PRIMAL AND DUAL SUBSTRUCTURING PRECONDITIONERS BEDŘICH SOUSEDÍK

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

Domain Decomposition Preconditioners for Spectral Nédélec Elements in Two and Three Dimensions

Domain Decomposition Preconditioners for Spectral Nédélec Elements in Two and Three Dimensions Domain Decomposition Preconditioners for Spectral Nédélec Elements in Two and Three Dimensions Bernhard Hientzsch Courant Institute of Mathematical Sciences, New York University, 51 Mercer Street, New

More information

The 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

GRUPO DE GEOFÍSICA MATEMÁTICA Y COMPUTACIONAL MEMORIA Nº 8

GRUPO DE GEOFÍSICA MATEMÁTICA Y COMPUTACIONAL MEMORIA Nº 8 GRUPO DE GEOFÍSICA MATEMÁTICA Y COMPUTACIONAL MEMORIA Nº 8 MÉXICO 2014 MEMORIAS GGMC INSTITUTO DE GEOFÍSICA UNAM MIEMBROS DEL GGMC Dr. Ismael Herrera Revilla iherrerarevilla@gmail.com Dr. Luis Miguel de

More information

RESEARCH ARTICLE. A strategy of finding an initial active set for inequality constrained quadratic programming problems

RESEARCH ARTICLE. A strategy of finding an initial active set for inequality constrained quadratic programming problems Optimization Methods and Software Vol. 00, No. 00, July 200, 8 RESEARCH ARTICLE A strategy of finding an initial active set for inequality constrained quadratic programming problems Jungho Lee Computer

More information

Scalable BETI for Variational Inequalities

Scalable BETI for Variational Inequalities Scalable BETI for Variational Inequalities Jiří Bouchala, Zdeněk Dostál and Marie Sadowská Department of Applied Mathematics, Faculty of Electrical Engineering and Computer Science, VŠB-Technical University

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

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

FETI Methods for the Simulation of Biological Tissues

FETI Methods for the Simulation of Biological Tissues SpezialForschungsBereich F 32 Karl Franzens Universita t Graz Technische Universita t Graz Medizinische Universita t Graz FETI Methods for the Simulation of Biological Tissues Ch. Augustin O. Steinbach

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

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

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

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

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

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

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

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 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

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

A posteriori error estimates applied to flow in a channel with corners

A posteriori error estimates applied to flow in a channel with corners Mathematics and Computers in Simulation 61 (2003) 375 383 A posteriori error estimates applied to flow in a channel with corners Pavel Burda a,, Jaroslav Novotný b, Bedřich Sousedík a a Department of Mathematics,

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

ON THE CONVERGENCE OF A DUAL-PRIMAL SUBSTRUCTURING METHOD. January 2000

ON THE CONVERGENCE OF A DUAL-PRIMAL SUBSTRUCTURING METHOD. January 2000 ON THE CONVERGENCE OF A DUAL-PRIMAL SUBSTRUCTURING METHOD JAN MANDEL AND RADEK TEZAUR January 2000 Abstract In the Dual-Primal FETI method, introduced by Farhat et al [5], the domain is decomposed into

More information

Lecture 9 Approximations of Laplace s Equation, Finite Element Method. Mathématiques appliquées (MATH0504-1) B. Dewals, C.

Lecture 9 Approximations of Laplace s Equation, Finite Element Method. Mathématiques appliquées (MATH0504-1) B. Dewals, C. Lecture 9 Approximations of Laplace s Equation, Finite Element Method Mathématiques appliquées (MATH54-1) B. Dewals, C. Geuzaine V1.2 23/11/218 1 Learning objectives of this lecture Apply the finite difference

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

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

TR THREE-LEVEL BDDC IN THREE DIMENSIONS

TR THREE-LEVEL BDDC IN THREE DIMENSIONS R2005-862 REE-LEVEL BDDC IN REE DIMENSIONS XUEMIN U Abstract BDDC methods are nonoverlapping iterative substructuring domain decomposition methods for the solution of large sparse linear algebraic systems

More information

Convergence Behavior of a Two-Level Optimized Schwarz Preconditioner

Convergence Behavior of a Two-Level Optimized Schwarz Preconditioner Convergence Behavior of a Two-Level Optimized Schwarz Preconditioner Olivier Dubois 1 and Martin J. Gander 2 1 IMA, University of Minnesota, 207 Church St. SE, Minneapolis, MN 55455 dubois@ima.umn.edu

More information

Parallelization of Multilevel Preconditioners Constructed from Inverse-Based ILUs on Shared-Memory Multiprocessors

Parallelization of Multilevel Preconditioners Constructed from Inverse-Based ILUs on Shared-Memory Multiprocessors Parallelization of Multilevel Preconditioners Constructed from Inverse-Based ILUs on Shared-Memory Multiprocessors J.I. Aliaga 1 M. Bollhöfer 2 A.F. Martín 1 E.S. Quintana-Ortí 1 1 Deparment of Computer

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

GRUPO DE GEOFÍSICA MATEMÁTICA Y COMPUTACIONAL MEMORIA Nº 3

GRUPO DE GEOFÍSICA MATEMÁTICA Y COMPUTACIONAL MEMORIA Nº 3 GRUPO DE GEOFÍSICA MATEMÁTICA Y COMPUTACIONAL MEMORIA Nº 3 MÉXICO 2014 MEMORIAS GGMC INSTITUTO DE GEOFÍSICA UNAM MIEMBROS DEL GGMC Dr. Ismael Herrera Revilla iherrerarevilla@gmail.com Dr. Luis Miguel de

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

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

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

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

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

A new algorithm for solving 3D contact problems with Coulomb friction

A new algorithm for solving 3D contact problems with Coulomb friction A new algorithm for solving 3D contact problems with Coulomb friction Radek Kučera VŠB-TU Ostrava, Department of Mathematics and Descriptive Geometry, name@email.address Summary. The paper deals with solving

More information

An Iterative Domain Decomposition Method for the Solution of a Class of Indefinite Problems in Computational Structural Dynamics

An Iterative Domain Decomposition Method for the Solution of a Class of Indefinite Problems in Computational Structural Dynamics An Iterative Domain Decomposition Method for the Solution of a Class of Indefinite Problems in Computational Structural Dynamics Charbel Farhat a, and Jing Li a a Department of Aerospace Engineering Sciences

More information

The antitriangular factorisation of saddle point matrices

The antitriangular factorisation of saddle point matrices The antitriangular factorisation of saddle point matrices J. Pestana and A. J. Wathen August 29, 2013 Abstract Mastronardi and Van Dooren [this journal, 34 (2013) pp. 173 196] recently introduced the block

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

Comparative Analysis of Mesh Generators and MIC(0) Preconditioning of FEM Elasticity Systems

Comparative Analysis of Mesh Generators and MIC(0) Preconditioning of FEM Elasticity Systems Comparative Analysis of Mesh Generators and MIC(0) Preconditioning of FEM Elasticity Systems Nikola Kosturski and Svetozar Margenov Institute for Parallel Processing, Bulgarian Academy of Sciences Abstract.

More information

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

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

More information

Two-scale Dirichlet-Neumann preconditioners for boundary refinements

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

More information

Multipréconditionnement adaptatif pour les méthodes de décomposition de domaine. Nicole Spillane (CNRS, CMAP, École Polytechnique)

Multipréconditionnement adaptatif pour les méthodes de décomposition de domaine. Nicole Spillane (CNRS, CMAP, École Polytechnique) Multipréconditionnement adaptatif pour les méthodes de décomposition de domaine Nicole Spillane (CNRS, CMAP, École Polytechnique) C. Bovet (ONERA), P. Gosselet (ENS Cachan), A. Parret Fréaud (SafranTech),

More information

From the Boundary Element Domain Decomposition Methods to Local Trefftz Finite Element Methods on Polyhedral Meshes

From the Boundary Element Domain Decomposition Methods to Local Trefftz Finite Element Methods on Polyhedral Meshes From the Boundary Element Domain Decomposition Methods to Local Trefftz Finite Element Methods on Polyhedral Meshes Dylan Copeland 1, Ulrich Langer 2, and David Pusch 3 1 Institute of Computational Mathematics,

More information

33 RASHO: A Restricted Additive Schwarz Preconditioner with Harmonic Overlap

33 RASHO: A Restricted Additive Schwarz Preconditioner with Harmonic Overlap Thirteenth International Conference on Domain Decomposition ethods Editors: N. Debit,.Garbey, R. Hoppe, J. Périaux, D. Keyes, Y. Kuznetsov c 001 DD.org 33 RASHO: A Restricted Additive Schwarz Preconditioner

More information

A domain decomposition algorithm for contact problems with Coulomb s friction

A domain decomposition algorithm for contact problems with Coulomb s friction A domain decomposition algorithm for contact problems with Coulomb s friction J. Haslinger 1,R.Kučera 2, and T. Sassi 1 1 Introduction Contact problems of elasticity are used in many fields of science

More information

Master Thesis Literature Study Presentation

Master Thesis Literature Study Presentation Master Thesis Literature Study Presentation Delft University of Technology The Faculty of Electrical Engineering, Mathematics and Computer Science January 29, 2010 Plaxis Introduction Plaxis Finite Element

More information

From the Boundary Element DDM to local Trefftz Finite Element Methods on Polyhedral Meshes

From the Boundary Element DDM to local Trefftz Finite Element Methods on Polyhedral Meshes www.oeaw.ac.at From the Boundary Element DDM to local Trefftz Finite Element Methods on Polyhedral Meshes D. Copeland, U. Langer, D. Pusch RICAM-Report 2008-10 www.ricam.oeaw.ac.at From the Boundary Element

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

Matrix Assembly in FEA

Matrix Assembly in FEA Matrix Assembly in FEA 1 In Chapter 2, we spoke about how the global matrix equations are assembled in the finite element method. We now want to revisit that discussion and add some details. For example,

More information

The Evaluation of the Thermal Behaviour of an Underground Repository of the Spent Nuclear Fuel

The Evaluation of the Thermal Behaviour of an Underground Repository of the Spent Nuclear Fuel The Evaluation of the Thermal Behaviour of an Underground Repository of the Spent Nuclear Fuel Roman Kohut, Jiří Starý, and Alexej Kolcun Institute of Geonics, Academy of Sciences of the Czech Republic,

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

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

Least-Squares Spectral Collocation with the Overlapping Schwarz Method for the Incompressible Navier Stokes Equations

Least-Squares Spectral Collocation with the Overlapping Schwarz Method for the Incompressible Navier Stokes Equations Least-Squares Spectral Collocation with the Overlapping Schwarz Method for the Incompressible Navier Stokes Equations by Wilhelm Heinrichs Universität Duisburg Essen, Ingenieurmathematik Universitätsstr.

More information

Optimal Interface Conditions for an Arbitrary Decomposition into Subdomains

Optimal Interface Conditions for an Arbitrary Decomposition into Subdomains Optimal Interface Conditions for an Arbitrary Decomposition into Subdomains Martin J. Gander and Felix Kwok Section de mathématiques, Université de Genève, Geneva CH-1211, Switzerland, Martin.Gander@unige.ch;

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

Spectral element agglomerate AMGe

Spectral element agglomerate AMGe Spectral element agglomerate AMGe T. Chartier 1, R. Falgout 2, V. E. Henson 2, J. E. Jones 4, T. A. Manteuffel 3, S. F. McCormick 3, J. W. Ruge 3, and P. S. Vassilevski 2 1 Department of Mathematics, Davidson

More information

BDDC deluxe for Isogeometric Analysis

BDDC deluxe for Isogeometric Analysis BDDC deluxe for sogeometric Analysis L. Beirão da Veiga 1, L.. Pavarino 1, S. Scacchi 1, O. B. Widlund 2, and S. Zampini 3 1 ntroduction The main goal of this paper is to design, analyze, and test a BDDC

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

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

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

Sharp condition number estimates for the symmetric 2-Lagrange multiplier method

Sharp condition number estimates for the symmetric 2-Lagrange multiplier method Sharp condition number estimates for the symmetric -Lagrange multiplier method Stephen W. Drury and Sébastien Loisel Abstract Domain decomposition methods are used to find the numerical solution of large

More information

FETI-DP for Elasticity with Almost Incompressible 2 Material Components 3 UNCORRECTED PROOF. Sabrina Gippert, Axel Klawonn, and Oliver Rheinbach 4

FETI-DP for Elasticity with Almost Incompressible 2 Material Components 3 UNCORRECTED PROOF. Sabrina Gippert, Axel Klawonn, and Oliver Rheinbach 4 1 FETI-DP for Elasticity with Almost Incompressible 2 Material Components 3 Sabrina Gippert, Axel Klawonn, and Oliver Rheinbach 4 Lehrstuhl für Numerische Mathematik, Fakultät für Mathematik, Universität

More information

Accomodating Irregular Subdomains in Domain Decomposition Theory

Accomodating Irregular Subdomains in Domain Decomposition Theory Accomodating Irregular Subdomains in Domain Decomposition Theory Olof B. Widlund 1 Courant Institute, 251 Mercer Street, New York, NY 10012, USA widlund@cims.nyu.edu Summary. In the theory for domain decomposition

More information

A FAST SOLVER FOR ELLIPTIC EQUATIONS WITH HARMONIC COEFFICIENT APPROXIMATIONS

A FAST SOLVER FOR ELLIPTIC EQUATIONS WITH HARMONIC COEFFICIENT APPROXIMATIONS Proceedings of ALGORITMY 2005 pp. 222 229 A FAST SOLVER FOR ELLIPTIC EQUATIONS WITH HARMONIC COEFFICIENT APPROXIMATIONS ELENA BRAVERMAN, MOSHE ISRAELI, AND ALEXANDER SHERMAN Abstract. Based on a fast subtractional

More information

ADDITIVE SCHWARZ FOR SCHUR COMPLEMENT 305 the parallel implementation of both preconditioners on distributed memory platforms, and compare their perfo

ADDITIVE SCHWARZ FOR SCHUR COMPLEMENT 305 the parallel implementation of both preconditioners on distributed memory platforms, and compare their perfo 35 Additive Schwarz for the Schur Complement Method Luiz M. Carvalho and Luc Giraud 1 Introduction Domain decomposition methods for solving elliptic boundary problems have been receiving increasing attention

More information

arxiv: v1 [math.na] 27 Jan 2016

arxiv: v1 [math.na] 27 Jan 2016 Virtual Element Method for fourth order problems: L 2 estimates Claudia Chinosi a, L. Donatella Marini b arxiv:1601.07484v1 [math.na] 27 Jan 2016 a Dipartimento di Scienze e Innovazione Tecnologica, Università

More information

ON ORTHOGONAL REDUCTION TO HESSENBERG FORM WITH SMALL BANDWIDTH

ON ORTHOGONAL REDUCTION TO HESSENBERG FORM WITH SMALL BANDWIDTH ON ORTHOGONAL REDUCTION TO HESSENBERG FORM WITH SMALL BANDWIDTH V. FABER, J. LIESEN, AND P. TICHÝ Abstract. Numerous algorithms in numerical linear algebra are based on the reduction of a given matrix

More information

Deflated Krylov Iterations in Domain Decomposition Methods

Deflated Krylov Iterations in Domain Decomposition Methods 305 Deflated Krylov Iterations in Domain Decomposition Methods Y.L.Gurieva 1, V.P.Ilin 1,2, and D.V.Perevozkin 1 1 Introduction The goal of this research is an investigation of some advanced versions of

More information

Efficient smoothers for all-at-once multigrid methods for Poisson and Stokes control problems

Efficient smoothers for all-at-once multigrid methods for Poisson and Stokes control problems Efficient smoothers for all-at-once multigrid methods for Poisson and Stoes control problems Stefan Taacs stefan.taacs@numa.uni-linz.ac.at, WWW home page: http://www.numa.uni-linz.ac.at/~stefant/j3362/

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 smooth variant of the fictitious domain approach

A smooth variant of the fictitious domain approach A smooth variant of the fictitious domain approach J. Haslinger, T. Kozubek, R. Kučera Department of umerical Mathematics, Charles University, Prague Department of Applied Mathematics, VŠB-TU, Ostrava

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

Chapter 7. Optimization and Minimum Principles. 7.1 Two Fundamental Examples. Least Squares

Chapter 7. Optimization and Minimum Principles. 7.1 Two Fundamental Examples. Least Squares Chapter 7 Optimization and Minimum Principles 7 Two Fundamental Examples Within the universe of applied mathematics, optimization is often a world of its own There are occasional expeditions to other worlds

More information

Numerical behavior of inexact linear solvers

Numerical behavior of inexact linear solvers Numerical behavior of inexact linear solvers Miro Rozložník joint results with Zhong-zhi Bai and Pavel Jiránek Institute of Computer Science, Czech Academy of Sciences, Prague, Czech Republic The fourth

More information

A Neumann-Dirichlet Preconditioner for FETI-DP 2 Method for Mortar Discretization of a Fourth Order 3 Problems in 2D 4 UNCORRECTED PROOF

A Neumann-Dirichlet Preconditioner for FETI-DP 2 Method for Mortar Discretization of a Fourth Order 3 Problems in 2D 4 UNCORRECTED PROOF 1 A Neumann-Dirichlet Preconditioner for FETI-DP 2 Method for Mortar Discretization of a Fourth Order 3 Problems in 2D 4 Leszek Marcinkowski * 5 Faculty of Mathematics, University of Warsaw, Banacha 2,

More information

Bath Institute For Complex Systems

Bath Institute For Complex Systems BICS Bath Institute for Complex Systems Energy Minimizing Coarse Spaces for Two-level Schwarz Methods for Multiscale PDEs J. Van lent, R. Scheichl and I.G. Graham Bath Institute For Complex Systems Preprint

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

New constructions of domain decomposition methods for systems of PDEs

New constructions of domain decomposition methods for systems of PDEs New constructions of domain decomposition methods for systems of PDEs Nouvelles constructions de méthodes de décomposition de domaine pour des systèmes d équations aux dérivées partielles V. Dolean?? F.

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

A Nonoverlapping Subdomain Algorithm with Lagrange Multipliers and its Object Oriented Implementation for Interface Problems

A Nonoverlapping Subdomain Algorithm with Lagrange Multipliers and its Object Oriented Implementation for Interface Problems Contemporary Mathematics Volume 8, 998 B 0-88-0988--03030- A Nonoverlapping Subdomain Algorithm with Lagrange Multipliers and its Object Oriented Implementation for Interface Problems Daoqi Yang. Introduction

More information