Geometric Multigrid Methods

Size: px
Start display at page:

Download "Geometric Multigrid Methods"

Transcription

1 Geometric Multigrid Methods Susanne C. Brenner Department of Mathematics and Center for Computation & Technology Louisiana State University IMA Tutorial: Fast Solution Techniques November 28, 2010

2 Ideas Outline Set-Up Multigrid Algorithms Smoothing and Approximation Convergence of W-Cycle Convergence of V-Cycle Multiplicative Theory Additive Theory Other Algorithms

3 General References 1 W. Hacbusch Multi-grid Methods and Applications, Springer-Verlag, J.H. Bramble Multigrid Methods, Longman Scientific & Technical, J.H. Bramble and X. Zhang The Analysis of Multigrid Methods, in Handboo of Numerical Analysis VII, North-Holland, U. Trottenberg, C. Oosterlee and A. Schüller Multigrid, Academic Press, 2001.

4 Let A be a SPD matrix. Suppose we solve Ideas (L) Ax = b by an iterative method (Jacobi, Gauss-Seidel, etc.).

5 Let A be a SPD matrix. Suppose we solve Ideas (L) Ax = b by an iterative method (Jacobi, Gauss-Seidel, etc.). After m iterations (starting with some initial guess), we obtain an approximate solution x m. Then the error e m = x x m satisfies the residual equation (RE) Ae m = r m where r m = b Ax m is the (computable) residual.

6 Let A be a SPD matrix. Suppose we solve Ideas (L) Ax = b by an iterative method (Jacobi, Gauss-Seidel, etc.). After m iterations (starting with some initial guess), we obtain an approximate solution x m. Then the error e m = x x m satisfies the residual equation (RE) Ae m = r m where r m = b Ax m is the (computable) residual. If we can solve (RE) exactly, then we can recover the exact solution of (L) by the relation (C) x = x m + (x x m ) = x m + e m

7 Ideas In reality, we will only solve (RE) approximately to obtain an approximation e m of e m. Then, hopefully, the correction (C ) x = x m + e m will give a better approximation of x.

8 Ideas In reality, we will only solve (RE) approximately to obtain an approximation e m of e m. Then, hopefully, the correction (C ) x = x m + e m will give a better approximation of x. In the context of finite element equations (FE h ) A h x h = f h there is a natural way to carry out this idea.

9 Ideas In reality, we will only solve (RE) approximately to obtain an approximation e m of e m. Then, hopefully, the correction (C ) x = x m + e m will give a better approximation of x. In the context of finite element equations (FE h ) A h x h = f h there is a natural way to carry out this idea. Smoothing Step Apply m iterations of a classical iterative method to obtain an approximation x m,h of x h and the corresponding residual equation e m,h = x h x m,h, (RE h ) r m,h = f h A hx m,h A h e m,h = r m,h

10 Ideas Correction Step Instead of solving (RE h ), we solve a related equation on a coarser grid T 2h (assuming that T h is obtained from T 2h by uniform refinement). (RE 2h ) A 2h e 2h = r 2h r 2h = projection of r h,m onto the coarse grid space A 2h = stiffness matrix for the coarse grid

11 Ideas Correction Step Instead of solving (RE h ), we solve a related equation on a coarser grid T 2h (assuming that T h is obtained from T 2h by uniform refinement). (RE 2h ) A 2h e 2h = r 2h r 2h = projection of r h,m onto the coarse grid space A 2h = stiffness matrix for the coarse grid We then use a transfer operator I h 2h to move e 2h to the fine grid T h and obtain the final output x m+1,h = x m,h + I h 2h e 2h This is nown as the two-grid algorithm.

12 Ideas Smoothing steps will damp out the highly oscillatory part of the error so that we can capture e h accurately on the coarser grid by the correction step. Together they produce a good approximate solution of (FE h ).

13 Ideas Smoothing steps will damp out the highly oscillatory part of the error so that we can capture e h accurately on the coarser grid by the correction step. Together they produce a good approximate solution of (FE h ). Moreover, it is cheaper to solve the coarse grid residual equation (RE 2h ).

14 Ideas Smoothing steps will damp out the highly oscillatory part of the error so that we can capture e h accurately on the coarser grid by the correction step. Together they produce a good approximate solution of (FE h ). Moreover, it is cheaper to solve the coarse grid residual equation (RE 2h ). Of course we do not have to solve (RE 2h ) exactly. Instead we can apply the same idea recursively to (RE 2h ). The resulting algorithm is a multigrid algorithm.

15 Set-Up Model Problem Find u H0 1 (Ω) such that a(u, v) = fv dx v H0(Ω) 1 Ω a(w, v) = w v dx Ω

16 Set-Up Model Problem Find u H0 1 (Ω) such that a(u, v) = fv dx v H0(Ω) 1 Ω a(w, v) = Ω w v dx Let T 0 be an initial triangulation of Ω and T ( 1) be obtained from T 1 by a refinement process. V ( 0) is the corresponding finite element space.

17 th Level Finite Element Problem a (u, v) = fv dx Ω Set-Up Find u V such that v V The bilinear form a (, ) is an approximation of the bilinear form a(, ) for the continuous problem. We can tae a (, ) to be a(, ) for conforming finite element methods. But in general a (, ) is a modification of a(, ) according to the choice of the finite element method.

18 th Level Finite Element Problem a (u, v) = fv dx Ω Set-Up Find u V such that v V It can be written as A u = φ where A : V V and φ V are defined by A w, v = a (w, v) v, w V φ, v = fv dx v V Ω

19 th Level Finite Element Problem a (u, v) = fv dx Ω Set-Up Find u V such that v V It can be written as A u = φ Two ey ingredients in defining multigrid algorithms. a good smoother for the equation A z = γ intergrid transfer operators to move functions between consecutive levels

20 Smoothing step for A z = γ (z V, γ V ) Set-Up (S) z new = z old + B 1 (γ A z old ) where B : V V is SPD, ρ(b 1 A ) 1 and B v, v h 2 v 2 L 2 (Ω) v V

21 Smoothing step for A z = γ (z V, γ V ) Set-Up (S) z new = z old + B 1 (γ A z old ) where B : V V is SPD, Example ρ(b 1 A ) 1 and B v, v h 2 v 2 L 2 (Ω) v V (Richardson relaxation scheme) V ( H 1 0 (Ω)) = P 1 Lagrange finite element space B w, v = λ p V w(p)v(p) V = the set of interior vertices of T λ = a (constant) damping factor

22 Intergrid Transfer Operators Set-Up The coarse-to-fine operator I 1 is a linear operator from V 1 to V. The fine-to-coarse operator I 1 : V V 1 is the transpose of I 1, i.e., I 1 α, v = α, I 1 v α V, v V 1

23 Intergrid Transfer Operators Set-Up The coarse-to-fine operator I 1 is a linear operator from V 1 to V. The fine-to-coarse operator I 1 : V V 1 is the transpose of I 1, i.e., Example I 1 α, v = α, I 1 v α V, v V 1 V ( H 1 0 (Ω)) = P 1 Lagrange finite element space V 0 V 1 I 1 = natural injection

24 Multigrid Algorithms V-Cycle Algorithm for A z = γ with initial guess z 0 Output = MG V (, γ, z 0, m)

25 Multigrid Algorithms V-Cycle Algorithm for A z = γ with initial guess z 0 Output = MG V (, γ, z 0, m) For = 0, we solve A 0 z = γ exactly to obtain MG V (0, γ, z 0, m) = A 1 0 γ

26 Multigrid Algorithms V-Cycle Algorithm for A z = γ with initial guess z 0 Output = MG V (, γ, z 0, m) For = 0, we solve A 0 z = γ exactly to obtain MG V (0, γ, z 0, m) = A 1 0 γ For 1, we compute the multigrid output recursively in 3 steps.

27 Multigrid Algorithms V-Cycle Algorithm for A z = γ with initial guess z 0 Output = MG V (, γ, z 0, m) For = 0, we solve A 0 z = γ exactly to obtain MG V (0, γ, z 0, m) = A 1 0 γ For 1, we compute the multigrid output recursively in 3 steps. Pre-smoothing Step For 1 m, compute z = z 1 + B 1 (γ A z 1 )

28 Multigrid Algorithms Correction Step Transfer the residual γ A z m V to the coarse grid using I 1 and solve the coarse-grid residual equation A 1 e 1 = I 1 (γ A z m ) by applying the ( 1) st level algorithm using 0 as the initial guess, i.e., we compute q = MG V ( 1, I 1 (γ A z m ), 0, m) as an approximation to e 1. Then we mae the correction z m+1 = z m + I 1 q

29 Multigrid Algorithms Correction Step Transfer the residual γ A z m V to the coarse grid using I 1 and solve the coarse-grid residual equation A 1 e 1 = I 1 (γ A z m ) by applying the ( 1) st level algorithm using 0 as the initial guess, i.e., we compute q = MG V ( 1, I 1 (γ A z m ), 0, m) as an approximation to e 1. Then we mae the correction z m+1 = z m + I 1 q Post-smoothing Step For m + 2 2m + 1, compute z = z 1 + B 1 (γ A z 1 )

30 Final Output Multigrid Algorithms MG V (, γ, z 0, m) = z 2m+1

31 Multigrid Algorithms Multigrid Algorithms for A z = ψ (z V, ψ V ) C 0 Interior Penalty Methods for Fourth Order Problems Final Output MG V (, γ, z 0, m) = z V-cycle Algorithm p = 1 2m+1 = 3 replacements = 2 = 1 = 0 scheduling Scheduling diagram Diagram for the of the V-cycle V-Cycle algorithm Algorithm Susanne C. Brenner AMIC 2010/6th EASIAM Conference

32 Multigrid Algorithms W-Cycle Algorithm for A z = γ with initial guess z 0 Output = MG W (, γ, z 0, m)

33 Multigrid Algorithms W-Cycle Algorithm for A z = γ with initial guess z 0 Output = MG W (, γ, z 0, m) Correction Step (apply the coarse grid algorithm twice) q = MG W ( 1, I 1 (γ A z m ), 0, m) q = MG W ( 1, I 1 (γ A z m ), q, m)

34 Multigrid Algorithms W-Cycle Algorithm for A z = γ with initial guess z 0 Output = MG W (, γ, z 0, m) C 0 Interior Penalty Methods for Fourth Order Problems Correction Step Multigrid Algorithms (apply the coarse grid algorithm twice) Multigrid Algorithms for A z = ψ (z V, ψ V ) q = MG W ( 1, I 1 (γ A z m ), 0, m) W-cycle Algorithm p = 2 q = MG W ( 1, I 1 (γ A z m ), q, m) = 3 ents = 2 = 1 = 0 scheduling diagram for the W-cycle algorithm Scheduling Diagram of the W-Cycle Algorithm

35 Multigrid Algorithms Operation Count n = dimv (n 4 ) W = number of flops for the th level multigrid algorithm m = number of smoothing steps p = 1 or 2

36 Operation Count n = dimv (n 4 ) Multigrid Algorithms W = number of flops for the th level multigrid algorithm m = number of smoothing steps p = 1 or 2 W C mn + pw 1 C mn + p(c mn 1 ) + p 2 (C mn 2 ) + p 1 (C mn 1 ) + p W 0 C m4 + pc m4 1 + p 2 C m4 2 + p 1 (C m4) + p W 0 = C m4 ( 1 + p 4 + p p 1 ) p W 0 C m4 1 p/4 + p W 0 C 4 + p W 0 C n

37 Error Propagation Operators Multigrid Algorithms Let E : V V be the error propagation operator that maps the initial error z z 0 to the final error z MG V (, γ, z 0, m). We want to develop a recursive relation between E and E 1.

38 Error Propagation Operators Multigrid Algorithms Let E : V V be the error propagation operator that maps the initial error z z 0 to the final error z MG V (, γ, z 0, m). We want to develop a recursive relation between E and E 1. It follows from (S) and A z = γ that z z new = z z old B 1 (γ A z old ) = (Id B 1 A )(z z old ) where Id is the identity operator on V.

39 Error Propagation Operators Multigrid Algorithms Let E : V V be the error propagation operator that maps the initial error z z 0 to the final error z MG V (, γ, z 0, m). We want to develop a recursive relation between E and E 1. It follows from (S) and A z = γ that z z new = z z old B 1 (γ A z old ) = (Id B 1 A )(z z old ) where Id is the identity operator on V. Therefore the effect of one smoothing step is measured by the operator R = Id B 1 A

40 Multigrid Algorithms Let P 1 : V V 1 be the transpose of the coarse-to-fine operator I 1 with respect to the variational forms, i.e. a 1 (P 1 v, w) = a (v, I 1 w) v V, w V 1

41 Multigrid Algorithms Let P 1 : V V 1 be the transpose of the coarse-to-fine operator I 1 with respect to the variational forms, i.e. a 1 (P 1 v, w) = a (v, I 1 w) v V, w V 1 Recall the coarse grid residual equation A 1 e 1 = I 1 (γ A z m )

42 Multigrid Algorithms Let P 1 : V V 1 be the transpose of the coarse-to-fine operator I 1 with respect to the variational forms, i.e. a 1 (P 1 v, w) = a (v, I 1 w) v V, w V 1 Recall the coarse grid residual equation A 1 e 1 = I 1 (γ A z m ) a 1 (e 1, v) = A 1 e 1, v (for any v V ) = I 1 (γ A z m ), v = (γ A z m ), I 1 v = A (z z m ), I 1 v = a (z z m, I 1 v) = a 1(P 1 (z z m ), v)

43 Multigrid Algorithms Let P 1 : V V 1 be the transpose of the coarse-to-fine operator I 1 with respect to the variational forms, i.e. a 1 (P 1 v, w) = a (v, I 1 w) v V, w V 1 Recall the coarse grid residual equation A 1 e 1 = I 1 (γ A z m ) a 1 (e 1, v) = A 1 e 1, v (for any v V ) = I 1 (γ A z m ), v = (γ A z m ), I 1 v = A (z z m ), I 1 v = a (z z m, I 1 v) = a 1(P 1 (z z m ), v)

44 Multigrid Algorithms e 1 = P 1 (z z m )

45 Multigrid Algorithms e 1 = P 1 (z z m ) Recall q = MG V ( 1, I 1 (γ A z m ), 0, m) is the approximate solution of the coarse grid residual equation obtained by using the ( 1) st level V-cycle algorithm with initial guess 0.

46 Multigrid Algorithms e 1 = P 1 (z z m ) Recall q = MG V ( 1, I 1 (γ A z m ), 0, m) is the approximate solution of the coarse grid residual equation obtained by using the ( 1) st level V-cycle algorithm with initial guess 0. e 1 q = E 1 (e 1 0) = q = (Id 1 E 1 )e 1

47 Multigrid Algorithms e 1 = P 1 (z z m ) Recall q = MG V ( 1, I 1 (γ A z m ), 0, m) is the approximate solution of the coarse grid residual equation obtained by using the ( 1) st level V-cycle algorithm with initial guess 0. e 1 q = E 1 (e 1 0) = q = (Id 1 E 1 )e 1 z z m+1 = z (z m + I 1 q) = z z m I 1 (Id 1 E 1 )e 1 = z z m I 1 (Id 1 E 1 )P 1 (z z m ) = (Id I 1 P 1 + I 1 E 1P 1 )(z z m ) = (Id I 1 P 1 + I 1 E 1P 1 )R m (z z 0)

48 Multigrid Algorithms z MG V (, γ, z 0, m) = z z 2m+1 = R m (z z m+1) = R m (Id I 1 P 1 + I 1 E 1P 1 )R m (z z 0)

49 Multigrid Algorithms z MG V (, γ, z 0, m) = z z 2m+1 = R m (z z m+1) = R m (Id I 1 P 1 + I 1 E 1P 1 )R m (z z 0)

50 Multigrid Algorithms z MG V (, γ, z 0, m) = z z 2m+1 = R m (z z m+1) = R m (Id I 1 P 1 Recursive Relation for V-Cycle E = R m (Id I 1 P 1 E 0 = 0 + I 1 E 1P 1 )R m (z z 0) + I 1 E 1P 1 )R m

51 Multigrid Algorithms z MG V (, γ, z 0, m) = z z 2m+1 = R m (z z m+1) = R m (Id I 1 P 1 Recursive Relation for V-Cycle E = R m (Id I 1 P 1 E 0 = 0 Recursive Relation for W-Cycle E = R m (Id I 1 P 1 E 0 = 0 + I 1 E 1P 1 )R m (z z 0) + I 1 E 1P 1 )R m + I 1 E2 1P 1 )R m

52 Smoothing and Approximation It is clear from the recursive relation E = R m (Id I 1 P 1 that we need to understand the operators + I 1 Ep 1 P 1 )R m R m and Id I 1 P 1

53 Smoothing and Approximation It is clear from the recursive relation E = R m (Id I 1 P 1 that we need to understand the operators + I 1 Ep 1 P 1 )R m R m and Id I 1 P 1 The effect of R m is measured by the smoothing property while the effect of Id I 1 P 1 is measured by the approximation property. These properties involve certain mesh dependent norms.

54 Smoothing and Approximation It is clear from the recursive relation E = R m (Id I 1 P 1 that we need to understand the operators + I 1 Ep 1 P 1 )R m R m and Id I 1 P 1 The effect of R m is measured by the smoothing property while the effect of Id I 1 P 1 is measured by the approximation property. These properties involve certain mesh dependent norms. Let the inner product (, ) on V be defined by (v, w) = h 2 B v, w Then the operator B 1 A : V V is SPD with respect to (, ).

55 Mesh-Dependent Norms v t, = h t Smoothing and Approximation ((B 1 A ) t v, v) v V, t R

56 Mesh-Dependent Norms In particular v t, = h t v 0, = (v, v) = v 1, = h 1 = Smoothing and Approximation ((B 1 B (B 1 ((B 1 A ) t v, v) v V, t R h 2 B v, v v L2 (Ω) A )v, v) A )v, v = A v, v = a (v, v) = v a

57 Mesh-Dependent Norms In particular v t, = h t v 0, = (v, v) = v 1, = h 1 = Smoothing and Approximation ((B 1 B (B 1 ((B 1 A ) t v, v) v V, t R h 2 B v, v v L2 (Ω) A )v, v) A )v, v = A v, v = a (v, v) = v a ρ(b 1 A ) 1 = R v t, v t,

58 Mesh-Dependent Norms In particular v t, = h t v 0, = (v, v) = v 1, = h 1 = Smoothing and Approximation ((B 1 B (B 1 ((B 1 A ) t v, v) v V, t R h 2 B v, v v L2 (Ω) A )v, v) Generalized Cauchy-Schwarz Inequality A )v, v = A v, v = a (v, v) = v a a (v, w) v 1+t, v 1 t, t R

59 Duality Smoothing and Approximation v 1+t, = a (v, w) max w V \{0} w 1 t, v V, t R

60 Duality Smoothing and Approximation v 1+t, = a (v, w) max w V \{0} w 1 t, v V, t R Smoothing Property For 0 s t 2 and, m = 1, 2,..., R m v s, Cm (t s) 2 h s t v t, v V

61 Duality Smoothing and Approximation v 1+t, = a (v, w) max w V \{0} w 1 t, v V, t R Smoothing Property For 0 s t 2 and, m = 1, 2,..., The proof is based on R m v s, Cm (t s) 2 h s t v t, v V Spectral Theorem ρ(b 1 A ) 1 calculus

62 Approximation Property Smoothing and Approximation There exists α ( 1 2, 1] such that (Id I 1 P 1 )v 1 α, Ch 2α v 1+α, v V, = 1, 2,... (The index α is related to elliptic regularity.)

63 Approximation Property Smoothing and Approximation There exists α ( 1 2, 1] such that (Id I 1 P 1 )v 1 α, Ch 2α v 1+α, v V, = 1, 2,... (The index α is related to elliptic regularity.) The proof is based on elliptic regularity duality arguments relations between the mesh dependent norms s, and the Sobolev norms H s (Ω)

64 Smoothing and Approximation Example (convex Ω) V ( H0 1(Ω)) = Lagrange P 1 finite element space a (w, v) = w v dx = a(w, v) Ω V 0 V 1, I 1 : V 1 V is the natural injection B w, v = λ p V w(p)v(p) v V

65 Smoothing and Approximation Example (convex Ω) V ( H0 1(Ω)) = Lagrange P 1 finite element space a (w, v) = w v dx = a(w, v) Ω V 0 V 1, I 1 : V 1 V is the natural injection B w, v = λ p V w(p)v(p) v V v 0, = ( h 2 B ) 1/2 v, v = λh 2 v 2 (p) v L2 (Ω) v V p V v 1, = v a = v H 1 (Ω) v V

66 The operator P 1 Smoothing and Approximation : V V 1 satisfies a(p 1 v, w) = a(v, I 1 w) = a(v, w) v V, w V 1 a((id I 1 P 1 )v, w) = a(v P 1 v, w) = 0 v V, w V 1

67 The operator P 1 Smoothing and Approximation : V V 1 satisfies a(p 1 v, w) = a(v, I 1 w) = a(v, w) v V, w V 1 a((id I 1 P 1 )v, w) = a(v P 1 v, w) = 0 v V, w V 1 Duality Argument Let v V be arbitrary and ζ H0 1 (Ω) satisfy a(w, ζ) = w(id I 1 P 1 )v dx w H0(Ω) 1 Ω i.e., ζ is the solution of the boundary value problem ζ = (Id I 1 P 1 )v in Ω and ζ = 0 on Ω

68 Since Ω is convex, ζ H 2 (Ω) and Smoothing and Approximation ζ H 2 (Ω) C Ω (Id I 1 P 1 )v L2 (Ω)

69 Since Ω is convex, ζ H 2 (Ω) and Smoothing and Approximation ζ H 2 (Ω) C Ω (Id I 1 P 1 )v L2 (Ω) (Id I 1 P 1 )v 2 L 2 (Ω) = a((id I 1 P 1 )v, ζ) = a((id I 1 P 1 )v, ζ Π 1 ζ) (Id I 1 P 1 )v H 1 (Ω) ζ Π 1 ζ H 1 (Ω) (Id I 1 P 1 )v H 1 (Ω)(Ch ζ H 2 (Ω)) (Id I 1 P 1 )v H 1 (Ω)(Ch (Id I 1 P 1 )v L2 (Ω))

70 Since Ω is convex, ζ H 2 (Ω) and Smoothing and Approximation ζ H 2 (Ω) C Ω (Id I 1 P 1 )v L2 (Ω) (Id I 1 P 1 )v 2 L 2 (Ω) = a((id I 1 P 1 )v, ζ) = a((id I 1 P 1 )v, ζ Π 1 ζ) (Id I 1 P 1 )v H 1 (Ω) ζ Π 1 ζ H 1 (Ω) (Id I 1 P 1 )v H 1 (Ω)(Ch ζ H 2 (Ω)) (Id I 1 P 1 )v H 1 (Ω)(Ch (Id I 1 P 1 )v L2 (Ω)) (Id I 1 P 1 )v L2 (Ω) Ch (Id I 1 P 1 )v H 1 (Ω)

71 Since Ω is convex, ζ H 2 (Ω) and Smoothing and Approximation ζ H 2 (Ω) C Ω (Id I 1 P 1 )v L2 (Ω) (Id I 1 P 1 )v 2 L 2 (Ω) = a((id I 1 P 1 )v, ζ) = a((id I 1 P 1 )v, ζ Π 1 ζ) (Id I 1 P 1 )v H 1 (Ω) ζ Π 1 ζ H 1 (Ω) (Id I 1 P 1 )v H 1 (Ω)(Ch ζ H 2 (Ω)) (Id I 1 P 1 )v H 1 (Ω)(Ch (Id I 1 P 1 )v L2 (Ω)) (Id I 1 P 1 )v L2 (Ω) Ch (Id I 1 P 1 )v H 1 (Ω) (Id I 1 P 1 )v 0, (Id I 1 P 1 )v L2 (Ω) Ch (Id I 1 P 1 )v H 1 (Ω) = Ch (Id I 1 P 1 )v 1,

72 In particular Smoothing and Approximation (Id I 1 P 1 )v 0, Ch (Id I 1 P 1 )v 1, Ch v 1,

73 Smoothing and Approximation In particular (Id I 1 P 1 )v 0, Ch (Id I 1 P 1 )v 1, Ch v 1, Duality (Id I 1 P 1 )v 1, = max w V \{0} = max w V \{0} a(v, (Id I 1 P 1 )w) w 1, a(id I 1 P 1 )v, w) w 1, v 2, (Id I 1 max P 1 )w 0, Ch v 2, w V \{0} w 1,

74 Smoothing and Approximation In particular (Id I 1 P 1 )v 0, Ch (Id I 1 P 1 )v 1, Ch v 1, Duality (Id I 1 P 1 )v 1, = max w V \{0} = max w V \{0} a(v, (Id I 1 P 1 )w) w 1, a(id I 1 P 1 )v, w) w 1, v 2, (Id I 1 max P 1 )w 0, Ch v 2, w V \{0} w 1, Approximation Property with α = 1 (Id I 1 P 1 )v 0, Ch 2 v 2, v V

75 Two-Grid Analysis E TG W-Cycle Convergence = R m (Id I 1 P 1 )R m

76 Two-Grid Analysis E TG W-Cycle Convergence = R m (Id I 1 P 1 )R m E TG v 1, = R m (Id I 1 P 1 )R m v 1, Cm α 2 h α Cm α 2 h α Cm α 2 h α (Id I 1 P 1 )R m v 1 α, h 2α R m v 1+α, h 2α m α 2 h α v 1, = C m α v 1,

77 Two-Grid Analysis E TG W-Cycle Convergence = R m (Id I 1 P 1 )R m E TG v 1, = R m (Id I 1 P 1 )R m v 1, Cm α 2 h α Cm α 2 h α Cm α 2 h α (Id I 1 P 1 )R m v 1 α, h 2α R m v 1+α, h 2α m α 2 h α v 1, = C m α v 1, The convergence of the W-cycle algorithm can then be established by a perturbation argument under the condition I 1 v 1, C v 1, 1 v V 1, = 1, 2,... which implies by duality P 1 v 1, 1 C v 1, v V, = 1, 2,...

78 Suppose for some δ > 0 we have W-Cycle Convergence E 1 v 1, 1 δ v 1, 1 v V 1

79 Suppose for some δ > 0 we have W-Cycle Convergence E 1 v 1, 1 δ v 1, 1 v V 1 E v 1, = R m (Id I 1 P 1 + I 1 E2 1P 1 )R m v 1, R m (Id I 1 P 1 )v 1, + R m I 1 E2 1P 1 R m v 1, C m α v 1, + C E 1P 2 1 R m v 1, C m α v 1, + C δ 2 P 1 R m v 1, C m α v 1, + C 2 δ2 v 1, = (C m α + C 2 δ2 ) v 1,

80 Suppose for some δ > 0 we have W-Cycle Convergence E 1 v 1, 1 δ v 1, 1 v V 1 E v 1, = R m (Id I 1 P 1 + I 1 E2 1P 1 )R m v 1, R m (Id I 1 P 1 )v 1, + R m I 1 E2 1P 1 R m v 1, C m α v 1, + C E 1P 2 1 R m v 1, C m α v 1, + C δ 2 P 1 R m v 1, C m α v 1, + C 2 δ2 v 1, = (C m α + C 2 δ2 ) v 1, E v 1, δ v 1, v V provided ( ) (C m α + C 2 δ2 ) = δ

81 W-Cycle Convergence Solving ( ) we find ( ) δ = 1 1 4C 2 C m α /(2C 2 ) < 1 provided ( ) 4C 2 C m α < 1

82 W-Cycle Convergence Solving ( ) we find ( ) δ = 1 1 4C 2 C m α /(2C 2 ) < 1 provided ( ) 4C 2 C m α < 1 Therefore, by mathematical induction E v 1, δ v 1, for 1 and the W-cycle algorithm is a contraction under the condition ( ). Moreover δ C m α as m

83 W-Cycle Convergence Theorem The W-cycle algorithm is a contraction with contraction number independent of the grid levels, provided the number m of smoothing steps is greater than a number m that is also independent of the grid levels.

84 W-Cycle Convergence Theorem The W-cycle algorithm is a contraction with contraction number independent of the grid levels, provided the number m of smoothing steps is greater than a number m that is also independent of the grid levels. The convergence analysis of W-cycle is based on the wor of Ban and Dupont (originally for conforming methods). It is a robust approach that wors for problems without full elliptic regularity (α < 1) and also for nonconforming methods.

85 W-Cycle Convergence Theorem The W-cycle algorithm is a contraction with contraction number independent of the grid levels, provided the number m of smoothing steps is greater than a number m that is also independent of the grid levels. The convergence analysis of W-cycle is based on the wor of Ban and Dupont (originally for conforming methods). It is a robust approach that wors for problems without full elliptic regularity (α < 1) and also for nonconforming methods. References 1 R.E. Ban and T.F. Dupont An optimal order process for solving finite element equations, Math. Comp., B., Convergence of nonconforming multigrid methods without full elliptic regularity, Math. Comp., 1999.

86 W-Cycle Convergence Theorem The W-cycle algorithm is a contraction with contraction number independent of the grid levels, provided the number m of smoothing steps is greater than a number m that is also independent of the grid levels. The convergence analysis of W-cycle is based on the wor of Ban and Dupont (originally for conforming methods). It is a robust approach that wors for problems without full elliptic regularity (α < 1) and also for nonconforming methods. Remar For conforming finite element methods with nested finite element spaces, the W-cycle algorithm is a contraction for m = 1. This result can be deduced from the corresponding result for the V-cycle algorithm.

87 Model Problem V-Cycle Convergence Poisson problem on a polygonal domain discretized by a conforming Lagrange finite element method.

88 Model Problem V-Cycle Convergence Poisson problem on a polygonal domain discretized by a conforming Lagrange finite element method. With Full Elliptic Regularity (Ω convex) u H 2 (Ω) C Ω f L2 (Ω) 1983 Braess-Hacbusch z MG V (, γ, z 0, m) a C C + m z z 0 a for m, 1, where C is independent of m and. In particular, the V-cycle is a contraction with only one smoothing step.

89 V-Cycle Convergence Without Full Elliptic Regularity (Ω nonconvex) u H 1+α (Ω) C Ω f L2 (Ω) for 1 2 < α < 1

90 Without Full Elliptic Regularity for 1 2 < α < Bramble-Pascia V-Cycle Convergence (Ω nonconvex) u H 1+α (Ω) C Ω f L2 (Ω) 1988 Decer-Mandel-Parter ( 1 ) z MG V (, γ, z 0, 1) a 1 C (1 α)/α z z 0 a for 1

91 Without Full Elliptic Regularity for 1 2 < α < Bramble-Pascia V-Cycle Convergence (Ω nonconvex) u H 1+α (Ω) C Ω f L2 (Ω) 1988 Decer-Mandel-Parter ( 1 ) z MG V (, γ, z 0, 1) a 1 C (1 α)/α z z 0 a for Bramble-Pascia-Wang-Xu (no regularity assumption) z MG V (, γ, z 0, 1) a ( 1 1 ) z z 0 a for 1 C

92 1992 Zhang, Xu 1993 Bramble-Pascia There exists δ (0, 1) such that V-Cycle Convergence z MG V (, γ, z 0, m) a δ z z 0 a for m, 1. In particular, the V-cycle is a contraction with one smoothing step.

93 1992 Zhang, Xu 1993 Bramble-Pascia There exists δ (0, 1) such that V-Cycle Convergence z MG V (, γ, z 0, m) a δ z z 0 a for m, 1. In particular, the V-cycle is a contraction with one smoothing step. Braess-Hacbusch z MG V (, γ, z 0, m) a C C + m z z 0 a for m, 1, where C is independent of m and. In particular, the V-cycle is a contraction with only one smoothing step.

94 2002 B. z MG V (, γ, z 0, m) a V-Cycle Convergence C C + m α z z 0 a for m, 1, where C is independent of m and.

95 2002 B. z MG V (, γ, z 0, m) a V-Cycle Convergence C C + m α z z 0 a for m, 1, where C is independent of m and. This is a complete generalization of the Braess-Hacbusch result: z MG V (, γ, z 0, m) a C C + m z z 0 a for m, 1, where C is independent of m and. In particular, the V-cycle is a contraction with only one smoothing step.

96 Model Problem Multiplicative Theory P 1 Lagrange finite element method for the Poisson problem. T is generated from T 0 by uniform refinement. V ( H 1 0 (Ω)) is the P 1 Lagrange finite element space associated with T. V 0 V 1 I 1 : V 1 V is the natural injection. a (w, v) = w v dx = a(w, v) Ω

97 Recursive Relation Multiplicative Theory E = R m (Id I 1 P 1 E 0 = 0 + I 1 E 1P 1 )R m

98 Recursive Relation Multiplicative Theory E = R m (Id I 1 P 1 E 0 = 0 + I 1 E 1P 1 )R m Notation (j l) I l j : V j V l is the natural injection P j l : V l V j is the transpose of I l j with respect to the variational form, i.e., a(p j l v, w) = a(v, Il j w) v V l, w V j I j j = Id j = P j j

99 Multiplicative Theory Properties of I l j and P j l For j i l I l j = I l i I i j P j l = P j i P i l I i j = P i l Il j (in particular Id j = I j j = Pj l Il j ) P j i = P j l Il i (I l j Pj l )2 = I l j Pj l (Id l I l j P j l )2 = (Id l I l j P j l )

100 Multiplicative Theory Key Observation [ (Id I 1 P 1 ) + I 1 E 1P 1 ] = (Id I 1 P 1 ) + I 1 [ R m 1 (Id 1 I 1 2 P I 1 2 E 2P 2 ] 1 )Rm 1 P 1

101 Key Observation [ (Id I 1 P 1 ) + I 1 E 1P 1 ] = (Id I 1 P 1 ) + I 1 [ R m 1 (Id 1 I 1 2 P 2 = [ (Id I 1 P 1 ) + I 1 Rm 1 P 1 ] [(Id I 2 P 2 [(Id I 1 P 1 Multiplicative Theory 1 + I 1 2 E 2P 2 1 )Rm 1 + I 2 E 2P 2 ) ] ) + I 1 Rm 1 P 1 ] ] P 1

102 Key Observation [ (Id I 1 P 1 ) + I 1 E 1P 1 ] = (Id I 1 P 1 ) + I 1 [ R m 1 (Id 1 I 1 2 P 2 = [ (Id I 1 P 1 ) + I 1 Rm 1 P 1 ] [(Id I 2 P 2 Multiplicative Theory 1 + I 1 2 E 2P 2 1 )Rm 1 + I 2 E 2P 2 ) ] [(Id I 1 P 1 ) + I 1 Rm 1 P 1 = [ (Id I 1 P 1 ) + I 1 Rm 1 P 1 ] [(Id I 2 P 2 ) + I 2 Rm 2 P 2 ] [(Id I 3 P 3 ) + I 3 E 3P 3 ] [(Id I 2 P 2 ) + I 2 Rm 2 P 2 ] [(Id I 1 P 1 ) + I 1 Rm 1 P 1 ] ] ] P 1

103 Multiplicative Theory E = R m [ (Id I 1 P 1 ) + I 1 E 1P 1 ] R m = R m [ (Id I 1 P 1 ) + I 1 Rm 1 P 1 ] [(Id I1 P 1 ) + I1 ] Rm 1 P1 (Id I0 P 0 ) [ (Id I1 P 1 ) + I1 Rm 1 P 1 ] [(Id I 1 P 1 ) + I 1 ] Rm 1 P 1 R m

104 Multiplicative Theory E = R m [ (Id I 1 P 1 ) + I 1 E 1P 1 ] R m = R m [ (Id I 1 P 1 ) + I 1 Rm 1 P 1 ] [(Id I1 P 1 ) + I1 ] Rm 1 P1 (Id I0 P 0 ) [ (Id I1 P 1 ) + I1 Rm 1 P 1 ] [(Id I 1 P 1 ) + I 1 ] Rm 1 P 1 R m Notation For 1 j T j = def I j (Id j R m j )P j

105 Multiplicative Theory E = R m [ (Id I 1 P 1 ) + I 1 E 1P 1 ] R m = R m [ (Id I 1 P 1 ) + I 1 Rm 1 P 1 ] [(Id I1 P 1 ) + I1 ] Rm 1 P1 (Id I0 P 0 ) [ (Id I1 P 1 ) + I1 Rm 1 P 1 ] [(Id I 1 P 1 ) + I 1 ] Rm 1 P 1 R m Notation For 1 j In particular T j = def I j (Id j R m j )P j T = I (Id R m )P = Id R m = Rm = Id T

106 Multiplicative Theory E = R m [ (Id I 1 P 1 ) + I 1 E 1P 1 ] R m = R m [ (Id I 1 P 1 ) + I 1 Rm 1 P 1 ] [(Id I1 P 1 ) + I1 ] Rm 1 P1 (Id I0 P 0 ) [ (Id I1 P 1 ) + I1 Rm 1 P 1 ] [(Id I 1 P 1 ) + I 1 ] Rm 1 P 1 R m Notation For 1 j In particular T j = def I j (Id j R m j )P j T = I (Id R m )P = Id R m = Rm = Id T (Id I j P j ) + I j R m j P j = Id I j (Id j R m j )P j = Id T j

107 Multiplicative Theory E = R m [ (Id I 1 P 1 ) + I 1 E 1P 1 ] R m = R m [ (Id I 1 P 1 ) + I 1 Rm 1 P 1 ] [(Id I1 P 1 ) + I1 ] Rm 1 P1 (Id I0 P 0 ) [ (Id I1 P 1 ) + I1 Rm 1 P 1 ] [(Id I 1 P 1 ) + I 1 ] Rm 1 P 1 R m Notation For 1 j In particular T j = def I j (Id j R m j )P j T = I (Id R m )P = Id R m = Rm = Id T (Id I j P j ) + I j R m j P j = Id I j (Id j R m j )P j = Id T j T 0 = def I 0 P 0 = Id I 0 P 0 = Id T 0

108 Multiplicative Theory Multiplicative Expression for E E = (Id T )(Id T 1 )... (Id T 1 ) (Id T 0 )(Id T 1 )... (Id T 1 )(Id T )

109 Multiplicative Expression for E Multiplicative Theory E = (Id T )(Id T 1 )... (Id T 1 ) (Id T 0 )(Id T 1 )... (Id T 1 )(Id T ) Strengthened Cauchy-Schwarz Inequality For 0 j a(v j, v ) C2 ( j)/2 v j H 1 (Ω)h 1 v L2 (Ω) v j V j, v V

110 Multiplicative Expression for E Multiplicative Theory E = (Id T )(Id T 1 )... (Id T 1 ) (Id T 0 )(Id T 1 )... (Id T 1 )(Id T ) Strengthened Cauchy-Schwarz Inequality For 0 j a(v j, v ) C2 ( j)/2 v j H 1 (Ω)h 1 v L2 (Ω) v j V j, v V Standard Cauchy-Schwarz Inequality a(v j, v ) v j a v a = v H 1 (Ω) v H 1 (Ω) v j V j, v V which implies a(v j, v ) C v j H 1 (Ω)h 1 v L2 (Ω)

111 Theorem There exists δ (0, 1) such that Multiplicative Theory for m, 1. z MG V (, γ, z 0, m) a δ z z 0 a

112 Theorem There exists δ (0, 1) such that Multiplicative Theory for m, 1. z MG V (, γ, z 0, m) a δ z z 0 a Details can be found in the boo by Bramble and the survey article by Bramble and Zhang. Refinement of the multiplicative theory can be found in the paper by Xu and Ziatanov. Reference J. Xu and L. Ziatanov, The method of alternating projections and the method of subspace corrections in Hilbert space, J. Amer. Math. Soc., 2002.

113 Theorem There exists δ (0, 1) such that Multiplicative Theory for m, 1. z MG V (, γ, z 0, m) a δ z z 0 a Details can be found in the boo by Bramble and the survey article by Bramble and Zhang. Refinement of the multiplicative theory can be found in the paper by Xu and Ziatanov. Reference J. Xu and L. Ziatanov, The method of alternating projections and the method of subspace corrections in Hilbert space, J. Amer. Math. Soc., The multiplicative theory cannot be applied to nonconforming finite element methods in general since many of the algebraic relations are no longer valid. For example, (Id I l P l ) 2 (Id I l P l )

114 Recursive Relation E = R m (Id I 1 P 1 E 0 = 0 Additive Theory + I 1 E 1P 1 )R m

115 Recursive Relation E E = R m (Id I 1 P 1 E 0 = 0 Additive Theory + I 1 E 1P 1 )R m = R m (Id I 1 P 1 )R m + R m I 1 Rm 1 (Id 1 I 1 2 P I 1 2 E 2P 2 1 )Rm 1 P 1 = R m (Id I 1 P 1 )R m + R m I 1 Rm 1 (Id 1 I 1 2 P 2 1 )Rm 1 P 1 R m + R m I 1 Rm 1 I 1 2 Rm 2 (Id 2 I 2 3 P 3 2 )Rm 2 P 2 + R m 1 Rm 1 P 1 R m

116 Recursive Relation E E = R m (Id I 1 P 1 E 0 = 0 Additive Theory + I 1 E 1P 1 )R m = R m (Id I 1 P 1 )R m + R m I 1 Rm 1 (Id 1 I 1 2 P I 1 2 E 2P 2 1 )Rm 1 P 1 = R m (Id I 1 P 1 )R m + R m I 1 Rm 1 (Id 1 I 1 2 P 2 1 )Rm 1 P 1 R m + R m I 1 Rm 1 I 1 2 Rm 2 (Id 2 I 2 3 P 3 2 )Rm 2 P 2 + [ R m j (Id j I j 1 P j 1 ] P j = j=1 R m I 1 Rm j+1 Ij+1 j j )R m j R m 1 Rm 1 P 1 R m j+1 Rm j P 1 R m

117 Ideas Additive Theory The operator R m j (Id j I j 1 P j 1 j )R m j has already been analyzed in the two-grid analysis.

118 Ideas Additive Theory The operator R m j (Id j I j 1 P j 1 j )R m j has already been analyzed in the two-grid analysis. The ey is to analyze (for 0 j ) the multi-level operator T def,j = R m I 1 Rm j+1 Ij+1 j : V j V and its transpose with respect to the variational forms T def j, = P j j+1 Rm j P 1 R m : V V j

119 Ideas Additive Theory The operator R m j (Id j I j 1 P j 1 j )R m j has already been analyzed in the two-grid analysis. The ey is to analyze (for 0 j ) the multi-level operator T def,j = R m I 1 Rm j+1 Ij+1 j : V j V and its transpose with respect to the variational forms T def j, = P j j+1 Rm j P 1 R m : V V j We will need a strengthened Cauchy-Schwarz inequality with smoothing and estimates that compare the meshdependent norms on consecutive levels.

120 Ideas Additive Theory The operator R m j (Id j I j 1 P j 1 j )R m j has already been analyzed in the two-grid analysis. The ey is to analyze (for 0 j ) the multi-level operator T def,j = R m I 1 Rm j+1 Ij+1 j : V j V and its transpose with respect to the variational forms T def j, = P j j+1 Rm j P 1 R m : V V j We will need a strengthened Cauchy-Schwarz inequality with smoothing and estimates that compare the meshdependent norms on consecutive levels. We need to circumvent the fact that for nonconforming methods in general (Id I l P l )2 (Id I l Pl )

121 Additive Theory Strengthened Cauchy-Schwarz Inequality with Smoothing Let 0 j, l, v j V j and v l V l. a (T,j R m j v j, T,l R m l v l) C m α δ l j v j 1 α,j v l 1 α,l where C is a positive constant, 0 < δ < 1 and α ( 1 2, 1] is the index of elliptic regularity, provided the number of smoothing steps m is sufficiently large.

122 Additive Theory Strengthened Cauchy-Schwarz Inequality with Smoothing Let 0 j, l, v j V j and v l V l. a (T,j R m j v j, T,l R m l v l) C m α δ l j v j 1 α,j v l 1 α,l where C is a positive constant, 0 < δ < 1 and α ( 1 2, 1] is the index of elliptic regularity, provided the number of smoothing steps m is sufficiently large. A Nonconforming Estimate ( Id 1 P 1 I 1) v 1 α, 1 Ch α v 1, 1 v V 1 (This will allow us to handle (Id I l Pl )2 (Id I l P l ).)

123 Two-Level Estimates (0 < θ < 1) Additive Theory I 1 v 2 1, (1 + θ 2 ) v 2 1, 1 + Cθ 2 h 2α v 2 1+α, 1 v V 1 I 1 v 2 1 α, (1 + θ 2 ) v 2 1 α, 1 + Cθ 2 h 2α v 2 1, 1 v V 1 P 1 v 2 1 α, 1 (1 + θ 2 ) v 2 1 α, + Cθ 2 h 2α v 2 1, v V Important aspect: the constant C is independent of and θ.

124 Two-Level Estimates (0 < θ < 1) Additive Theory I 1 v 2 1, (1 + θ 2 ) v 2 1, 1 + Cθ 2 h 2α v 2 1+α, 1 v V 1 I 1 v 2 1 α, (1 + θ 2 ) v 2 1 α, 1 + Cθ 2 h 2α v 2 1, 1 v V 1 P 1 v 2 1 α, 1 (1 + θ 2 ) v 2 1 α, + Cθ 2 h 2α v 2 1, v V Important aspect: the constant C is independent of and θ. θ is a parameter that calibrates the meaning of high/low frequency. The freedom to choose different θ on different levels allows us to build multi-level estimates from these two-level estimates.

125 Additive Theory Theorem There exists a positive constant C independent of and m, such that z MG V (, γ, z 0, m) ah C m α z z a h provided that the number of smoothing steps m is larger than a number m which is independent of. In particular the V-cycle algorithm is a contraction with contraction number uniformly bounded away from 1 if m is sufficiently large.

126 Additive Theory Theorem There exists a positive constant C independent of and m, such that z MG V (, γ, z 0, m) ah C m α z z a h provided that the number of smoothing steps m is larger than a number m which is independent of. In particular the V-cycle algorithm is a contraction with contraction number uniformly bounded away from 1 if m is sufficiently large. This result holds for both conforming and nonconforming finite element methods.

127 Additive Theory Theorem There exists a positive constant C independent of and m, such that z MG V (, γ, z 0, m) ah C m α z z a h provided that the number of smoothing steps m is larger than a number m which is independent of. In particular the V-cycle algorithm is a contraction with contraction number uniformly bounded away from 1 if m is sufficiently large. This result holds for both conforming and nonconforming finite element methods. In the conforming case we can combine this with the result from the multiplicative theory to show that C z MG V (, γ, z 0, m) a C + m α z z a

128 References Additive Theory 1 B., Convergence of the multigrid V-cycle algorithm for second order boundary value problems without full elliptic regularity, Math. Comp., B., Convergence of nonconforming V-cycle and F-cycle multigrid algorithms for second order elliptic boundary value problems, Math. Comp., B., Smoothers, mesh dependent norms, interpolation and multigrid, Appl. Numer. Math., B. and L.-Y. Sung Multigrid algorithms for C 0 interior penalty methods, SIAM J. Numer. Anal., 2006.

129 Other Algorithms F-Cycle Algorithm for A z = γ with initial guess z 0 Output = MG F (, γ, z 0, m)

130 Other Algorithms F-Cycle Algorithm for A z = γ with initial guess z 0 Output = MG F (, γ, z 0, m) Correction Step (coarse grid algorithm followed by V-cycle) q = MG F ( 1, I 1 (γ A z m ), 0, m) q = MG V ( 1, I 1 (γ A z m ), q, m)

131 Other Algorithms F-Cycle Algorithm for A z = γ with initial guess z 0 Output = MG F (, γ, z 0, m) Correction Step (coarse grid algorithm followed by V-cycle) q = MG F ( 1, I 1 (γ A z m ), 0, m) q = MG V ( 1, I 1 (γ A z m ), q, m) = 3 acements = 2 = 1 = 0 scheduling diagram for the F-cycle algorithm

132 Other Algorithms Convergence of the F-cycle algorithm follows from the convergence of the V-cycle algorithm by a perturbation argument. The computational cost of the F-cycle algorithm is more than the cost of the V-cycle algorithm but less than that of the W-cycle algorithm. For nonconforming methods the F-cycle is more robust than the V-cycle (i.e., it requires a smaller number of smoothing steps) and its performance is almost identical with the performance of the W-cycle. Nonconforming F-cycle algorithms have been used extensively in CFD computations by Rannacher and Ture.

133 Variable V-Cycle Other Algorithms This is the V-cycle algorithm where the number of smoothing steps can vary from level to level.

134 Variable V-Cycle Other Algorithms This is the V-cycle algorithm where the number of smoothing steps can vary from level to level. Suppose we want to solve the finite element equation on level. Then m j, the number of smoothing steps for level j, is chosen according to the rule β 1 m j m j 1 β 2 m j for 0 j, where 1 < β 1 β 2.

135 Variable V-Cycle Other Algorithms This is the V-cycle algorithm where the number of smoothing steps can vary from level to level. Suppose we want to solve the finite element equation on level. Then m j, the number of smoothing steps for level j, is chosen according to the rule β 1 m j m j 1 β 2 m j for 0 j, where 1 < β 1 β 2. The variable V-cycle algorithm is mostly used as an optimal preconditioner.

136 Full Multigrid Other Algorithms The th level multigrid algorithm solves the equation A z = γ with an (arbitrary) initial guess z 0.

137 Full Multigrid Other Algorithms The th level multigrid algorithm solves the equation A z = γ with an (arbitrary) initial guess z 0. When we are solving the finite element equation u v dx = fv dx v V Ω the finite element solution u on different levels are related, because they are approximations of the same u. Ω

138 Full Multigrid Other Algorithms The th level multigrid algorithm solves the equation A z = γ with an (arbitrary) initial guess z 0. When we are solving the finite element equation u v dx = fv dx v V Ω the finite element solution u on different levels are related, because they are approximations of the same u. Therefore the initial guess for the th level multigrid algorithm should come from the solution on the ( 1) st level. Ω

139 Finite Element Equation Full Multigrid Algorithm For = 0, û 0 = A 1 0 φ 0 For 1, A u = φ φ, v = fv dx Ω Other Algorithms v V u 0 = I 1û 1 u l = MG(, φ, u l 1, m) for 1 l r û = u r

140 Other Algorithms Suppose the multigrid algorithm is uniformly convergent. For a sufficiently large r, the full multigrid algorithm, which is a nested iteration of the th level multigrid algorithms, will produce an approximate solution of the continuous problem that is accurate to the same order as the exact solution of the finite element equation. Moreover the computational cost of the full multigrid algorithm remains proportional to the number of unnowns.

Multigrid Methods for Saddle Point Problems

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

More information

Multigrid Method ZHONG-CI SHI. Institute of Computational Mathematics Chinese Academy of Sciences, Beijing, China. Joint work: Xuejun Xu

Multigrid Method ZHONG-CI SHI. Institute of Computational Mathematics Chinese Academy of Sciences, Beijing, China. Joint work: Xuejun Xu Multigrid Method ZHONG-CI SHI Institute of Computational Mathematics Chinese Academy of Sciences, Beijing, China Joint work: Xuejun Xu Outline Introduction Standard Cascadic Multigrid method(cmg) Economical

More information

INTERGRID OPERATORS FOR THE CELL CENTERED FINITE DIFFERENCE MULTIGRID ALGORITHM ON RECTANGULAR GRIDS. 1. Introduction

INTERGRID OPERATORS FOR THE CELL CENTERED FINITE DIFFERENCE MULTIGRID ALGORITHM ON RECTANGULAR GRIDS. 1. Introduction Trends in Mathematics Information Center for Mathematical Sciences Volume 9 Number 2 December 2006 Pages 0 INTERGRID OPERATORS FOR THE CELL CENTERED FINITE DIFFERENCE MULTIGRID ALGORITHM ON RECTANGULAR

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

Multigrid Methods for Maxwell s Equations

Multigrid Methods for Maxwell s Equations Multigrid Methods for Maxwell s Equations Jintao Cui Institute for Mathematics and Its Applications University of Minnesota Outline Nonconforming Finite Element Methods for a Two Dimensional Curl-Curl

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

Comparison of V-cycle Multigrid Method for Cell-centered Finite Difference on Triangular Meshes

Comparison of V-cycle Multigrid Method for Cell-centered Finite Difference on Triangular Meshes Comparison of V-cycle Multigrid Method for Cell-centered Finite Difference on Triangular Meshes Do Y. Kwak, 1 JunS.Lee 1 Department of Mathematics, KAIST, Taejon 305-701, Korea Department of Mathematics,

More information

Multigrid and Domain Decomposition Methods for Electrostatics Problems

Multigrid and Domain Decomposition Methods for Electrostatics Problems Multigrid and Domain Decomposition Methods for Electrostatics Problems Michael Holst and Faisal Saied Abstract. We consider multigrid and domain decomposition methods for the numerical solution of electrostatics

More information

A SHORT NOTE COMPARING MULTIGRID AND DOMAIN DECOMPOSITION FOR PROTEIN MODELING EQUATIONS

A SHORT NOTE COMPARING MULTIGRID AND DOMAIN DECOMPOSITION FOR PROTEIN MODELING EQUATIONS A SHORT NOTE COMPARING MULTIGRID AND DOMAIN DECOMPOSITION FOR PROTEIN MODELING EQUATIONS MICHAEL HOLST AND FAISAL SAIED Abstract. We consider multigrid and domain decomposition methods for the numerical

More information

Computational Linear Algebra

Computational Linear Algebra Computational Linear Algebra PD Dr. rer. nat. habil. Ralf-Peter Mundani Computation in Engineering / BGU Scientific Computing in Computer Science / INF Winter Term 2018/19 Part 4: Iterative Methods PD

More information

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

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

More information

Numerical Solutions to Partial Differential Equations

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

More information

MULTIGRID PRECONDITIONING FOR THE BIHARMONIC DIRICHLET PROBLEM M. R. HANISCH

MULTIGRID PRECONDITIONING FOR THE BIHARMONIC DIRICHLET PROBLEM M. R. HANISCH MULTIGRID PRECONDITIONING FOR THE BIHARMONIC DIRICHLET PROBLEM M. R. HANISCH Abstract. A multigrid preconditioning scheme for solving the Ciarlet-Raviart mixed method equations for the biharmonic Dirichlet

More information

ITERATIVE METHODS FOR NONLINEAR ELLIPTIC EQUATIONS

ITERATIVE METHODS FOR NONLINEAR ELLIPTIC EQUATIONS ITERATIVE METHODS FOR NONLINEAR ELLIPTIC EQUATIONS LONG CHEN In this chapter we discuss iterative methods for solving the finite element discretization of semi-linear elliptic equations of the form: find

More information

On an Approximation Result for Piecewise Polynomial Functions. O. Karakashian

On an Approximation Result for Piecewise Polynomial Functions. O. Karakashian BULLETIN OF THE GREE MATHEMATICAL SOCIETY Volume 57, 010 (1 7) On an Approximation Result for Piecewise Polynomial Functions O. arakashian Abstract We provide a new approach for proving approximation results

More information

A Multigrid Method for Two Dimensional Maxwell Interface Problems

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

More information

Kasetsart University Workshop. Multigrid methods: An introduction

Kasetsart University Workshop. Multigrid methods: An introduction Kasetsart University Workshop Multigrid methods: An introduction Dr. Anand Pardhanani Mathematics Department Earlham College Richmond, Indiana USA pardhan@earlham.edu A copy of these slides is available

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

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

INTRODUCTION TO MULTIGRID METHODS

INTRODUCTION TO MULTIGRID METHODS INTRODUCTION TO MULTIGRID METHODS LONG CHEN 1. ALGEBRAIC EQUATION OF TWO POINT BOUNDARY VALUE PROBLEM We consider the discretization of Poisson equation in one dimension: (1) u = f, x (0, 1) u(0) = u(1)

More information

Multigrid Methods and their application in CFD

Multigrid Methods and their application in CFD Multigrid Methods and their application in CFD Michael Wurst TU München 16.06.2009 1 Multigrid Methods Definition Multigrid (MG) methods in numerical analysis are a group of algorithms for solving differential

More information

A MULTILEVEL SUCCESSIVE ITERATION METHOD FOR NONLINEAR ELLIPTIC PROBLEMS

A MULTILEVEL SUCCESSIVE ITERATION METHOD FOR NONLINEAR ELLIPTIC PROBLEMS MATHEMATICS OF COMPUTATION Volume 73, Number 246, Pages 525 539 S 0025-5718(03)01566-7 Article electronically published on July 14, 2003 A MULTILEVEL SUCCESSIVE ITERATION METHOD FOR NONLINEAR ELLIPTIC

More information

Journal of Computational and Applied Mathematics. Multigrid method for solving convection-diffusion problems with dominant convection

Journal of Computational and Applied Mathematics. Multigrid method for solving convection-diffusion problems with dominant convection Journal of Computational and Applied Mathematics 226 (2009) 77 83 Contents lists available at ScienceDirect Journal of Computational and Applied Mathematics journal homepage: www.elsevier.com/locate/cam

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

1. Fast Iterative Solvers of SLE

1. Fast Iterative Solvers of SLE 1. Fast Iterative Solvers of crucial drawback of solvers discussed so far: they become slower if we discretize more accurate! now: look for possible remedies relaxation: explicit application of the multigrid

More information

Multigrid Methods for Elliptic Obstacle Problems on 2D Bisection Grids

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

More information

AMS526: Numerical Analysis I (Numerical Linear Algebra)

AMS526: Numerical Analysis I (Numerical Linear Algebra) AMS526: Numerical Analysis I (Numerical Linear Algebra) Lecture 24: Preconditioning and Multigrid Solver Xiangmin Jiao SUNY Stony Brook Xiangmin Jiao Numerical Analysis I 1 / 5 Preconditioning Motivation:

More information

EFFICIENT MULTIGRID BASED SOLVERS FOR ISOGEOMETRIC ANALYSIS

EFFICIENT MULTIGRID BASED SOLVERS FOR ISOGEOMETRIC ANALYSIS 6th European Conference on Computational Mechanics (ECCM 6) 7th European Conference on Computational Fluid Dynamics (ECFD 7) 1115 June 2018, Glasgow, UK EFFICIENT MULTIGRID BASED SOLVERS FOR ISOGEOMETRIC

More information

Lecture Note III: Least-Squares Method

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

More information

Numerical Solutions to Partial Differential Equations

Numerical Solutions to Partial Differential Equations Numerical Solutions to Partial Differential Equations Zhiping Li LMAM and School of Mathematical Sciences Peking University The Residual and Error of Finite Element Solutions Mixed BVP of Poisson Equation

More information

10.6 ITERATIVE METHODS FOR DISCRETIZED LINEAR EQUATIONS

10.6 ITERATIVE METHODS FOR DISCRETIZED LINEAR EQUATIONS 10.6 ITERATIVE METHODS FOR DISCRETIZED LINEAR EQUATIONS 769 EXERCISES 10.5.1 Use Taylor expansion (Theorem 10.1.2) to give a proof of Theorem 10.5.3. 10.5.2 Give an alternative to Theorem 10.5.3 when F

More information

ETNA Kent State University

ETNA Kent State University g ' Electronic Transactions on umerical Analysis. Volume 17 pp. 112-132 2004. Copyright 2004. SS 10-913. COVERGECE OF V-CYCE AD F-CYCE MTGRD METHODS FOR THE BHARMOC PROBEM SG THE MOREY EEMET JE ZHAO Abstract.

More information

INTRODUCTION TO FINITE ELEMENT METHODS

INTRODUCTION TO FINITE ELEMENT METHODS INTRODUCTION TO FINITE ELEMENT METHODS LONG CHEN Finite element methods are based on the variational formulation of partial differential equations which only need to compute the gradient of a function.

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

A Recursive Trust-Region Method for Non-Convex Constrained Minimization

A Recursive Trust-Region Method for Non-Convex Constrained Minimization A Recursive Trust-Region Method for Non-Convex Constrained Minimization Christian Groß 1 and Rolf Krause 1 Institute for Numerical Simulation, University of Bonn. {gross,krause}@ins.uni-bonn.de 1 Introduction

More information

VARIATIONAL AND NON-VARIATIONAL MULTIGRID ALGORITHMS FOR THE LAPLACE-BELTRAMI OPERATOR.

VARIATIONAL AND NON-VARIATIONAL MULTIGRID ALGORITHMS FOR THE LAPLACE-BELTRAMI OPERATOR. VARIATIONAL AND NON-VARIATIONAL MULTIGRID ALGORITHMS FOR THE LAPLACE-BELTRAMI OPERATOR. ANDREA BONITO AND JOSEPH E. PASCIAK Abstract. We design and analyze variational and non-variational multigrid algorithms

More information

Stabilization and Acceleration of Algebraic Multigrid Method

Stabilization and Acceleration of Algebraic Multigrid Method Stabilization and Acceleration of Algebraic Multigrid Method Recursive Projection Algorithm A. Jemcov J.P. Maruszewski Fluent Inc. October 24, 2006 Outline 1 Need for Algorithm Stabilization and Acceleration

More information

A Mixed Nonconforming Finite Element for Linear Elasticity

A Mixed Nonconforming Finite Element for Linear Elasticity A Mixed Nonconforming Finite Element for Linear Elasticity Zhiqiang Cai, 1 Xiu Ye 2 1 Department of Mathematics, Purdue University, West Lafayette, Indiana 47907-1395 2 Department of Mathematics and Statistics,

More information

ANALYSIS AND COMPARISON OF GEOMETRIC AND ALGEBRAIC MULTIGRID FOR CONVECTION-DIFFUSION EQUATIONS

ANALYSIS AND COMPARISON OF GEOMETRIC AND ALGEBRAIC MULTIGRID FOR CONVECTION-DIFFUSION EQUATIONS ANALYSIS AND COMPARISON OF GEOMETRIC AND ALGEBRAIC MULTIGRID FOR CONVECTION-DIFFUSION EQUATIONS CHIN-TIEN WU AND HOWARD C. ELMAN Abstract. The discrete convection-diffusion equations obtained from streamline

More information

Algebraic Multigrid as Solvers and as Preconditioner

Algebraic Multigrid as Solvers and as Preconditioner Ò Algebraic Multigrid as Solvers and as Preconditioner Domenico Lahaye domenico.lahaye@cs.kuleuven.ac.be http://www.cs.kuleuven.ac.be/ domenico/ Department of Computer Science Katholieke Universiteit Leuven

More information

A Least-Squares Finite Element Approximation for the Compressible Stokes Equations

A Least-Squares Finite Element Approximation for the Compressible Stokes Equations A Least-Squares Finite Element Approximation for the Compressible Stokes Equations Zhiqiang Cai, 1 Xiu Ye 1 Department of Mathematics, Purdue University, 1395 Mathematical Science Building, West Lafayette,

More information

Aspects of Multigrid

Aspects of Multigrid Aspects of Multigrid Kees Oosterlee 1,2 1 Delft University of Technology, Delft. 2 CWI, Center for Mathematics and Computer Science, Amsterdam, SIAM Chapter Workshop Day, May 30th 2018 C.W.Oosterlee (CWI)

More information

An Algebraic Multigrid Method for Eigenvalue Problems

An Algebraic Multigrid Method for Eigenvalue Problems An Algebraic Multigrid Method for Eigenvalue Problems arxiv:1503.08462v1 [math.na] 29 Mar 2015 Xiaole Han, Yunhui He, Hehu Xie and Chunguang You Abstract An algebraic multigrid method is proposed to solve

More information

A MULTIGRID ALGORITHM FOR. Richard E. Ewing and Jian Shen. Institute for Scientic Computation. Texas A&M University. College Station, Texas SUMMARY

A MULTIGRID ALGORITHM FOR. Richard E. Ewing and Jian Shen. Institute for Scientic Computation. Texas A&M University. College Station, Texas SUMMARY A MULTIGRID ALGORITHM FOR THE CELL-CENTERED FINITE DIFFERENCE SCHEME Richard E. Ewing and Jian Shen Institute for Scientic Computation Texas A&M University College Station, Texas SUMMARY In this article,

More information

Constrained Minimization and Multigrid

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

More information

MULTIGRID METHODS FOR NEARLY SINGULAR LINEAR EQUATIONS AND EIGENVALUE PROBLEMS

MULTIGRID METHODS FOR NEARLY SINGULAR LINEAR EQUATIONS AND EIGENVALUE PROBLEMS SIAM J. NUMER. ANAL. c 997 Society for Industrial and Applied Mathematics Vol. 34, No., pp. 78 200, February 997 008 MULTIGRID METHODS FOR NEARLY SINGULAR LINEAR EQUATIONS AND EIGENVALUE PROBLEMS ZHIQIANG

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

MULTIGRID METHODS FOR NONLINEAR PROBLEMS: AN OVERVIEW

MULTIGRID METHODS FOR NONLINEAR PROBLEMS: AN OVERVIEW MULTIGRID METHODS FOR NONLINEAR PROBLEMS: AN OVERVIEW VAN EMDEN HENSON CENTER FOR APPLIED SCIENTIFIC COMPUTING LAWRENCE LIVERMORE NATIONAL LABORATORY Abstract Since their early application to elliptic

More information

6. Multigrid & Krylov Methods. June 1, 2010

6. Multigrid & Krylov Methods. June 1, 2010 June 1, 2010 Scientific Computing II, Tobias Weinzierl page 1 of 27 Outline of This Session A recapitulation of iterative schemes Lots of advertisement Multigrid Ingredients Multigrid Analysis Scientific

More information

arxiv: v1 [math.na] 29 Feb 2016

arxiv: v1 [math.na] 29 Feb 2016 EFFECTIVE IMPLEMENTATION OF THE WEAK GALERKIN FINITE ELEMENT METHODS FOR THE BIHARMONIC EQUATION LIN MU, JUNPING WANG, AND XIU YE Abstract. arxiv:1602.08817v1 [math.na] 29 Feb 2016 The weak Galerkin (WG)

More information

ENERGY NORM A POSTERIORI ERROR ESTIMATES FOR MIXED FINITE ELEMENT METHODS

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

More information

Solving PDEs with Multigrid Methods p.1

Solving PDEs with Multigrid Methods p.1 Solving PDEs with Multigrid Methods Scott MacLachlan maclachl@colorado.edu Department of Applied Mathematics, University of Colorado at Boulder Solving PDEs with Multigrid Methods p.1 Support and Collaboration

More information

MULTIGRID METHODS FOR MAXWELL S EQUATIONS

MULTIGRID METHODS FOR MAXWELL S EQUATIONS MULTIGRID METHODS FOR MAXWELL S EQUATIONS A Dissertation Submitted to the Graduate Faculty of the Louisiana State University and Agricultural and Mechanical College in partial fulfillment of the requirements

More information

AMG for a Peta-scale Navier Stokes Code

AMG for a Peta-scale Navier Stokes Code AMG for a Peta-scale Navier Stokes Code James Lottes Argonne National Laboratory October 18, 2007 The Challenge Develop an AMG iterative method to solve Poisson 2 u = f discretized on highly irregular

More information

Multigrid finite element methods on semi-structured triangular grids

Multigrid finite element methods on semi-structured triangular grids XXI Congreso de Ecuaciones Diferenciales y Aplicaciones XI Congreso de Matemática Aplicada Ciudad Real, -5 septiembre 009 (pp. 8) Multigrid finite element methods on semi-structured triangular grids F.J.

More information

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

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

More information

University of Illinois at Urbana-Champaign. Multigrid (MG) methods are used to approximate solutions to elliptic partial differential

University of Illinois at Urbana-Champaign. Multigrid (MG) methods are used to approximate solutions to elliptic partial differential Title: Multigrid Methods Name: Luke Olson 1 Affil./Addr.: Department of Computer Science University of Illinois at Urbana-Champaign Urbana, IL 61801 email: lukeo@illinois.edu url: http://www.cs.uiuc.edu/homes/lukeo/

More information

Chapter 7 Iterative Techniques in Matrix Algebra

Chapter 7 Iterative Techniques in Matrix Algebra Chapter 7 Iterative Techniques in Matrix Algebra Per-Olof Persson persson@berkeley.edu Department of Mathematics University of California, Berkeley Math 128B Numerical Analysis Vector Norms Definition

More information

Finite Elements. Colin Cotter. February 22, Colin Cotter FEM

Finite Elements. Colin Cotter. February 22, Colin Cotter FEM Finite Elements February 22, 2019 In the previous sections, we introduced the concept of finite element spaces, which contain certain functions defined on a domain. Finite element spaces are examples of

More information

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

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

More information

A Sobolev trust-region method for numerical solution of the Ginz

A Sobolev trust-region method for numerical solution of the Ginz A Sobolev trust-region method for numerical solution of the Ginzburg-Landau equations Robert J. Renka Parimah Kazemi Department of Computer Science & Engineering University of North Texas June 6, 2012

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

An Algebraic Multigrid Method Based on Matching 2 in Graphs 3 UNCORRECTED PROOF

An Algebraic Multigrid Method Based on Matching 2 in Graphs 3 UNCORRECTED PROOF 1 An Algebraic Multigrid Method Based on Matching 2 in Graphs 3 James Brannic 1, Yao Chen 1, Johannes Kraus 2, and Ludmil Ziatanov 1 4 1 Department of Mathematics, The Pennsylvania State University, PA

More information

arxiv: v2 [math.na] 29 Nov 2016

arxiv: v2 [math.na] 29 Nov 2016 Noname manuscript No. (will be inserted by the editor) Multigrid algorithms for hp-version Interior Penalty Discontinuous Galerkin methods on polygonal and polyhedral meshes P. F. Antonietti P. Houston

More information

A Finite Element Method Using Singular Functions for Poisson Equations: Mixed Boundary Conditions

A Finite Element Method Using Singular Functions for Poisson Equations: Mixed Boundary Conditions A Finite Element Method Using Singular Functions for Poisson Equations: Mixed Boundary Conditions Zhiqiang Cai Seokchan Kim Sangdong Kim Sooryun Kong Abstract In [7], we proposed a new finite element method

More information

Bootstrap AMG. Kailai Xu. July 12, Stanford University

Bootstrap AMG. Kailai Xu. July 12, Stanford University Bootstrap AMG Kailai Xu Stanford University July 12, 2017 AMG Components A general AMG algorithm consists of the following components. A hierarchy of levels. A smoother. A prolongation. A restriction.

More information

From Completing the Squares and Orthogonal Projection to Finite Element Methods

From Completing the Squares and Orthogonal Projection to Finite Element Methods From Completing the Squares and Orthogonal Projection to Finite Element Methods Mo MU Background In scientific computing, it is important to start with an appropriate model in order to design effective

More information

Chapter 6 A posteriori error estimates for finite element approximations 6.1 Introduction

Chapter 6 A posteriori error estimates for finite element approximations 6.1 Introduction Chapter 6 A posteriori error estimates for finite element approximations 6.1 Introduction The a posteriori error estimation of finite element approximations of elliptic boundary value problems has reached

More information

Robust solution of Poisson-like problems with aggregation-based AMG

Robust solution of Poisson-like problems with aggregation-based AMG Robust solution of Poisson-like problems with aggregation-based AMG Yvan Notay Université Libre de Bruxelles Service de Métrologie Nucléaire Paris, January 26, 215 Supported by the Belgian FNRS http://homepages.ulb.ac.be/

More information

Hamburger Beiträge zur Angewandten Mathematik

Hamburger Beiträge zur Angewandten Mathematik Hamburger Beiträge zur Angewandten Mathematik Numerical analysis of a control and state constrained elliptic control problem with piecewise constant control approximations Klaus Deckelnick and Michael

More information

Institut für Mathematik

Institut für Mathematik U n i v e r s i t ä t A u g s b u r g Institut für Mathematik Xuejun Xu, Huangxin Chen, Ronald H.W. Hoppe Local Multilevel Methods for Adaptive Nonconforming Finite Element Methods Preprint Nr. 21/2009

More information

A NOTE ON THE LADYŽENSKAJA-BABUŠKA-BREZZI CONDITION

A NOTE ON THE LADYŽENSKAJA-BABUŠKA-BREZZI CONDITION A NOTE ON THE LADYŽENSKAJA-BABUŠKA-BREZZI CONDITION JOHNNY GUZMÁN, ABNER J. SALGADO, AND FRANCISCO-JAVIER SAYAS Abstract. The analysis of finite-element-like Galerkin discretization techniques for the

More information

Notes on Multigrid Methods

Notes on Multigrid Methods Notes on Multigrid Metods Qingai Zang April, 17 Motivation of multigrids. Te convergence rates of classical iterative metod depend on te grid spacing, or problem size. In contrast, convergence rates of

More information

It is known that Morley element is not C 0 element and it is divergent for Poisson equation (see [6]). When Morley element is applied to solve problem

It is known that Morley element is not C 0 element and it is divergent for Poisson equation (see [6]). When Morley element is applied to solve problem Modied Morley Element Method for a ourth Order Elliptic Singular Perturbation Problem Λ Wang Ming LMAM, School of Mathematical Science, Peking University Jinchao u School of Mathematical Science, Peking

More information

A posteriori error estimation for elliptic problems

A posteriori error estimation for elliptic problems A posteriori error estimation for elliptic problems Praveen. C praveen@math.tifrbng.res.in Tata Institute of Fundamental Research Center for Applicable Mathematics Bangalore 560065 http://math.tifrbng.res.in

More information

New Multigrid Solver Advances in TOPS

New Multigrid Solver Advances in TOPS New Multigrid Solver Advances in TOPS R D Falgout 1, J Brannick 2, M Brezina 2, T Manteuffel 2 and S McCormick 2 1 Center for Applied Scientific Computing, Lawrence Livermore National Laboratory, P.O.

More information

High order, finite volume method, flux conservation, finite element method

High order, finite volume method, flux conservation, finite element method FLUX-CONSERVING FINITE ELEMENT METHODS SHANGYOU ZHANG, ZHIMIN ZHANG, AND QINGSONG ZOU Abstract. We analyze the flux conservation property of the finite element method. It is shown that the finite element

More information

CLASSICAL ITERATIVE METHODS

CLASSICAL ITERATIVE METHODS CLASSICAL ITERATIVE METHODS LONG CHEN In this notes we discuss classic iterative methods on solving the linear operator equation (1) Au = f, posed on a finite dimensional Hilbert space V = R N equipped

More information

TREATMENTS OF DISCONTINUITY AND BUBBLE FUNCTIONS IN THE MULTIGRID METHOD

TREATMENTS OF DISCONTINUITY AND BUBBLE FUNCTIONS IN THE MULTIGRID METHOD MATHEMATICS OF COMPUTATION Volume 66, Number 219, July 1997, Pages 1055 1072 S 0025-5718(97)00853-3 TREATMENTS OF DISCONTINUITY AND BUBBLE FUNCTIONS IN THE MULTIGRID METHOD SHANGYOU ZHANG AND ZHIMIN ZHANG

More information

Remarks on the analysis of finite element methods on a Shishkin mesh: are Scott-Zhang interpolants applicable?

Remarks on the analysis of finite element methods on a Shishkin mesh: are Scott-Zhang interpolants applicable? Remarks on the analysis of finite element methods on a Shishkin mesh: are Scott-Zhang interpolants applicable? Thomas Apel, Hans-G. Roos 22.7.2008 Abstract In the first part of the paper we discuss minimal

More information

Solving Symmetric Indefinite Systems with Symmetric Positive Definite Preconditioners

Solving Symmetric Indefinite Systems with Symmetric Positive Definite Preconditioners Solving Symmetric Indefinite Systems with Symmetric Positive Definite Preconditioners Eugene Vecharynski 1 Andrew Knyazev 2 1 Department of Computer Science and Engineering University of Minnesota 2 Department

More information

Subdiffusion in a nonconvex polygon

Subdiffusion in a nonconvex polygon Subdiffusion in a nonconvex polygon Kim Ngan Le and William McLean The University of New South Wales Bishnu Lamichhane University of Newcastle Monash Workshop on Numerical PDEs, February 2016 Outline Time-fractional

More information

REGULARITY AND MULTIGRID ANALYSIS FOR LAPLACE-TYPE AXISYMMETRIC EQUATIONS. Hengguang Li. IMA Preprint Series #2417.

REGULARITY AND MULTIGRID ANALYSIS FOR LAPLACE-TYPE AXISYMMETRIC EQUATIONS. Hengguang Li. IMA Preprint Series #2417. REGULARITY AND MULTIGRID ANALYSIS FOR LAPLACE-TYPE AXISYMMETRIC EQUATIONS By Hengguang Li IMA Preprint Series #417 February 013) INSTITUTE FOR MATHEMATICS AND ITS APPLICATIONS UNIVERSITY OF MINNESOTA 400

More information

Adaptive algebraic multigrid methods in lattice computations

Adaptive algebraic multigrid methods in lattice computations Adaptive algebraic multigrid methods in lattice computations Karsten Kahl Bergische Universität Wuppertal January 8, 2009 Acknowledgements Matthias Bolten, University of Wuppertal Achi Brandt, Weizmann

More information

LOCAL MULTILEVEL METHODS FOR ADAPTIVE NONCONFORMING FINITE ELEMENT METHODS

LOCAL MULTILEVEL METHODS FOR ADAPTIVE NONCONFORMING FINITE ELEMENT METHODS LOCAL MULTILEVEL METHODS FOR ADAPTIVE NONCONFORMING FINITE ELEMENT METHODS XUEUN XU, HUANGXIN CHEN, AND RONALD H.W. HOPPE Abstract. In this paper, we propose a local multilevel product algorithm and its

More information

Introduction to Scientific Computing II Multigrid

Introduction to Scientific Computing II Multigrid Introduction to Scientific Computing II Multigrid Miriam Mehl Slide 5: Relaxation Methods Properties convergence depends on method clear, see exercises and 3), frequency of the error remember eigenvectors

More information

A New Multilevel Smoothing Method for Wavelet-Based Algebraic Multigrid Poisson Problem Solver

A New Multilevel Smoothing Method for Wavelet-Based Algebraic Multigrid Poisson Problem Solver Journal of Microwaves, Optoelectronics and Electromagnetic Applications, Vol. 10, No.2, December 2011 379 A New Multilevel Smoothing Method for Wavelet-Based Algebraic Multigrid Poisson Problem Solver

More information

Iterative Methods and Multigrid

Iterative Methods and Multigrid Iterative Methods and Multigrid Part 1: Introduction to Multigrid 1 12/02/09 MG02.prz Error Smoothing 1 0.9 0.8 0.7 0.6 0.5 0.4 0.3 0.2 0.1 0 Initial Solution=-Error 0 10 20 30 40 50 60 70 80 90 100 DCT:

More information

Preface to the Second Edition. Preface to the First Edition

Preface to the Second Edition. Preface to the First Edition n page v Preface to the Second Edition Preface to the First Edition xiii xvii 1 Background in Linear Algebra 1 1.1 Matrices................................. 1 1.2 Square Matrices and Eigenvalues....................

More information

1. Introduction. We consider the model problem that seeks an unknown function u = u(x) satisfying

1. Introduction. We consider the model problem that seeks an unknown function u = u(x) satisfying A SIMPLE FINITE ELEMENT METHOD FOR LINEAR HYPERBOLIC PROBLEMS LIN MU AND XIU YE Abstract. In this paper, we introduce a simple finite element method for solving first order hyperbolic equations with easy

More information

Numerische Mathematik

Numerische Mathematik Numer. Math. (1999) 82: 179 191 Numerische Mathematik c Springer-Verlag 1999 Electronic Edition A cascadic multigrid algorithm for the Stokes equations Dietrich Braess 1, Wolfgang Dahmen 2 1 Fakultät für

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

Multigrid Methods for A Mixed Finite Element Method of The Darcy-Forchheimer Model

Multigrid Methods for A Mixed Finite Element Method of The Darcy-Forchheimer Model Noname manuscript No. (will be inserted by the editor) Multigrid Methods for A Mixed Finite Element Method of he Darcy-Forchheimer Model Jian Huang Long Chen Hongxing Rui Received: date / Accepted: date

More information

ETNA Kent State University

ETNA Kent State University Electronic Transactions on Numerical Analysis. Volume 37, pp. 166-172, 2010. Copyright 2010,. ISSN 1068-9613. ETNA A GRADIENT RECOVERY OPERATOR BASED ON AN OBLIQUE PROJECTION BISHNU P. LAMICHHANE Abstract.

More information

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

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

More information

A Balancing Algorithm for Mortar Methods

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

More information

Numerische Mathematik

Numerische Mathematik Numer. Math. (997) 76: 479 488 Numerische Mathematik c Springer-Verlag 997 Electronic Edition Exponential decay of C cubic splines vanishing at two symmetric points in each knot interval Sang Dong Kim,,

More information

Projected Surface Finite Elements for Elliptic Equations

Projected Surface Finite Elements for Elliptic Equations Available at http://pvamu.edu/aam Appl. Appl. Math. IN: 1932-9466 Vol. 8, Issue 1 (June 2013), pp. 16 33 Applications and Applied Mathematics: An International Journal (AAM) Projected urface Finite Elements

More information

PREPRINT 2010:23. A nonconforming rotated Q 1 approximation on tetrahedra PETER HANSBO

PREPRINT 2010:23. A nonconforming rotated Q 1 approximation on tetrahedra PETER HANSBO PREPRINT 2010:23 A nonconforming rotated Q 1 approximation on tetrahedra PETER HANSBO Department of Mathematical Sciences Division of Mathematics CHALMERS UNIVERSITY OF TECHNOLOGY UNIVERSITY OF GOTHENBURG

More information

Elliptic Problems / Multigrid. PHY 604: Computational Methods for Physics and Astrophysics II

Elliptic Problems / Multigrid. PHY 604: Computational Methods for Physics and Astrophysics II Elliptic Problems / Multigrid Summary of Hyperbolic PDEs We looked at a simple linear and a nonlinear scalar hyperbolic PDE There is a speed associated with the change of the solution Explicit methods

More information