BALANCING DOMAIN DECOMPOSITION FOR PROBLEMS WITH LARGE JUMPS IN COEFFICIENTS

Size: px
Start display at page:

Download "BALANCING DOMAIN DECOMPOSITION FOR PROBLEMS WITH LARGE JUMPS IN COEFFICIENTS"

Transcription

1 MATHEMATICS OF COMPUTATION Volume 65, Number 216 October 1996, Pages BALANCING DOMAIN DECOMPOSITION FOR PROBLEMS WITH LARGE JUMPS IN COEFFICIENTS JAN MANDEL AND MARIAN BREZINA Abstract. Te Balancing Domain Decomposition algoritm uses in eac iteration solution of local problems on te subdomains coupled wit a coarse problem tat is used to propagate te error globally and to guarantee tat te possibly singular local problems are consistent. Te abstract teory introduced recently by te first-named autor is used to develop condition number bounds for conforming linear elements in two and tree dimensions. Te bounds are independent of arbitrary coefficient jumps between subdomains and of te number of subdomains, and grow only as te squared logaritm of te mes size. Computational experiments for two- and tree-dimensional problems confirm te teory. 1. Introduction Domain decomposition metods for solving elliptic boundary value problems ave received muc attention in te last few years. Te main reason for te popularity of tese metods is undoubtedly te need to take advantage of parallel computers, but many domain decomposition metods are efficient solvers in a classical uniprocessor environment as well. Tis paper is concerned wit a domain decomposition preconditioner for linear, conforming finite elements for te elliptic equation σ u) = fwit te coefficients σ canging between te subdomains by orders of magnitude. Te main component of te domain decomposition algoritms of te type studied ere is an approximate solver based on te solution of local independent subproblems on subdomains and a global coarse problem wit one or a few unknowns for eac subdomain to effect a global excange of information between te subdomain solution. Te composed approximate solver is ten used as a preconditioner in te conjugate gradients metod. It is well known tat te absence of a coarse problem results in deterioration of convergence of te iterations wit increasing number of subdomains [11, 14]. Te Balancing Domain Decomposition BDD) was introduced by Mandel [20] by adding a coarse problem to an earlier metod of De Roeck and Le Tallec [11], known as te Neumann-Neumann metod, based in turn on earlier work for te case of two subdomains [2] and on a closely related metod of Glowinski and Weeler for mixed Received by te editor Marc 18, 1993 and, in revised form, December 2, 1993 and September 21, Matematics Subject Classification. Primary 65N55, 65F10. Key words and prases. Domain decomposition, second-order elliptic boundary value problems, two-level iterative metods, discontinuous coefficients. Submitted Marc 1993; revised September c 1996 American Matematical Society

2 1388 JAN MANDEL AND MARIAN BREZINA problems [17]. Te development of BDD was motivated by very good performance of te Neumann-Neumann preconditioner for real-world problems wit strongly discontinuous coefficients for a small number of subdomains [11]. Algoritms similar to BDD but different in important aspects and convergence results also independent of coefficient jumps between subdomains were recently obtained by Dryja and Widlund [16], and by Sarkis [23]. For application of te BDD metod to mixed finite elements and computational results on a parallel computer, see Cowsar, Mandel, and Weeler [9]. For extensions of BDD to plate bending and performance results on a sared-memory parallel macine, see Le Tallec, Mandel, and Vidrascu [19]. In tis paper, we extend te abstract teory from [20] by an elementary argument sowing tat te convergence of te BDD metod is bounded independently on coefficient jumps of arbitrary size between subdomains. We obtain new bounds on convergence from te abstract teory by unifying te fundamental inequalities of te Domain Decomposition teory by Dryja and Widlund [12, 13, 26, 27] and Bramble, Pasciak, and Scatz [3, 5], and complementing tem wit some new results in te 2D case. In te 3D, we only need to use te inequalities from [5]. We sow tat te condition number after preconditioning is bounded by C1 + log 2 H/)), were H is te caracteristic subdomain size and is te caracteristic element size, bot in 2D and 3D. In te 3D case, suc a bound was already given in [20] based on a different estimate from [11]. Te teory is confirmed by computational experiments. Furter numerical results, available in te tecnical report [21], demonstrate tat te metod beaves very well even in te case of general discontinuities of te coefficients and irregular subdomain sapes in 2D and in many cases in 3D as well. Te paper is organized as follows: 2 introduces te BDD algoritm. Abstract bounds on te condition number are given in 3, relying only on algebraic arguments. Te assumptions of tese bounds are verified for finite element discretizations in 4. Finally, 5 contains numerical results. 2. Formulation of te problem and algoritms We will recall te notation and formulation of te algoritm, following [20]. Consider a system of linear algebraic equations 1) Ax = f, wit te m m, symmetric positive definite matrix A arising from a finite element discretization of a linear, elliptic, self-adjoint boundary value problem on a domain Ω. We assume te domain Ω to be split into nonoverlapping subdomains Ω 1,...,Ω k, eac of wic is te union of some of te elements. Let A i be te local stiffness matrix corresponding to subdomain Ω i, x i be te vector of degrees of freedom corresponding to all elements in Ω i,andletn i denote te matrix wit entries 0 or 1 mapping te degrees of freedom x i into global degrees of freedom, i.e., x i = Ni T x. Ten te stiffness matrix A is obtained by te standard subassembly process, A = N i A i Ni T. Eac x i is split into degrees of freedom x i tat correspond to Ω i, called interface degrees of freedom, and te remaining interior degrees of freedom ẋ i. Te degrees of freedom on Ω Ω i are assigned to te interiors. Te subdomain stiffness matrices

3 BALANCING DOMAIN DECOMPOSITION 1389 and te 0-1 matrices N i are ten split accordingly: ) ) xi Āi B i x i =, A ẋ i = i Bi T, N Ȧ i = N i,ṅ i ). i Assume te subdomain matrices A i to be symmetric and positive semidefinite and te submatrices Ȧi nonsingular. Witout loss of generality, let te interface degrees of freedom be numbered first and te interior degrees of freedom second in te global numbering. Let k Γ= Ω i, V i be te space of te interface degrees of freedom for te subdomain Ω i and V denote te space of all degrees of freedom on Γ, in a global numbering. After elimination of te interior degrees of freedom, te problem 1) reduces to a problem posedonteinterfacespacev, 2) Su = g, were S is te Scur complement 3) S = N i S i N T i, S i = Āi B i Ȧ 1 i B T i. Te local Scur complements S i are symmetric positive semidefinite and S is positive definite. Interpreting matrices as mappings, we ave 4) S : V V, S i : V i V i, Ni : V i V. Trougout tis paper, we denote u, v = u T v and, for symmetric positive semidefinite B, u, v B = Bu,v and u B = u, u B ) 1/2. Te notation u v means u, v =0. Muc of te benefit of domain decomposition is obtained already by solving te reduced problem 2) by conjugate gradients wit simple preconditioners suc as an approximation to te diagonal of S, cf. [6, 7, 18]. Evaluation of te action of S i can be implemented by solving a Diriclet problem on Ω i. Te BDD metod is based on te Neumann-Neumann preconditioner [11, 10], wic requires te solution of a Neumann problem on every subdomain Ω i named so in contrast to te Neumann-Diriclet preconditioner, wic requires solving Neumann problems on some subdomains and uses te original Diriclet problem on oters). An important design coice for te Neumann-Neumann preconditioner is te selection of weigt matrices D i tat form a decomposition of unity on te interface space V, T 5) N i D i N i = I. A straigtforward coice for D i is a diagonal matrix wit te diagonal elements being te reciprocal of te number of subdomains te degree of freedom is associated wit. A better coice, wic also guarantees a convergence bound independent of coefficient jumps between subdomains, is given in Teorem 3.3 below. For oter possibilities, see [11] and 5 below. Te following algoritm defines a linear operator M 1 N-N for use as a preconditioner.

4 1390 JAN MANDEL AND MARIAN BREZINA Algoritm 2.1 Neumann-Neumann preconditioner, [11]). Given r V, compute z = M 1 N-Nr as follows. Distribute r to subdomains, r i = Di T N i T r, solve te local problems 6) S i u i = r i on te subdomains, and average te results by z = N i D i u i. Since te matrices S i are typically singular, De Roeck and Le Tallec [11] used a pseudoinverse obtained by replacing zero pivots in te Gaussian decomposition by positive values. Te BDD metod adds a coarse problem as follows. Let n i =dimv i,0 m i n i,and Z i be n i m i matrices of full column rank suc tat 7) Ker S i Range Z i, i =1,...,k, and let W V be defined by W = {v V v = N i D i u i,u i Range Z i }. Te space W will play te role of a coarse space just as in variational multigrid metods [22]. We say tat s V is balanced if 8) Zi T DT i N i T s =0, i =1,...,k. Te process of replacing r by a balanced s = r Sw, w W, will be called balancing. We are now ready to define te action r z = M 1 u of te BDD preconditioner. Algoritm 2.2 BDD preconditioner, [20]). Given r V, compute M 1 r as follows. Balance te original residual by solving te auxiliary problem for unknown vectors λ i R mi, 9) and set 10) Z T i DT i s = r S N T i r S j=1 j=1 N j D j Z j λ j, N j D j Z j λ j ) =0, s i = D T i N T i s, i =1,...,k, i =1,...,k. Find any solution u i for eac of te local problems 11) S i u i = s i, i =1,...,k, balance te residual by solving te auxiliary problem for µ i R mi, 12) Z T i DT i N T i r S j=1 N j D j u j + Z j µ j ) ) =0, i =1,...,k,

5 BALANCING DOMAIN DECOMPOSITION 1391 and average te result on te interfaces according to 13) z = N i D i u i + Z i µ i ). If some m i =0,tenZ i as well as te block unknowns µ i and λ i are void and te it block equation is taken out of 9) and 12). Te presence of te coarse problem now guarantees tat te possibly singular local problems 11) are consistent, and te result of te algoritm does not depend on te coice of te solutions of 11), see [20]. In practice, te residual of te initial approximation sould be balanced first as in 12); ten te first balancing step 9) in every iteration can be omitted since te residual r received from te conjugate gradients algoritm is already balanced. 3. Algebraic teory In tis section, we give bounds on te condition number, relying on algebraic arguments only. Tese results apply to arbitrary linear systems of te form described in te preceding section. Teir assumptions will be verified in te following section for systems obtained from a particular variant of te Finite Element Metod. Te following teorem was proved in [20, Teorem 3.2] in te case wen Range Z i = Ker S i, but te same proof applies ere. Teorem 3.1. Algoritm 2.2 returns z = M 1 r,weremis symmetric positive definite and cond M,S) =λ max M 1 S)/λ min M 1 S) C, were { k j=1 C=sup N j T k N } i D i u i 2 S j k u u i V i, u i Ker S i, S i u i Range Z i. i 2 S i To motivate te bound given in Teorem 3.1, we need te concepts of glob and glob projection, defined as follows. Definition 3.2. Any vertex, edge, and, in te 3D case, face, of Γ will be called a glob. A glob is understood to be relatively open; for example, an edge does not contain its endpoints. We will also identify a glob wit te set of te degrees of freedom associated wit it. Te set of all globs will be denoted by G. For a glob G G, define te glob projection as follows: for a vector u V, E G u V is te vector tat as te same values as u for all degrees of freedom in G, andall oter degrees of freedom of E G u are zero. Te glob projection in terms of te local degrees of freedom is E ji G = N j TE G N i : V i V j. Note tat any two distinct globs from G are disjoint, and Γ = k Ω i = G G G. Te mappings E G, E ij G correspond to zero-one matrices and satisfy 14) E G = I, NT j Ni = E ji G, Eji G = Eji G Eii G, G G G G and 15) G Ω i Ω j E ji G 0, G Ω i EG ii 0. We are now ready for an abstract bound in te case wen te matrices S i are scaled by arbitrary positive numbers α i, wic corresponds to coefficient discontinuities of arbitrary size between te subdomains. Te teorem is formulated and proved in terms of properties of matrices only.

6 1392 JAN MANDEL AND MARIAN BREZINA Teorem 3.3. Let α i > 0, i =1,...,k, t 1/2,andE ji G, Ni, S i,andz i satisfy 3), 14), and7). Define D i as te diagonal matrices 16) D i = di, G)EG ii, di, G) = α t i G:E G 0 ii t j α j:e ji G 0 and assume tat tere exists a number R so tat for all i, j =1,...,k and all G, 1 17) E ji G α u i 2 S j 1 R u i 2 S j α i i for all u i suc tat u i Ker S i, S i u i Range Z i. Ten te weigt matrices D i form a decomposition of unity 5), and te preconditioner defined by Algoritm 2.2 satisfies 18) cond M,S) K 2 L 2 R, T were K =max i {j N j Ni 0}, andl=max i,j {G E ji G 0}. Proof. Te property 5) follows from te definition 16) and from 14), N i T D i N i = di, G)E G = E G = I. G:E G 0 ii G G Let j be fixed. Since tere are at most K nonzero terms in te sum k N j T N i D i u i, it follows by te triangle inequality and te Caucy inequality tat ) 2 N j T N i D i u i 2 S j N j T N i D i u i Sj K N j T N i D i u i 2 S j, and 19) j=1 N T j N i D i u i 2 S j K 2 max N j T j, N i D i u i 2 S j. If E ji G 0, te coefficient di, G) from 16) satisfies di, G) αt i /αt i + αt j ), and it follows from 14) and from 17) tat N T j N i D i u i Sj Now by 19), G:E ji G 0 α t i α t i + αt j E ji G u i Sj G:E ji G 0 LR 1/2 ρ 1/2 sup ρ>0 1+ρ t u i Si LR 1/2 u i Si. j=1 N T j N i D i u i 2 S j K 2 L 2 R u i 2 S i, α t 1/2 i α 1/2 j α t i + αt j R 1/2 u i Si wic concludes te proof, owing to Teorem 3.1. Note tat te constant K is te maximal number of adjacent subdomains Ω j to any subdomain Ω i plus one, and L is te maximal number of globs in any Ω i Ω j. If t>1/2, te estimate 18) can be sligtly improved; in particular, if t = 1, analogously to te metod of De Roeck and Le Tallec [11], one as cond M,S) K 2 L 2 R/2.

7 BALANCING DOMAIN DECOMPOSITION 1393 Te related metod of Dryja and Widlund [16] uses te coarse space W wit t =1/2 in 16), and te matrices S i in 11) replaced by S i + c i M i, M i positive definite, to avoid solving singular problems. Sarkis [23] obtained an estimate for a similar metod for nonconforming elements wit any t 1/2. 4. Teory for a finite element discretization Let Ω be a bounded domain in R d d =2ord= 3) wit a piecewise smoot boundary Ω, and Ω =Γ 1 Γ 2 wit Γ 1, Γ 2 disjoint, Γ 1 > 0. Consider te model problem 20) were 21) Lu = f in Ω, u = g on Γ 1, Lv = d r,s=1 x r u n =0onΓ 2, αx)β rs x) vx) ), x s wit te coefficient matrix β rs ) uniformly positive definite, bounded and piecewise smoot on Ω, and αx) a positive constant in eac subdomain Ω i, i.e., αx) =α i >0 for x Ω i. Let ˆΩ denote a reference domain of diameter O1) e.g., square or cube in 2D or 3D, respectively) and assume tat te subdomains Ω i are of diameter OH) and sape regular, i.e., 22) Ω i = F i ˆΩ), F i CH, Fi 1 CH 1, wit F i te Jacobian and te Euclidean R d matrix norm. Let V Ω) be a conforming linear finite element space on a triangulation of Ω suc tat eac subdomain Ω i is te union of some of te elements, and te usual sape regularity and inverse assumption old [8]. All functions v V Ω) satisfy omogeneous boundary condition u =0onΓ 1. Let V Ω i ) be te space of te restrictions of functions in V Ω) to Ω i. In all te estimates below, C and c denote generic positive constants independent of te sapeorsizeofωandω i. Note tat tese constants may depend on te constant in 22) or on te regularity of te triangulation, but tey are independent of and H. Following [4], [12] or [25], we define te scaled Sobolev norms u 2 1,Ω i = u 2 1,Ω i + 1 H 2 u 2 0,Ω i, u 2 1/2, Ω i = u 2 1/2, Ω i + 1 H u 2 0, Ω i, were u 2 1,Ω i = ux) 2 dx, u 2 ut) us) 1/2, Ω i = Ω i Ω i Ωi 2 t s d dtds. Te advantage of tis definition is tat it allows us to restrict all of our considerations to te reference domain ˆΩ and use te mappings F i to obtain te results for eac Ω i from te obvious norm equivalence c u 2 1,Ω i u F i 2 1,ˆΩ Hd 2 C u 2 1,Ω i, 23) c u 2 1/2, Ω i u F i 2 1/2, ˆΩ Hd 2 C u 2 1/2, Ω i.

8 1394 JAN MANDEL AND MARIAN BREZINA Assume tat for eac Ω i,γ 1 Ω i is eiter empty or a part of Ω i of size bounded below by a fixed proportion of te size of Ω i so tat te Poincaré inequality olds uniformly for all Ω i and wit te constant C independent of and H, 24) u 2 0,Ω i CH u 2 1,Ω i, u 2 0, Ω i CH 1/2 u 2 1/2, Ω i for all u V Ω i )ifγ 1 Ω i and for all u V Ω i ), Ω i uds = 0 if Γ 1 Ω i =. To apply Teorem 3.1, we first need to replace te S i norm by te scaled H 1/2 norm. Tis is a standard result [3, 13, 26], wic we state ere for reference in a form suitable for our purposes. Te scaling by α i is obvious. Lemma 4.1. Tere exist constants c>0,c independent of H or so tat c u 2 1/2, Ω i 1 α i u 2 S i C u 2 1/2, Ω i, u V Ω i ). To derive te fundamental inequality 17) assumed in Teorem 3.3, we identify by abuse of notation) V wit V Γ) and V i wit V Ω i ). Ten te glob projections are E G : V Γ) V Γ), and 17) becomes a bound on te increase of te H 1/2 norm wen a function in V Ω i ) is canged by setting its values to zero on all nodes of Ω i \ G. We first consider te two-dimensional case, Ω R 2.Since Ω i is one-dimensional, we may use te properties of te space V 0,H) of piecewise linear functions on a uniform mes wit step on te interval [0,H]. Te following form of Discrete Sobolev Inequality was proved by Dryja [12]. Lemma 4.2. Tere exists a constant C suc tat u 2 L 0,H) C 1+log H ) u 2 H 1/2 0,H), u V 0,H). We will also need te following bound for te H 1/2 norm of te extension by zero from an interval to te wole R, proved by Bramble, Pasciak, and Scatz [3, Lemma 3.5]. Lemma 4.3. Tere exists a constant C suc tat for all u V 0,H) satisfying u0) = uh) =0,u=0outside 0,H), u 2 1/2,R C 1+log H ) u 2 L 0,H) + u 2 1/2,0,H). An estimate of te H 1/2 norm of a spike function, obtained by sampling te value of a given function at one point, follows easily. Lemma 4.4. Tere exists a constant C suc tat for all u V 0,H),0 1, and v 0 V R) defined by v 0 0) = u0), v 0 x)=0for x, v 0 2 1/2,R C 1+log H ) u 2 1/2,0,H). Proof. Let L = u L 0,H). It follows from Lemma 4.3 tat v 0 2 1/2,R C 1+log 2 ) 25) v 0 2 L,) + v 0 2 1/2,,).

9 BALANCING DOMAIN DECOMPOSITION 1395 Using linearity of v 0,weobtain v 0 2 1/2,,) = v 0 s) v 0 t) 2 26) s t 2 dsdt 4 L 2, because v 0 2 L,) = v 0 0) 2 L 2. Tus, v 0 2 1/2,,) CL2. But L 2 C1 + log H ) u 2 1/2,0,H) by Lemma 4.2, wic concludes te proof. By subtracting suc spikes at te endpoints, we can extend Lemma 4.3 to te case wen te values of u at te endpoints are nonzero. Lemma 4.5. Tere exists a constant C so tat for u V 0,H) and w V R) suc tat w = u on [, H ], and wx) =0for x 0, x H, w 2 1/2,R C 1+log H ) 2 u 2 1/2,0,H). Proof. Define ux) to be zero for x, ) H +, ), and linear in [, 0] and [H, H + ]. Furter, define v 0 and v H by v 0 x) = { u0), x =0, 0, x, v 0 linear in [, 0] and in [0,], { uh), x = H, v H x) = 0, x H, v H linear in [H, H] andin[h, H + ]. Writing w as w = u v 0 v H,and applying Lemma 4.3 and Lemma 4.4, we obtain w 2 1/2,R C 1+log H ) w 2 L 0,H) + w 2 1/2,0,H) = C 1+log H ) u 2 L 0,H) + w 2 1/2,0,H) C 1+log H ) u 2 L 0,H) +3 u 2 1/2,0,H) + v 0 2 1/2,R + v H 2 ) 1/2,R C 1+log H ) ) u 2 L 0,H) + u 2 1/2,0,H) +1+logH ) u 2 1/2,0,H). Application of Lemma 4.2 to u L,0,H) concludes te proof. We are now ready for te estimate of te H 1/2 norm of te glob projections E G, wic sows tat an arbitrary function in V Ω i ) can be decomposed into its glob parts wit only a small increase in te H 1/2 norm. Teorem 4.6. Let Ω R d, d =2or d =3. Ten tere exists a constant C not dependent of or H, so tat for any glob G G and for all u V Ω i ), E G u 2 1/2, Ω i C 1+log H ) 2 u 2 1/2,G. Proof. In te 2D case, te proposition follows by using a mapping of Ω i onto an interval so tat G maps to 0,H), from Lemma 4.5 for G being an edge, and from Lemma 4.4 for G being a vertex.

10 1396 JAN MANDEL AND MARIAN BREZINA In te 3D case, te proposition was proved for te case of G beingafaceof Ω i as Lemma 4.3 in [5]. In te case of G being an edge or a vertex of Ω i, te proof follows from Lemma 4.2. and te proof of Lemma 4.1 of [5]. Te bound on te condition number of te BDD algoritm follows. Teorem 4.7. Let Ω R d, d =2or d =3, and te weigt matrices D i be diagonal wit te entries given by 16). Ten tere exists a constant C independent of H, and α i, so tat te condition number of te BDD metod satisfies cond M,S) C 1+log 2 H Proof. We only need to verify te assumption 17) of Teorem 3.3. Lemma 4.1 allows to replace te S i norms by te H 1/2 Ω i ) seminorms, wic may in turn be replaced by te H 1/2 Ω i ) norms, owing to te Poincaré inequality 24). It remains to use Teorem 4.6. ). 5. Computational results Te purpose of our computational tests was to demonstrate te fast convergence of te BDD metod on complicated problems wit varying coefficients. In all of te following examples, te space V of te piecewise linear functions defined on a uniform rectangular mes of stepsize in 2D or 3D was used for te solution of te elliptic problem of te form 20), u divσ u) =1inΩ, u =1onΓ 1, n =0onΓ 2, wit Ω =Γ 1 Γ 2,Γ 1 Γ 2 =. Te coefficient σ is an elementwise constant function, and k is te number of subdomains. We ave compared tree algoritms: conjugate gradients applied to te reduced system 2) witout preconditioning denoted as CG in te tables), conjugate gradients wit Neumann-Neumann preconditioner and te local singular problems 6) solved using te Moore-Penrose pseudoinverse Algoritm 2.1, denoted as N-N), and conjugate gradients wit te BDD preconditioner using Range Z i = Ker S i Algoritm 2.2, denoted as BDD). Te stopping criterion for te iterations was based on 27) λ max M 1 S) λ min M 1 S) M 1 r, r M 1 b, b ɛ2, wit r te current residual and b te rigt-and side, wic guarantees te relative precision of ɛ in te energy norm, cf. Asby, Manteuffel, and Saylor [1]. Te condition number λ max M 1 S)/λ min M 1 S) reported in te tables and also used in 27) was estimated as te ratio of te extreme Ritz values for te Krylov space, computed from te eigenvalues of a tridiagonal matrix constructed from te Lanczos recursion in conjugate gradients. Number of iterations wit means tat te criterion 27) was not satisfied wen te maximum number of iterations was reaced. Te 2D examples were computed by a prototype implementation of te BDD metod programmed using te CLAM package [24]. In te two-dimensional test BDD implementation, te weigts D i were based on te diagonal entries of te Scur complements, as suggested in [11], because we ad te diagonal entries of te

11 BALANCING DOMAIN DECOMPOSITION 1397 Table 1. 2D results for Poisson equation on unit square Fig. 1, σ 1 = σ 2 =1) CG N-N BDD k iterations cond. iterations cond. iterations cond. 1/ / , / , Table 2. 2D ceckerboard pattern Fig. 1, σ 1 =10 3,σ 2 =10 3 ) CG N-N BDD k σ 1 σ 2 iter cond. iter cond. iter cond. 1/ / * / , Table 3. 2 x 2 ceckerboard pattern for various σ 1,σ 2 CG N-N BDD k σ 1 σ 2 iter cond. iter cond. iter cond. 1/ * / * , / * , Scur complement available: Denote s i ll te diagonal entry of Scur complement S i corresponding to global degree of freedom l. For subdomain Ω i, te weigt matrix D i was constructed as diagonal wit diagonal elements d i ψ il),wereψ il)iste local number in Ω i associated wit te global degree of freedom l, d i ψ il) = s i ll j:l Ω j s j ll wic is essentially 16) computed node by node wit te diagonal entries of S i used instead of te scalars α i. Tis coice of te weigts was found to give good results [11]. Te domain Ω was cosen to be te unit square and Γ 1 was te left-and side of Ω. Te tests sow tat unlike for te CG and N-N metod, te condition number and te number of iterations of te BDD metod does not deteriorate for increasing number of subdomains Table 1, Fig. 1), te coefficient σ varying by orders of magnitude between te subdomains Table 2, Fig. 1), and increasing jumps in te coefficients Table 3).,

12 1398 JAN MANDEL AND MARIAN BREZINA Γ 2 σ 1 σ 2 σ 1 σ 2 σ 1 σ 2 σ 1 σ 2 σ 1 σ 2 Γ σ 1 σ 2 σ 1 σ 2 σ 1 1 Γ 2 σ 2 σ 1 σ 2 σ 1 σ 2 σ 1 σ 2 σ 1 σ 2 σ 1 Γ 2 Figure 1. 2D ceckerboard pattern Table 4. 3D Poisson s equation, various and number of subdomains x y z k dof iter cond. 1/15 1/15 1/ /20 1/25 1/ /30 1/30 1/ A FORTRAN implementation was used for te 3D experiments, wit te action of S i implemented in a straigtforward way following te definition of te Scur complement 3). Te implementation of te action of te inverse, tat is, te solution of S i y = x, relies on te obvious fact tat y may equivalently be computed, using notation of 2, as solution of te sparse system ) ) ) Āi B i y x =, z 0 B T i Ȧ i

13 BALANCING DOMAIN DECOMPOSITION 1399 Table 5. 3D ceckerboard pattern wit alternating σ k σ 1 σ 2 dof iter cond. 1/ / / / / / / / discarding z afterwards. Since te diagonal entries of S i are not available, te weigts were defined from α i = σ i by 16) wit t = 1. Te problem was set on unit cube Ω, wit zero Diriclet boundary condition on te wole Ω, and ɛ =10 18 was used for te stopping criterion 27). Again, te results confirm te teory. Finally, one sould note tat te l 2 norm of residual of te global solution was never larger tan 20 times te l 2 residual of te reduced solution. For furter numerical results, see [21]. FORTRAN 77 code tat implements te metod is available from MGNET by anonymous ftp to casper.cs.yale.edu in te directory /mgnet/jmandel. Te code invokes user-supplied subroutines tat implement te matrix-vector multiplications S i x i and solution of te possibly singular systems S i z i = r i. Acknowledgements Te autors are grateful to Olof Widlund for inspiring discussions and for providing in is papers te available teoretical tools in a systematic form tat made te simple proofs presented ere possible, and in particular for making available to us early drafts of [15] as well as oter publications. We also tank Lawrence Cowsar for useful discussions and pointing out several improvements in an earlier version of te paper. Tis researc was supported by NSF grants DMS , ASC , and ASC References 1. S. Asby, T. A. Manteuffel, and P. E. Saylor, A taxonomy for conjugate gradient metods, SIAM J. Numer. Anal., ), pp MR 91i: J.-F. Bourgat, R. Glowinski, P. Le Tallec, and M. Vidrascu, Variational formulation and algoritm for trace operator in domain decomposition calculations, in Domain Decomposition Metods, T. Can, R. Glowinski, J. Périaux, and O. Widlund, eds., SIAM, Piladelpia, PA, MR 90b: J. H. Bramble, J. E. Pasciak, and A. H. Scatz, Te construction of preconditioners for elliptic problems by substructuring, I, Mat. Comp., ), pp MR 87m: , An iterative metod for elliptic problems on regions partitioned into substructures, Mat. Comp., ), pp MR 88a: , Te construction of preconditioners for elliptic problems by substructuring, IV, Mat. Comp., ), pp MR 89m: T. F. Can, Analysis of preconditioners for domain decomposition, SIAM J. Numer. Anal., ), pp MR 88e:65033

14 1400 JAN MANDEL AND MARIAN BREZINA 7. T. F. Can and T. P. Matew, Te interface probing tecnique in domain decomposition, SIAM J. on Matrix Analysis and Applications, ), pp MR 92i: P. G. Ciarlet, Te Finite Element Metod for Elliptic Problems, Nort Holland, Amsterdam, MR 58: L. Cowsar, J. Mandel, and M. F. Weeler, Balancing domain decomposition for mixed finite elements. Mat. Comp., ), pp MR 95j: Y.-H. De Roeck, Résolution sur Ordinateurs Multi-Processeurs de Problème d Elasticité par Décomposition de Domaines, PD tesis, Université Paris IX Daupine, Y.-H. De Roeck and P. Le Tallec, Analysis and test of a local domain decomposition preconditioner, in Fourt International Symposium on Domain Decomposition Metods for Partial Differential Equations, R. Glowinski, Y. Kuznetsov, G. Meurant, J. Périaux, and O. Widlund, eds., SIAM, Piladelpia, PA, CMP 91: M. Dryja, A metod of domain decomposition for 3-D finite element elliptic problems, infirst International Symposium on Domain Decomposition Metods for Partial Differential Equations, R. Glowinski, G. H. Golub, G. A. Meurant, and J. Périaux, eds., SIAM, Piladelpia, PA, MR 90b: M. Dryja and O. B. Widlund, Towards a unified teory of domain decomposition algoritms for elliptic problems, in Tird International Symposium on Domain Decomposition Metods for Partial Differential Equations, eld in Houston, Texas, Marc 20-22, 1989, T. Can, R. Glowinski, J. Périaux, and O. Widlund, eds., SIAM, Piladelpia, PA, MR 91m: , Additive Scwarz metods for elliptic finite element problems in tree dimensions, in Fift International Symposium on Domain Decomposition Metods for Partial Differential Equations, T. F. Can, D. E. Keyes, G. A. Meurant, J. S. Scroggs, and R. G. Voigt, eds., SIAM, Piladelpia, PA, MR 93j: , Domain decomposition algoritms wit small overlap, SIAM J. Sci.Comput., ), pp MR 95d: , Scwarz metods of Neumann-Neumann type for tree-dimensional elliptic finite element problems, Comm. Pure Appl. Mat, ), pp CMP 95: R. Glowinski and M. F. Weeler, Domain decomposition and mixed finite element metods for elliptic problems, in First International Symposium on Domain Decomposition Metods for Partial Differential Equations, R. Glowinski, G. H. Golub, G. A. Meurant, and J. Périaux, eds., SIAM, Piladelpia, PA, MR 90a: D. E. Keyes and W. D. Gropp, A comparison of domain decomposition tecniques for elliptic partial differential equations and teir parallel implementation, SIAM J. Sci. Stat. Comput., ), pp. s166 s202. MR 88g: P. Le Tallec, J. Mandel, and M. Vidrascu, Balancing domain decomposition for plates, in Domain Decomposition Metods in Scientific and Engineering Computing, D. E. Keyes and J. Xu, eds., American Matematical Society, Providence, RI, 1994, pp Proceedings of te 7t International Symposium on Domain Decomposition Metods, Penn State, November MR 95j: J. Mandel, Balancing domain decomposition, Comm. in Numerical Metods in Engrg., ), pp MR 94b: J. Mandel and M. Brezina, Balancing domain decomposition: Teory and computations in two and tree dimensions, UCD/CCM Report 2, Center for Computational Matematics, University of Colorado at Denver, November J. Mandel, S. McCormick, and R. Bank, Variational multigrid teory, in Multigrid Metods, S. F. McCormick, ed., SIAM, Piladepia, 1987, c. 5, pp CMP 21: M. Sarkis, Two-level Scwarz metods for nonconforming finite elements and discontinuous coefficients, in Proceedings of te Sixt Copper Mountain Conference on Multigrid Metods, Volume 2, N. D. Melson, T. A. Manteuffel, and S. F. McCormick, eds., no. 3224, Hampton VA, 1993, NASA, pp Scientific Computing Associates, CLAM User s Guide; Te Computational Linear Algebra Macine, Version 2.00, New Haven, CT, B. F. Smit, A domain decomposition algoritm for elliptic problems in tree dimensions, Numer. Mat., ), pp MR 92m:65159

15 BALANCING DOMAIN DECOMPOSITION O. B. Widlund, An extension teorem for finite element spaces wit tree applications, in Numerical Tecniques in Continuum Mecanics, W. Hackbusc and K. Witsc, eds., Braunscweig/Wiesbaden, 1987, Notes on Numerical Fluid Mecanics, v. 16, Friedr. Vieweg und Son, pp Proceedings of te Second GAMM-Seminar, Kiel, January, , Iterative substructuring metods: Algoritms and teory for elliptic problems in te plane, in First International Symposium on Domain Decomposition Metods for Partial Differential Equations, R. Glowinski, G. H. Golub, G. A. Meurant, and J. Périaux, eds., SIAM, Piladelpia, PA, MR 90c:65138 Center for Computational Matematics, University of Colorado at Denver, Denver, Colorado address: address:

Preconditioning in H(div) and Applications

Preconditioning in H(div) and Applications 1 Preconditioning in H(div) and Applications Douglas N. Arnold 1, Ricard S. Falk 2 and Ragnar Winter 3 4 Abstract. Summarizing te work of [AFW97], we sow ow to construct preconditioners using domain decomposition

More information

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

ON THE CONVERGENCE OF A DUAL-PRIMAL SUBSTRUCTURING METHOD. January 2000 Revised April 2000 ON THE CONVERGENCE OF A DUAL-PRIMAL SUBSTRUCTURING METHOD JAN MANDEL AND RADEK TEZAUR January 2000 Revised April 2000 Abstract In te Dual-Primal FETI metod, introduced by Farat et al [5], te domain is

More information

Figure 1. Figure. Anticipating te use of two-level domain decomposition preconditioners, we construct a triangulation of in te following way. Let be d

Figure 1. Figure. Anticipating te use of two-level domain decomposition preconditioners, we construct a triangulation of in te following way. Let be d Lower Bounds for Two-Level Additive Scwarz Preconditioners wit Small Overlap * Susanne C. Brenner Department of Matematics University of Sout Carolina Columbia, SC 908 Summary. Lower bounds for te condition

More information

1. Introduction. We consider the model problem: seeking an unknown function u satisfying

1. Introduction. We consider the model problem: seeking an unknown function u satisfying A DISCONTINUOUS LEAST-SQUARES FINITE ELEMENT METHOD FOR SECOND ORDER ELLIPTIC EQUATIONS XIU YE AND SHANGYOU ZHANG Abstract In tis paper, a discontinuous least-squares (DLS) finite element metod is introduced

More information

More on generalized inverses of partitioned matrices with Banachiewicz-Schur forms

More on generalized inverses of partitioned matrices with Banachiewicz-Schur forms More on generalized inverses of partitioned matrices wit anaciewicz-scur forms Yongge Tian a,, Yosio Takane b a Cina Economics and Management cademy, Central University of Finance and Economics, eijing,

More information

Different Approaches to a Posteriori Error Analysis of the Discontinuous Galerkin Method

Different Approaches to a Posteriori Error Analysis of the Discontinuous Galerkin Method WDS'10 Proceedings of Contributed Papers, Part I, 151 156, 2010. ISBN 978-80-7378-139-2 MATFYZPRESS Different Approaces to a Posteriori Error Analysis of te Discontinuous Galerkin Metod I. Šebestová Carles

More information

Crouzeix-Velte Decompositions and the Stokes Problem

Crouzeix-Velte Decompositions and the Stokes Problem Crouzeix-Velte Decompositions and te Stokes Problem PD Tesis Strauber Györgyi Eötvös Loránd University of Sciences, Insitute of Matematics, Matematical Doctoral Scool Director of te Doctoral Scool: Dr.

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

Numerical Experiments Using MATLAB: Superconvergence of Nonconforming Finite Element Approximation for Second-Order Elliptic Problems

Numerical Experiments Using MATLAB: Superconvergence of Nonconforming Finite Element Approximation for Second-Order Elliptic Problems Applied Matematics, 06, 7, 74-8 ttp://wwwscirporg/journal/am ISSN Online: 5-7393 ISSN Print: 5-7385 Numerical Experiments Using MATLAB: Superconvergence of Nonconforming Finite Element Approximation for

More information

LEAST-SQUARES FINITE ELEMENT APPROXIMATIONS TO SOLUTIONS OF INTERFACE PROBLEMS

LEAST-SQUARES FINITE ELEMENT APPROXIMATIONS TO SOLUTIONS OF INTERFACE PROBLEMS SIAM J. NUMER. ANAL. c 998 Society for Industrial Applied Matematics Vol. 35, No., pp. 393 405, February 998 00 LEAST-SQUARES FINITE ELEMENT APPROXIMATIONS TO SOLUTIONS OF INTERFACE PROBLEMS YANZHAO CAO

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 additive average Schwarz method for the plate bending problem

An additive average Schwarz method for the plate bending problem J. Numer. Math., Vol. 10, No. 2, pp. 109 125 (2002) c VSP 2002 Prepared using jnm.sty [Version: 02.02.2002 v1.2] An additive average Schwarz method for the plate bending problem X. Feng and T. Rahman Abstract

More information

27. A Non-Overlapping Optimized Schwarz Method which Converges with Arbitrarily Weak Dependence on h

27. A Non-Overlapping Optimized Schwarz Method which Converges with Arbitrarily Weak Dependence on h Fourteent International Conference on Domain Decomposition Metods Editors: Ismael Herrera, David E. Keyes, Olof B. Widlund, Robert Yates c 003 DDM.org 7. A Non-Overlapping Optimized Scwarz Metod wic Converges

More information

Dedicated to the 70th birthday of Professor Lin Qun

Dedicated to the 70th birthday of Professor Lin Qun Journal of Computational Matematics, Vol.4, No.3, 6, 4 44. ACCELERATION METHODS OF NONLINEAR ITERATION FOR NONLINEAR PARABOLIC EQUATIONS Guang-wei Yuan Xu-deng Hang Laboratory of Computational Pysics,

More information

MANY scientific and engineering problems can be

MANY scientific and engineering problems can be A Domain Decomposition Metod using Elliptical Arc Artificial Boundary for Exterior Problems Yajun Cen, and Qikui Du Abstract In tis paper, a Diriclet-Neumann alternating metod using elliptical arc artificial

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

Overlapping domain decomposition methods for elliptic quasi-variational inequalities related to impulse control problem with mixed boundary conditions

Overlapping domain decomposition methods for elliptic quasi-variational inequalities related to impulse control problem with mixed boundary conditions Proc. Indian Acad. Sci. (Mat. Sci.) Vol. 121, No. 4, November 2011, pp. 481 493. c Indian Academy of Sciences Overlapping domain decomposition metods for elliptic quasi-variational inequalities related

More information

New Streamfunction Approach for Magnetohydrodynamics

New Streamfunction Approach for Magnetohydrodynamics New Streamfunction Approac for Magnetoydrodynamics Kab Seo Kang Brooaven National Laboratory, Computational Science Center, Building 63, Room, Upton NY 973, USA. sang@bnl.gov Summary. We apply te finite

More information

arxiv: v1 [math.na] 9 Sep 2015

arxiv: v1 [math.na] 9 Sep 2015 arxiv:509.02595v [mat.na] 9 Sep 205 An Expandable Local and Parallel Two-Grid Finite Element Sceme Yanren ou, GuangZi Du Abstract An expandable local and parallel two-grid finite element sceme based on

More information

Polynomial Interpolation

Polynomial Interpolation Capter 4 Polynomial Interpolation In tis capter, we consider te important problem of approximatinga function fx, wose values at a set of distinct points x, x, x,, x n are known, by a polynomial P x suc

More information

arxiv: v1 [math.na] 6 Dec 2010

arxiv: v1 [math.na] 6 Dec 2010 MULTILEVEL PRECONDITIONERS FOR DISCONTINUOUS GALERKIN APPROXIMATIONS OF ELLIPTIC PROBLEMS WITH JUMP COEFFICIENTS BLANCA AYUSO DE DIOS, MICHAEL HOLST, YUNRONG ZHU, AND LUDMIL ZIKATANOV arxiv:1012.1287v1

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

Uniform estimate of the constant in the strengthened CBS inequality for anisotropic non-conforming FEM systems

Uniform estimate of the constant in the strengthened CBS inequality for anisotropic non-conforming FEM systems Uniform estimate of te constant in te strengtened CBS inequality for anisotropic non-conforming FEM systems R. Blaeta S. Margenov M. Neytceva Version of November 0, 00 Abstract Preconditioners based on

More information

ERROR BOUNDS FOR THE METHODS OF GLIMM, GODUNOV AND LEVEQUE BRADLEY J. LUCIER*

ERROR BOUNDS FOR THE METHODS OF GLIMM, GODUNOV AND LEVEQUE BRADLEY J. LUCIER* EO BOUNDS FO THE METHODS OF GLIMM, GODUNOV AND LEVEQUE BADLEY J. LUCIE* Abstract. Te expected error in L ) attimet for Glimm s sceme wen applied to a scalar conservation law is bounded by + 2 ) ) /2 T

More information

Mass Lumping for Constant Density Acoustics

Mass Lumping for Constant Density Acoustics Lumping 1 Mass Lumping for Constant Density Acoustics William W. Symes ABSTRACT Mass lumping provides an avenue for efficient time-stepping of time-dependent problems wit conforming finite element spatial

More information

The Laplace equation, cylindrically or spherically symmetric case

The Laplace equation, cylindrically or spherically symmetric case Numerisce Metoden II, 7 4, und Übungen, 7 5 Course Notes, Summer Term 7 Some material and exercises Te Laplace equation, cylindrically or sperically symmetric case Electric and gravitational potential,

More information

arxiv: v1 [math.na] 17 Jul 2014

arxiv: v1 [math.na] 17 Jul 2014 Div First-Order System LL* FOSLL* for Second-Order Elliptic Partial Differential Equations Ziqiang Cai Rob Falgout Sun Zang arxiv:1407.4558v1 [mat.na] 17 Jul 2014 February 13, 2018 Abstract. Te first-order

More information

Differentiation in higher dimensions

Differentiation in higher dimensions Capter 2 Differentiation in iger dimensions 2.1 Te Total Derivative Recall tat if f : R R is a 1-variable function, and a R, we say tat f is differentiable at x = a if and only if te ratio f(a+) f(a) tends

More information

COMPUTATIONAL COMPARISON BETWEEN THE TAYLOR HOOD AND THE CONFORMING CROUZEIX RAVIART ELEMENT

COMPUTATIONAL COMPARISON BETWEEN THE TAYLOR HOOD AND THE CONFORMING CROUZEIX RAVIART ELEMENT Proceedings of ALGORITMY 5 pp. 369 379 COMPUTATIONAL COMPARISON BETWEEN E TAYLOR HOOD AND E CONFORMING OUZEIX RAVIART ELEMENT ROLF KRAHL AND EBERHARD BÄNSCH Abstract. Tis paper is concerned wit te computational

More information

On convergence of the immersed boundary method for elliptic interface problems

On convergence of the immersed boundary method for elliptic interface problems On convergence of te immersed boundary metod for elliptic interface problems Zilin Li January 26, 2012 Abstract Peskin s Immersed Boundary (IB) metod is one of te most popular numerical metods for many

More information

ETNA Kent State University

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

More information

On convexity of polynomial paths and generalized majorizations

On convexity of polynomial paths and generalized majorizations On convexity of polynomial pats and generalized majorizations Marija Dodig Centro de Estruturas Lineares e Combinatórias, CELC, Universidade de Lisboa, Av. Prof. Gama Pinto 2, 1649-003 Lisboa, Portugal

More information

A Weak Galerkin Method with an Over-Relaxed Stabilization for Low Regularity Elliptic Problems

A Weak Galerkin Method with an Over-Relaxed Stabilization for Low Regularity Elliptic Problems J Sci Comput (07 7:95 8 DOI 0.007/s095-06-096-4 A Weak Galerkin Metod wit an Over-Relaxed Stabilization for Low Regularity Elliptic Problems Lunji Song, Kaifang Liu San Zao Received: April 06 / Revised:

More information

Poisson Equation in Sobolev Spaces

Poisson Equation in Sobolev Spaces Poisson Equation in Sobolev Spaces OcMountain Dayligt Time. 6, 011 Today we discuss te Poisson equation in Sobolev spaces. It s existence, uniqueness, and regularity. Weak Solution. u = f in, u = g on

More information

A Hybrid Mixed Discontinuous Galerkin Finite Element Method for Convection-Diffusion Problems

A Hybrid Mixed Discontinuous Galerkin Finite Element Method for Convection-Diffusion Problems A Hybrid Mixed Discontinuous Galerkin Finite Element Metod for Convection-Diffusion Problems Herbert Egger Joacim Scöberl We propose and analyse a new finite element metod for convection diffusion problems

More information

MIXED DISCONTINUOUS GALERKIN APPROXIMATION OF THE MAXWELL OPERATOR. SIAM J. Numer. Anal., Vol. 42 (2004), pp

MIXED DISCONTINUOUS GALERKIN APPROXIMATION OF THE MAXWELL OPERATOR. SIAM J. Numer. Anal., Vol. 42 (2004), pp MIXED DISCONTINUOUS GALERIN APPROXIMATION OF THE MAXWELL OPERATOR PAUL HOUSTON, ILARIA PERUGIA, AND DOMINI SCHÖTZAU SIAM J. Numer. Anal., Vol. 4 (004), pp. 434 459 Abstract. We introduce and analyze a

More information

A SADDLE POINT LEAST SQUARES APPROACH TO MIXED METHODS

A SADDLE POINT LEAST SQUARES APPROACH TO MIXED METHODS A SADDLE POINT LEAST SQUARES APPROACH TO MIXED METHODS CONSTANTIN BACUTA AND KLAJDI QIRKO Abstract. We investigate new PDE discretization approaces for solving variational formulations wit different types

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

Polynomial Interpolation

Polynomial Interpolation Capter 4 Polynomial Interpolation In tis capter, we consider te important problem of approximating a function f(x, wose values at a set of distinct points x, x, x 2,,x n are known, by a polynomial P (x

More information

AN ANALYSIS OF THE EMBEDDED DISCONTINUOUS GALERKIN METHOD FOR SECOND ORDER ELLIPTIC PROBLEMS

AN ANALYSIS OF THE EMBEDDED DISCONTINUOUS GALERKIN METHOD FOR SECOND ORDER ELLIPTIC PROBLEMS AN ANALYSIS OF THE EMBEDDED DISCONTINUOUS GALERKIN METHOD FOR SECOND ORDER ELLIPTIC PROBLEMS BERNARDO COCKBURN, JOHNNY GUZMÁN, SEE-CHEW SOON, AND HENRYK K. STOLARSKI Abstract. Te embedded discontinuous

More information

A CLASS OF EVEN DEGREE SPLINES OBTAINED THROUGH A MINIMUM CONDITION

A CLASS OF EVEN DEGREE SPLINES OBTAINED THROUGH A MINIMUM CONDITION STUDIA UNIV. BABEŞ BOLYAI, MATHEMATICA, Volume XLVIII, Number 3, September 2003 A CLASS OF EVEN DEGREE SPLINES OBTAINED THROUGH A MINIMUM CONDITION GH. MICULA, E. SANTI, AND M. G. CIMORONI Dedicated to

More information

A New Class of Zienkiewicz-Type Nonconforming Element in Any Dimensions

A New Class of Zienkiewicz-Type Nonconforming Element in Any Dimensions Numerisce Matematik manuscript No. will be inserted by te editor A New Class of Zienkiewicz-Type Nonconforming Element in Any Dimensions Wang Ming 1, Zong-ci Si 2, Jincao Xu1,3 1 LMAM, Scool of Matematical

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] 28 Apr 2017

arxiv: v1 [math.na] 28 Apr 2017 THE SCOTT-VOGELIUS FINITE ELEMENTS REVISITED JOHNNY GUZMÁN AND L RIDGWAY SCOTT arxiv:170500020v1 [matna] 28 Apr 2017 Abstract We prove tat te Scott-Vogelius finite elements are inf-sup stable on sape-regular

More information

c 2004 Society for Industrial and Applied Mathematics

c 2004 Society for Industrial and Applied Mathematics SIAM J NUMER ANAL Vol 4, No, pp 86 84 c 004 Society for Industrial and Applied Matematics LEAST-SQUARES METHODS FOR LINEAR ELASTICITY ZHIQIANG CAI AND GERHARD STARKE Abstract Tis paper develops least-squares

More information

Some Applications of Fractional Step Runge-Kutta Methods

Some Applications of Fractional Step Runge-Kutta Methods Some Applications of Fractional Step Runge-Kutta Metods JORGE, J.C., PORTERO, L. Dpto. de Matematica e Informatica Universidad Publica de Navarra Campus Arrosadia, s/n 3006 Pamplona Navarra SPAIN Abstract:

More information

An approximation method using approximate approximations

An approximation method using approximate approximations Applicable Analysis: An International Journal Vol. 00, No. 00, September 2005, 1 13 An approximation metod using approximate approximations FRANK MÜLLER and WERNER VARNHORN, University of Kassel, Germany,

More information

Department of Mathematical Sciences University of South Carolina Aiken Aiken, SC 29801

Department of Mathematical Sciences University of South Carolina Aiken Aiken, SC 29801 RESEARCH SUMMARY AND PERSPECTIVES KOFFI B. FADIMBA Department of Matematical Sciences University of Sout Carolina Aiken Aiken, SC 29801 Email: KoffiF@usca.edu 1. Introduction My researc program as focused

More information

Analysis of A Continuous Finite Element Method for H(curl, div)-elliptic Interface Problem

Analysis of A Continuous Finite Element Method for H(curl, div)-elliptic Interface Problem Analysis of A Continuous inite Element Metod for Hcurl, div)-elliptic Interface Problem Huoyuan Duan, Ping Lin, and Roger C. E. Tan Abstract In tis paper, we develop a continuous finite element metod for

More information

ch (for some fixed positive number c) reaching c

ch (for some fixed positive number c) reaching c GSTF Journal of Matematics Statistics and Operations Researc (JMSOR) Vol. No. September 05 DOI 0.60/s4086-05-000-z Nonlinear Piecewise-defined Difference Equations wit Reciprocal and Cubic Terms Ramadan

More information

5 Ordinary Differential Equations: Finite Difference Methods for Boundary Problems

5 Ordinary Differential Equations: Finite Difference Methods for Boundary Problems 5 Ordinary Differential Equations: Finite Difference Metods for Boundary Problems Read sections 10.1, 10.2, 10.4 Review questions 10.1 10.4, 10.8 10.9, 10.13 5.1 Introduction In te previous capters we

More information

Consider a function f we ll specify which assumptions we need to make about it in a minute. Let us reformulate the integral. 1 f(x) dx.

Consider a function f we ll specify which assumptions we need to make about it in a minute. Let us reformulate the integral. 1 f(x) dx. Capter 2 Integrals as sums and derivatives as differences We now switc to te simplest metods for integrating or differentiating a function from its function samples. A careful study of Taylor expansions

More information

Journal of Computational and Applied Mathematics

Journal of Computational and Applied Mathematics Journal of Computational and Applied Matematics 94 (6) 75 96 Contents lists available at ScienceDirect Journal of Computational and Applied Matematics journal omepage: www.elsevier.com/locate/cam Smootness-Increasing

More information

Parameter Fitted Scheme for Singularly Perturbed Delay Differential Equations

Parameter Fitted Scheme for Singularly Perturbed Delay Differential Equations International Journal of Applied Science and Engineering 2013. 11, 4: 361-373 Parameter Fitted Sceme for Singularly Perturbed Delay Differential Equations Awoke Andargiea* and Y. N. Reddyb a b Department

More information

Volume 29, Issue 3. Existence of competitive equilibrium in economies with multi-member households

Volume 29, Issue 3. Existence of competitive equilibrium in economies with multi-member households Volume 29, Issue 3 Existence of competitive equilibrium in economies wit multi-member ouseolds Noriisa Sato Graduate Scool of Economics, Waseda University Abstract Tis paper focuses on te existence of

More information

Blanca Bujanda, Juan Carlos Jorge NEW EFFICIENT TIME INTEGRATORS FOR NON-LINEAR PARABOLIC PROBLEMS

Blanca Bujanda, Juan Carlos Jorge NEW EFFICIENT TIME INTEGRATORS FOR NON-LINEAR PARABOLIC PROBLEMS Opuscula Matematica Vol. 26 No. 3 26 Blanca Bujanda, Juan Carlos Jorge NEW EFFICIENT TIME INTEGRATORS FOR NON-LINEAR PARABOLIC PROBLEMS Abstract. In tis work a new numerical metod is constructed for time-integrating

More information

Parallel algorithm for convection diffusion system based on least squares procedure

Parallel algorithm for convection diffusion system based on least squares procedure Zang et al. SpringerPlus (26 5:69 DOI.86/s464-6-3333-8 RESEARCH Parallel algoritm for convection diffusion system based on least squares procedure Open Access Jiansong Zang *, Hui Guo 2, Hongfei Fu 3 and

More information

Superconvergence of energy-conserving discontinuous Galerkin methods for. linear hyperbolic equations. Abstract

Superconvergence of energy-conserving discontinuous Galerkin methods for. linear hyperbolic equations. Abstract Superconvergence of energy-conserving discontinuous Galerkin metods for linear yperbolic equations Yong Liu, Ci-Wang Su and Mengping Zang 3 Abstract In tis paper, we study superconvergence properties of

More information

A THREE-LEVEL BDDC ALGORITHM FOR SADDLE POINT PROBLEMS

A THREE-LEVEL BDDC ALGORITHM FOR SADDLE POINT PROBLEMS A TREE-LEVEL BDDC ALGORITM FOR SADDLE POINT PROBLEMS XUEMIN TU Abstract BDDC algoritms ave previously been extended to te saddle point problems arising from mixed formulations of elliptic and incompressible

More information

Math 312 Lecture Notes Modeling

Math 312 Lecture Notes Modeling Mat 3 Lecture Notes Modeling Warren Weckesser Department of Matematics Colgate University 5 7 January 006 Classifying Matematical Models An Example We consider te following scenario. During a storm, a

More information

A SPLITTING LEAST-SQUARES MIXED FINITE ELEMENT METHOD FOR ELLIPTIC OPTIMAL CONTROL PROBLEMS

A SPLITTING LEAST-SQUARES MIXED FINITE ELEMENT METHOD FOR ELLIPTIC OPTIMAL CONTROL PROBLEMS INTERNATIONAL JOURNAL OF NUMERICAL ANALSIS AND MODELING Volume 3, Number 4, Pages 6 626 c 26 Institute for Scientific Computing and Information A SPLITTING LEAST-SQUARES MIED FINITE ELEMENT METHOD FOR

More information

The Convergence of a Central-Difference Discretization of Rudin-Osher-Fatemi Model for Image Denoising

The Convergence of a Central-Difference Discretization of Rudin-Osher-Fatemi Model for Image Denoising Te Convergence of a Central-Difference Discretization of Rudin-Oser-Fatemi Model for Image Denoising Ming-Jun Lai 1, Bradley Lucier 2, and Jingyue Wang 3 1 University of Georgia, Atens GA 30602, USA mjlai@mat.uga.edu

More information

Robust approximation error estimates and multigrid solvers for isogeometric multi-patch discretizations

Robust approximation error estimates and multigrid solvers for isogeometric multi-patch discretizations www.oeaw.ac.at Robust approximation error estimates and multigrid solvers for isogeometric multi-patc discretizations S. Takacs RICAM-Report 2017-32 www.ricam.oeaw.ac.at Robust approximation error estimates

More information

computation, it is appealing to keep te global iterations to a small number. In 1988, Kuznetsov [14] proposed a one-iteration overlapping Scwarz algor

computation, it is appealing to keep te global iterations to a small number. In 1988, Kuznetsov [14] proposed a one-iteration overlapping Scwarz algor Stable, Gloablly Non-iterative, Non-overlapping Domain Decomposition Parallel Solvers for Parabolic Problems Λ Yu Zuang y Xian-He Sun z Abstract In tis paper, we report a class of stabilized explicit-implicit

More information

Generic maximum nullity of a graph

Generic maximum nullity of a graph Generic maximum nullity of a grap Leslie Hogben Bryan Sader Marc 5, 2008 Abstract For a grap G of order n, te maximum nullity of G is defined to be te largest possible nullity over all real symmetric n

More information

Solving Continuous Linear Least-Squares Problems by Iterated Projection

Solving Continuous Linear Least-Squares Problems by Iterated Projection Solving Continuous Linear Least-Squares Problems by Iterated Projection by Ral Juengling Department o Computer Science, Portland State University PO Box 75 Portland, OR 977 USA Email: juenglin@cs.pdx.edu

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

lecture 26: Richardson extrapolation

lecture 26: Richardson extrapolation 43 lecture 26: Ricardson extrapolation 35 Ricardson extrapolation, Romberg integration Trougout numerical analysis, one encounters procedures tat apply some simple approximation (eg, linear interpolation)

More information

NUMERICAL DIFFERENTIATION. James T. Smith San Francisco State University. In calculus classes, you compute derivatives algebraically: for example,

NUMERICAL DIFFERENTIATION. James T. Smith San Francisco State University. In calculus classes, you compute derivatives algebraically: for example, NUMERICAL DIFFERENTIATION James T Smit San Francisco State University In calculus classes, you compute derivatives algebraically: for example, f( x) = x + x f ( x) = x x Tis tecnique requires your knowing

More information

Variational Localizations of the Dual Weighted Residual Estimator

Variational Localizations of the Dual Weighted Residual Estimator Publised in Journal for Computational and Applied Matematics, pp. 192-208, 2015 Variational Localizations of te Dual Weigted Residual Estimator Tomas Ricter Tomas Wick Te dual weigted residual metod (DWR)

More information

THE STURM-LIOUVILLE-TRANSFORMATION FOR THE SOLUTION OF VECTOR PARTIAL DIFFERENTIAL EQUATIONS. L. Trautmann, R. Rabenstein

THE STURM-LIOUVILLE-TRANSFORMATION FOR THE SOLUTION OF VECTOR PARTIAL DIFFERENTIAL EQUATIONS. L. Trautmann, R. Rabenstein Worksop on Transforms and Filter Banks (WTFB),Brandenburg, Germany, Marc 999 THE STURM-LIOUVILLE-TRANSFORMATION FOR THE SOLUTION OF VECTOR PARTIAL DIFFERENTIAL EQUATIONS L. Trautmann, R. Rabenstein Lerstul

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

MA455 Manifolds Solutions 1 May 2008

MA455 Manifolds Solutions 1 May 2008 MA455 Manifolds Solutions 1 May 2008 1. (i) Given real numbers a < b, find a diffeomorpism (a, b) R. Solution: For example first map (a, b) to (0, π/2) and ten map (0, π/2) diffeomorpically to R using

More information

PARTITION OF UNITY FOR THE STOKES PROBLEM ON NONMATCHING GRIDS

PARTITION OF UNITY FOR THE STOKES PROBLEM ON NONMATCHING GRIDS PARTITION OF UNITY FOR THE STOES PROBLEM ON NONMATCHING GRIDS CONSTANTIN BACUTA AND JINCHAO XU Abstract. We consider the Stokes Problem on a plane polygonal domain Ω R 2. We propose a finite element method

More information

Efficient algorithms for for clone items detection

Efficient algorithms for for clone items detection Efficient algoritms for for clone items detection Raoul Medina, Caroline Noyer, and Olivier Raynaud Raoul Medina, Caroline Noyer and Olivier Raynaud LIMOS - Université Blaise Pascal, Campus universitaire

More information

232 Calculus and Structures

232 Calculus and Structures 3 Calculus and Structures CHAPTER 17 JUSTIFICATION OF THE AREA AND SLOPE METHODS FOR EVALUATING BEAMS Calculus and Structures 33 Copyrigt Capter 17 JUSTIFICATION OF THE AREA AND SLOPE METHODS 17.1 THE

More information

ROBUST MULTISCALE ITERATIVE SOLVERS FOR NONLINEAR FLOWS IN HIGHLY HETEROGENEOUS MEDIA

ROBUST MULTISCALE ITERATIVE SOLVERS FOR NONLINEAR FLOWS IN HIGHLY HETEROGENEOUS MEDIA ROBUST MULTISCALE ITERATIVE SOLVERS FOR NONLINEAR FLOWS IN HIGHLY HETEROGENEOUS MEDIA Y. EFENDIEV, J. GALVIS, S. KI KANG, AND R.D. LAZAROV Abstract. In tis paper, we study robust iterative solvers for

More information

POLYNOMIAL AND SPLINE ESTIMATORS OF THE DISTRIBUTION FUNCTION WITH PRESCRIBED ACCURACY

POLYNOMIAL AND SPLINE ESTIMATORS OF THE DISTRIBUTION FUNCTION WITH PRESCRIBED ACCURACY APPLICATIONES MATHEMATICAE 36, (29), pp. 2 Zbigniew Ciesielski (Sopot) Ryszard Zieliński (Warszawa) POLYNOMIAL AND SPLINE ESTIMATORS OF THE DISTRIBUTION FUNCTION WITH PRESCRIBED ACCURACY Abstract. Dvoretzky

More information

Adaptive Finite Element Method

Adaptive Finite Element Method 39 Capter 3 Adaptive inite Element Metod 31 Introduction As already pointed out in capter 2, singularities occur in interface problems Wen discretizing te problem (221) wit inite Elements, te singularities

More information

THE DISCRETE PLATEAU PROBLEM: CONVERGENCE RESULTS

THE DISCRETE PLATEAU PROBLEM: CONVERGENCE RESULTS MATHEMATICS OF COMPUTATION Volume 00, Number 0, Pages 000 000 S 0025-5718XX0000-0 THE DISCRETE PLATEAU PROBLEM: CONVERGENCE RESULTS GERHARD DZIUK AND JOHN E. HUTCHINSON Abstract. We solve te problem of

More information

A method of Lagrange Galerkin of second order in time. Une méthode de Lagrange Galerkin d ordre deux en temps

A method of Lagrange Galerkin of second order in time. Une méthode de Lagrange Galerkin d ordre deux en temps A metod of Lagrange Galerkin of second order in time Une métode de Lagrange Galerkin d ordre deux en temps Jocelyn Étienne a a DAMTP, University of Cambridge, Wilberforce Road, Cambridge CB3 0WA, Great-Britain.

More information

FINITE ELEMENT DUAL SINGULAR FUNCTION METHODS FOR HELMHOLTZ AND HEAT EQUATIONS

FINITE ELEMENT DUAL SINGULAR FUNCTION METHODS FOR HELMHOLTZ AND HEAT EQUATIONS J. KSIAM Vol.22, No.2, 101 113, 2018 ttp://dx.doi.org/10.12941/jksiam.2018.22.101 FINITE ELEMENT DUAL SINGULAR FUNCTION METHODS FOR HELMHOLTZ AND HEAT EQUATIONS DEOK-KYU JANG AND JAE-HONG PYO DEPARTMENT

More information

A Mixed-Hybrid-Discontinuous Galerkin Finite Element Method for Convection-Diffusion Problems

A Mixed-Hybrid-Discontinuous Galerkin Finite Element Method for Convection-Diffusion Problems A Mixed-Hybrid-Discontinuous Galerkin Finite Element Metod for Convection-Diffusion Problems Herbert Egger Joacim Scöberl We propose and analyse a new finite element metod for convection diffusion problems

More information

arxiv: v1 [math.na] 3 Nov 2011

arxiv: v1 [math.na] 3 Nov 2011 arxiv:.983v [mat.na] 3 Nov 2 A Finite Difference Gost-cell Multigrid approac for Poisson Equation wit mixed Boundary Conditions in Arbitrary Domain Armando Coco, Giovanni Russo November 7, 2 Abstract In

More information

A = h w (1) Error Analysis Physics 141

A = h w (1) Error Analysis Physics 141 Introduction In all brances of pysical science and engineering one deals constantly wit numbers wic results more or less directly from experimental observations. Experimental observations always ave inaccuracies.

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

4. The slope of the line 2x 7y = 8 is (a) 2/7 (b) 7/2 (c) 2 (d) 2/7 (e) None of these.

4. The slope of the line 2x 7y = 8 is (a) 2/7 (b) 7/2 (c) 2 (d) 2/7 (e) None of these. Mat 11. Test Form N Fall 016 Name. Instructions. Te first eleven problems are wort points eac. Te last six problems are wort 5 points eac. For te last six problems, you must use relevant metods of algebra

More information

CONVERGENCE ANALYSIS OF FINITE ELEMENT SOLUTION OF ONE-DIMENSIONAL SINGULARLY PERTURBED DIFFERENTIAL EQUATIONS ON EQUIDISTRIBUTING MESHES

CONVERGENCE ANALYSIS OF FINITE ELEMENT SOLUTION OF ONE-DIMENSIONAL SINGULARLY PERTURBED DIFFERENTIAL EQUATIONS ON EQUIDISTRIBUTING MESHES INTERNATIONAL JOURNAL OF NUMERICAL ANALYSIS AND MODELING Volume, Number, Pages 57 74 c 5 Institute for Scientific Computing and Information CONVERGENCE ANALYSIS OF FINITE ELEMENT SOLUTION OF ONE-DIMENSIONAL

More information

Controllability of a one-dimensional fractional heat equation: theoretical and numerical aspects

Controllability of a one-dimensional fractional heat equation: theoretical and numerical aspects Controllability of a one-dimensional fractional eat equation: teoretical and numerical aspects Umberto Biccari, Víctor Hernández-Santamaría To cite tis version: Umberto Biccari, Víctor Hernández-Santamaría.

More information

MATH745 Fall MATH745 Fall

MATH745 Fall MATH745 Fall MATH745 Fall 5 MATH745 Fall 5 INTRODUCTION WELCOME TO MATH 745 TOPICS IN NUMERICAL ANALYSIS Instructor: Dr Bartosz Protas Department of Matematics & Statistics Email: bprotas@mcmasterca Office HH 36, Ext

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

Jian-Guo Liu 1 and Chi-Wang Shu 2

Jian-Guo Liu 1 and Chi-Wang Shu 2 Journal of Computational Pysics 60, 577 596 (000) doi:0.006/jcp.000.6475, available online at ttp://www.idealibrary.com on Jian-Guo Liu and Ci-Wang Su Institute for Pysical Science and Tecnology and Department

More information

ELA

ELA Electronic Journal of Linear Algebra ISSN 181-81 A publication of te International Linear Algebra Society ttp://mat.tecnion.ac.il/iic/ela RANK AND INERTIA OF SUBMATRICES OF THE MOORE PENROSE INVERSE OF

More information

Packing polynomials on multidimensional integer sectors

Packing polynomials on multidimensional integer sectors Pacing polynomials on multidimensional integer sectors Luis B Morales IIMAS, Universidad Nacional Autónoma de México, Ciudad de México, 04510, México lbm@unammx Submitted: Jun 3, 015; Accepted: Sep 8,

More information

Numerische Mathematik

Numerische Mathematik Numer. Math. (1996) 75: 59 77 Numerische Mathematik c Springer-Verlag 1996 Electronic Edition A preconditioner for the h-p version of the finite element method in two dimensions Benqi Guo 1, and Weiming

More information

Derivatives of Exponentials

Derivatives of Exponentials mat 0 more on derivatives: day 0 Derivatives of Eponentials Recall tat DEFINITION... An eponential function as te form f () =a, were te base is a real number a > 0. Te domain of an eponential function

More information

OSCILLATION OF SOLUTIONS TO NON-LINEAR DIFFERENCE EQUATIONS WITH SEVERAL ADVANCED ARGUMENTS. Sandra Pinelas and Julio G. Dix

OSCILLATION OF SOLUTIONS TO NON-LINEAR DIFFERENCE EQUATIONS WITH SEVERAL ADVANCED ARGUMENTS. Sandra Pinelas and Julio G. Dix Opuscula Mat. 37, no. 6 (2017), 887 898 ttp://dx.doi.org/10.7494/opmat.2017.37.6.887 Opuscula Matematica OSCILLATION OF SOLUTIONS TO NON-LINEAR DIFFERENCE EQUATIONS WITH SEVERAL ADVANCED ARGUMENTS Sandra

More information

arxiv: v1 [math.na] 20 Jul 2009

arxiv: v1 [math.na] 20 Jul 2009 STABILITY OF LAGRANGE ELEMENTS FOR THE MIXED LAPLACIAN DOUGLAS N. ARNOLD AND MARIE E. ROGNES arxiv:0907.3438v1 [mat.na] 20 Jul 2009 Abstract. Te stability properties of simple element coices for te mixed

More information

arxiv: v1 [math.dg] 4 Feb 2015

arxiv: v1 [math.dg] 4 Feb 2015 CENTROID OF TRIANGLES ASSOCIATED WITH A CURVE arxiv:1502.01205v1 [mat.dg] 4 Feb 2015 Dong-Soo Kim and Dong Seo Kim Abstract. Arcimedes sowed tat te area between a parabola and any cord AB on te parabola

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