arxiv: v1 [math.na] 7 Jan 2019

Size: px
Start display at page:

Download "arxiv: v1 [math.na] 7 Jan 2019"

Transcription

1 Efficient p-multigrid Methods for Isogeometric Analysis R. Tielen a,, M. Möller a, D. Göddeke b, C. Vuik a arxiv:9.685v [math.na] 7 Jan 29 a Delft Institute of Applied Mathematics, Delft University of Technology, Van Mourik Broekmanweg 6, 2628XE, Delft b Institute for Applied Analysis and Numerical Simulation, University of Stuttgart Allmandring 5b, 7569, Stuttgart Abstract Over the years, Isogeometric Analysis has shown to be a successful alternative to the Finite Element Method (FEM). However, solving the resulting linear systems of equations efficiently remains a challenging task. In this paper, we consider a p-multigrid method, in which each level of the hierarchy is associated with a different approximation order p instead of mesh width h. Since the use of classical smoothers (i.e. Gauss-Seidel) results in a p-multigrid method with deteriorating performance for higher values of p, the use of an ILUT smoother is investigated. Numerical results and a spectral analysis indicate that the resulting p-multigrid method exhibits convergence rates independent of h and p. Keywords:. Introduction Isogeometric Analysis, Multigrid methods, p-multigrid Isogeometric Analysis (IgA) [] has become widely accepted over the years as an alternative to the Finite Element Method (FEM). The use of B-spline basis functions or Non-Uniform Rational B-splines (NURBS) allows for a highly accurate representation of complex geometries and establishes the link between computer-aided design (CAD) and computer-aided engineering (CAE) tools. Furthermore, the C p continuity of the basis functions offers a higher accuracy per degree of freedom compared to standard FEM [2]. IgA has been applied with success in a wide range of engineering fields, such as structural mechanics [3], fluid dynamics [4] and shape optimization [5]. r.p.w.m.tielen@tudelft.nl Preprint submitted to Computer Methods in Mechanics and Engineering January 8, 29

2 Solving the resulting linear systems efficiently is, however, still a challenging task. The condition numbers of the mass and stiffness matrices increase exponentially with the approximation order p, making the use of (standard) iterative solvers inefficient. On the other hand, the use of direct solvers is not straightforward due to the increasing stencil of the basis functions and increasing bandwith of matrices for higher values of p. Furthermore, direct solvers may not be practical for large problem sizes due to memory constraints, which is a common problem in high-order methods in general. Recently, various solution techniques have been developed for discretizations arising in Isogeometric Analysis. For example, preconditioners have been developed based on fast solvers for the Sylvester equation [3] and overlapping Schwarz methods [4]. As an alternative, geometric multigrid methods have been investigated, as they are considered among the most efficient solvers in Finite Element Methods for elliptic problems. However, the use of standard smoothers like (damped) Jacobi or Gauss-Seidel leads to convergence rates which deteriorate for increasing values of p [5]. It has been noted in [6] that very small eigenvalues associated with high-frequency eigenvectors cause this behaviour. The use of non-classical smoothers, such as a boundary-corrected mass-richardson smoother, has proven to solve this problem [7, 8]. p-multigrid methods can be adopted as an alternative solution strategy. In contrast to h-multigrid methods, a hierarchy is constructed where each level represents a different approximation order. Throughout this paper, the coarse grid correction is obtained at level p =. Here, B-spline functions coincide with linear Lagrange basis functions, enabling the use of well known solution techniques for standard Lagrangian Finite Elements. p-multigrid methods have mostly been used for solving linear systems arising within the Discontinuous Galerkin method [6, 7, 8, 9], where a hierarchy was constructed until level p =. However, some research has been performed for continuous Galerkin methods [] as well, where the coarse grid correction was obtained at level p =. Recently, the authors applied a p-multigrid method, using a Gauss-Seidel smoother, in the context of IgA []. As with h-multigrid methods, a dependence of the convergence rate on p was reported. In this paper, a p-multigrid method is presented making use of an Incomplete LU factorization based on a dual threshold strategy (ILUT) [2] for smoothing. The spectral properties of the resulting p-multigrid method are analyzed. Furthermore, numerical results are presented for Poisson s equation on a non-trivial geometry and the convection-diffusion-reaction (CDR) 2

3 equation on the unit square. The use of ILUT as a smoother significantly improves the performance of the p-multigrid method, leading to convergence rates independent of h and p. This paper is organised as follows. In Section 2 the model problem and spatial discretisation are considered. Section 3 presents the p-multigrid method in detail, together with the proposed ILUT smoother. A spectral analysis is performed and discussed in Section 4. In Section 5, numerical results for the considered benchmark are presented. Finally, conclusions are drawn in Section Model problem To assess the quality of the p-multigrid method, the convection-diffusionreaction (CDR) equation is considered as a model problem: (D u) + (vu) + Ru = f, on Ω, () where D denotes the diffusion tensor, v the velocity field and R a source term. Here, Ω R 2 is a connected domain, f L 2 (Ω) and u = on the boundary Ω. Let V = H (Ω) denote the space of functions in the Sobolev space H (Ω) that vanish on Ω. The variational form of () is then obtained by multiplication with an arbitrary test function v V and application of integration by parts: Find u V such that (D u, v) + (v u + Ru, v) = (f, v) v V. (2) The physical domain Ω is then parameterized by a geometry function F : Ω Ω, F(ξ) = x, (3) which describes an invertible mapping from the parameter domain Ω R 2 to the physical domain Ω R 2. The tensor product of one-dimensional B- spline basis functions of order p are then used for spatial discretization. Onedimensional B-spline basis functions are defined on the parameter domain and are uniquely determined by their underlying knot vector Ξ = {ξ, ξ 2,..., ξ N+p, ξ N+p+ }, (4) 3

4 consisting of a sequence of non-decreasing knots ξ i R. Here, N denotes the number of basis functions of order p defined by this knot vector. Throughout this paper, B-spline basis functions are considered based on an open uniform knot vector with knot span size h, implying that the first and last knots are repeated p + times. As a consequence, the basis functions considered are C p continuous and interpolating only at the two end points. Constant B-spline basis functions are defined as follows [9]: { if ξ i ξ < ξ i+, φ i, (ξ) = (5) otherwise. Higher-order B-spline basis functions of order p are then defined recursively for p > : φ i,p (ξ) = ξ ξ i φ i,p (ξ) + ξ i+p+ ξ φ i+,p (ξ). (6) ξ i+p ξ i ξ i+p+ ξ i+ The resulting B-spline basis functions φ i,p are non-zero on the interval [ξ i, ξ i+p+ ), implying a compact support that increases with p. The spline space V h,p is then formulated adopting the tensor product of these basis functions: Φ I, p (ξ) := φ i,p (ξ)φ j,q (ξ), I = (i, j), p = (p, q). (7) Using the geometry mapping F as pull-back operator, V h,p can be written as follows: } V h,p := span {Φ I, p F. (8) i=,...,n dof Here, N dof denotes the number of tensor-product basis functions, implying N dof = N 2. The Galerkin formulation of (2) becomes: Find u h,p V h,p such that (D u h,p, v h,p ) + (v u h,p + Ru h,p, v h,p ) = (f, v h,p ) v h,p V h,p. (9) The discretized problem can be written as a linear system A h,p u h,p = f h,p, () where A h,p denotes the system matrix resulting from this discretization with B-spline basis functions of order p and mesh width h. For a more detailed 4

5 description of the spatial discretization in Isogeometric Analysis, the authors refer to []. Throughout this paper two benchmarks are considered: Benchmark. Let Ω be the quarter annulus with an inner and outer radius of and 2, respectively. The coefficients are chosen as follows: [ ] [ ] D =, v =, R =. () Furthermore, the right-hand side is chosen such that the exact solution u is given by: u(x, y) = (x 2 + y 2 )(x 2 + y 2 4)xy 2. Benchmark 2. Here, the unit square is adopted as domain, i.e. Ω = [, ] 2, and the coefficients are chosen as follows: [ ] [ ] D =, v =, R =.3. (2) The right-hand side is chosen such that the exact solution u is given by: u(x, y) = sin(πx)sin(πy). The resulting system matrix from the first benchmark will be referred to as Ā h,p, while the system matrix associated with the second benchmark is denoted by  h,p. Please note, that both Ā h,p and  h,p are symmetric positive definite matrices. 3. p-multigrid method Multigrid methods aim to solve equations resulting from the discretization of partial differential equations by using a hierarchy of discretizations. At each level of the hierarchy a smoother is applied, whereas on the coarsest level a correction is determined. To solve Equation () using a p-multigrid method, a sequence of spaces V h,,..., V h,p is obtained by applying refinement in p. Note that, since basis functions with maximal continuity are considered, the spaces are not nested. A single step of the two-grid correction scheme for the p-multigrid method consists of the following steps []: 5

6 . Starting from an initial guess u () h,p, apply a fixed number ν of presmoothing steps: u (,m) h,p = u (,m ) h,p + S h,p ( f h,p A h,p u (,m ) h,p ), m =,..., ν, (3) where S is a smoothing operator applied to the high-order problem. 2. Determine the residual at level p and project it onto the space V h,p using the restriction operator Ip p : ( ) r h,p = Ip p f h,p A h,p u (,ν ) h,p. (4) 3. Solve the residual equation at level p to determine the coarse grid error: A h,p e h,p = r h,p. (5) 4. Project the error e h,p onto the space V h,p using the prolongation operator I p p and update u (,ν ) h,p : u (,ν ) h,p := u (,ν ) h,p + I p p (e h,p ). (6) 5. Apply ν 2 postsmoothing steps to obtain u (,ν +ν 2 ) h,p =: u () h,p. In literature, step (2)-(4) are referred to as coarse grid correction. Recursive application of this scheme on Equation (5) until level p = is reached, results in a V-cycle. However, as shown in Figure, different cycle types can be applied, for example a W-cycle. k = 3 k = 2 k = Restrict Restrict Prolongate Prolongate Figure : Description of a V-cycle and W-cycle. 6

7 Prolongation and restriction To transfer both coarse grid corrections and residuals between different levels of the hierarchy, prolongation and restriction operators are defined. The prolongation and restriction operator adopted in this paper are based on an L 2 projection and have been used extensively in literature [2, 2, 22]. At each level k, where 2 k p, the coarse grid correction is prolongated to level k by projection onto the space V h,k. The prolongation operator Ik k : V h,k V h,k is given by I k k (v k ) = (M k ) P k k v k, (7) where the mass matrix M k and transfer matrix P k k are defined, respectively, as follows: (M k ) (i,j) := φ i,k φ j,k dω, (P k k ) (i,j) := φ i,k φ j,k dω (8) Ω The residuals are restricted from level k to k by projection onto the space V h,k. The restriction operator I k k : V h,k V h,k is defined by I k k (v k ) = (M k ) P k k v k. (9) To prevent the explicit solution of a linear system of equations for each projection step, the consistent mass matrix M in both transfer operators is replaced by its lumped counterpart M L by applying row-sum lumping: Smoother N dof M L (i,i) = M (i,j). (2) j= Within multigrid methods, a basic iterative method is typically used as a smoother. However, in IgA the performance of classical smoothers such as (damped) Jacobi and Gauss-Seidel decreases significantly for higher values of p. Therefore, an Incomplete LU factorization is adopted with a dual threshold strategy (ILUT) [2] to approximate the operator A h,p : A h,p L h,p U h,p. (2) The ILUT factorization is determined completely by a tolerance τ and fillfactor m. Two dropping rules are applied during factorization: Ω 7

8 . All elements smaller (in absolute value) than the dropping tolerance are dropped. The dropping tolerance is obtained by multiplying the tolerance τ with the average magnitude of all elements in the currect row. 2. Apart from the diagonal element, only the M largest elements are kept in each row. Here, M is determined by multiplying the fillfactor m with the average number of non-zeros in each row of the original operator A h,p. An efficient implementation of ILUT is available in the Eigen library [23] based on [24]. Once the factorization is obtained, a single smoothing step is applied as follows: e (n) h,p = (L h,p U h,p ) (f h,p A h,p u (n) h,p ), = U h,p L h,p (f h,p A h,p u (n) h,p ), u (n+) h,p = u (n) h,p + e(n) h,p. Throughout this paper, the fillfactor m = is used and the dropping tolerance equals τ = 2. Hence, the number of non-zero elements of L h,p +U h,p is similar to the number of non-zero elements of A h,p. Figure 2 shows the sparsity pattern of the stiffness matrix Ā h,p and L h,p +Ū h,p for p = 3. Since a permutation is performed during the ILUT factorization, sparsity patterns differ significantly. However, the number of non-zero entries is comparable. Coarse grid operator At each level of the hierarchy, the operator A h,p is needed to apply smoothing or solve the residual equation. The operators at the coarser levels can be obtained by rediscretizing the bilinear form in (2) with low-order basis functions. Alternatively, a Galerkin projection can be adopted: A G h,p = I p p A h,p I p p. (22) For both approaches, the condition number of the coarse grid operator for Poisson s equation is presented in Table for different values of h and p. The condition number when using the Galerkin projection is significantly higher compared to the condition number of the rediscretized operator. Results for the second benchmark show the same behaviour. Therefore, the coarse grid operators in this paper are obtained by using the latter approach. 8

9 nz = nz = 6273 Figure 2: Sparsity pattern of the stiffness matrix Ā h,3 (left) and L h,3 + Ū h,3 (right). Table : Condition number of the coarse grid operator for Poisson s equation obtained with the Galerkin projection (G) and rediscretization (RD). p = 2 κ(ā G h, ) κ(ārd h, ) p = 3 κ(āg h,2 ) κ(ārd h,2 ) h = h = h = h = h = h = h = h = Spectral Analysis In this section, the performance of the proposed p-multigrid method is analyzed in different ways. First, a spectral analysis is performed to investigate the interplay between the coarse grid correction and the smoother. Then, the spectral radius of the iteration matrix is determined to obtain the asymptotic convergence factors of the p-multigrid method. Throughout this section, both benchmarks presented in Section 2 are considered for the analysis. Reduction factors To investigate the effect of a single smoothing step or coarse grid correction, a spectral analysis [25] is carried out for different values of p. For this analysis, we consider u = with homogeneous Dirichlet boundary conditions and, hence, u = as its exact solution. Let us define the error reduction factors as follows: 9

10 r S (u h,p) = S(u h,p ) 2 u h,p, r CGC (u h,p) = CGC(u h,p ) 2 2 u h,p, (23) 2 where S( ) and CGC( ) denote a single smoothing step and a coarse grid correction, respectively. As an initial guess, the generalized eigenvectors v i are chosen which satisfy A h,p v i = λ i M h,p v i, i =,..., N 2. (24) Here, M h,p denotes the consistent mass matrix as defined in (8) and v i the generalized eigenvectors. The error reduction factors for the first benchmark for different smoothers are shown in Figure 3 for h = 2 5 and different values of p. In the left column, the reduction factors are shown obtained with Gauss- Seidel as a smoother, while the plots in the right column are obtained based on an ILUT factorization. In general, the coarse grid correction reduces the eigenvectors corresponding to the low-frequency modes, while the smoother reduces the eigenvectors associated with high-frequency modes. However, for increasing values of p, the reduction factors of the Gauss-Seidel smoother increase for the high-frequency modes, implying that the smoother becomes less effective. On the other hand, the use of ILUT as a smoother leads to decreasing reduction factors for all modes when the value of p is increased. Figure 4 shows the error reduction factors obtained for the second benchmark, showing similar, but less oscillatory, behaviour. These results indicate that the use of ILUT as a smoother could improve the convergence properties of the p-multigrid method compared to the use of a classical smoother. Iteration Matrix For any multigrid method, the asymptotic convergence rate is determined by the spectral radius of the iteration matrix. To obtain this matrix explicitly, consider, again, u = with homogeneous Dirichtlet boundary conditions. By applying a single iteration of the p-multigrid method using the unit vector e i h,p as initial guess, one obtains the ith column of the iteration matrix [26]. Figure 5 shows the spectra for the first benchmark for h = 2 5 and different values of p obtained with both Gauss-Seidel and ILUT as a smoother. For reference, the unit circle has been added in all plots. The spectral radius of the iteration matrix, defined as the maximum eigenvalue in absolute value,

11 Reduction Reduction Reduction Reduction Reduction Reduction.2 CGC Smoother Gauss-Seidel (p=2).2 CGC Smoother ILUT (p=2) CGC Smoother Eigenvalue Gauss-Seidel (p=3) 2 Eigenvalue.2 CGC Smoother ILUT (p=3) CGC Smoother Eigenvalue Gauss-Seidel (p=4) 2 Eigenvalue.2 CGC Smoother ILUT (p=4) Eigenvalue 2 Eigenvalue Figure 3: Error reduction in (v j ) for the first benchmark with p = 2, 3, 4 and refinement level 5 obtained with Gauss-Seidel (left) and ILUT (right).

12 Reduction Reduction Reduction Reduction Reduction Reduction.2 CGC Smoother Gauss-Seidel (p=2).2 CGC Smoother ILUT (p=2) Eigenvalue.2 CGC Smoother Gauss-Seidel (p=3) 2.2 CGC Smoother Eigenvalue ILUT (p=3) Eigenvalue.2 CGC Smoother Gauss-Seidel (p=4) 2.2 CGC Smoother Eigenvalue ILUT (p=4) Eigenvalue 2 Eigenvalue Figure 4: Error reduction in (v j ) for the second benchmark with p = 2, 3, 4 and refinement level 5 obtained with Gauss-Seidel (left) and ILUT (right). 2

13 is then given by the eigenvalue that is the furthest away from the origin. Clearly, the spectral radius significantly increases for higher values of p when adopting Gauss-Seidel as a smoother. The use of ILUT as a smoother results in spectra clustered around the origin, implying fast convergence of the resulting p-multigrid method. The spectra of the iteration matrices for the second benchmark are presented in Figure 6. Although the eigenvalues are more clustered compared to the first benchmark, the same behaviour can be observed. The spectral radia for both benchmarks, where ν = ν 2 =, are presented in Table 2 and Table 3, respectively. For Gauss-Seidel, the spectral radius of the iteration matrix is independent of the mesh width h, but depends strongly on the approximation order p. For one configuration, the p-multigrid method diverges, indicated by a spectral radius larger then. The use of ILUT leads to a spectral radius which is significantly lower for all values of h and p. Although ILUT exhibits a small h-dependence, the spectral radius remains low for all values of h. As a consequence, the p- multigrid method is expected to show both h- and p-independence when ILUT is adopted as a smoother. Table 2: Spectral radius ρ for the first benchmark using Gauss-Seidel and ILUT for different values of h and p. p = 2 GS ILUT p = 3 GS ILUT p = 4 GS ILUT h = h = h = h = h = h = h = h = h = Table 3: Spectral radius ρ for the second benchmark using Gauss-Seidel and ILUT for different values of h and p. p = 2 GS ILUT p = 3 GS ILUT p = 4 GS ILUT h = h = h = h = h = h = h = h = h =

14 Imaginary axis Imaginary axis Imaginary axis Imaginary axis Imaginary axis Imaginary axis Gauss-Seidel (p=2) Real axis Gauss-Seidel (p=3) Real axis Gauss-Seidel (p=4) Real axis ILUT (p=2) Real axis ILUT (p=3) Real axis ILUT (p=4) Real axis Figure 5: Spectra of the iteration matrix for the first benchmark obtained with Gauss- Seidel (left) and ILUT (right) as smoother. 4

15 Imaginary axis Imaginary axis Imaginary axis Imaginary axis Imaginary axis Imaginary axis Gauss-Seidel (p=2) ILUT (p=2) Real axis Gauss-Seidel (p=3) Real axis Gauss-Seidel (p=4) Real axis Real axis ILUT (p=3) Real axis ILUT (p=4) Real axis Figure 6: Spectra of the iteration matrix for the second benchmark obtained with Gauss- Seidel (left) and ILUT (right) as smoother. 5

16 5. Numerical Results In this Section, p-multigrid is both applied as a stand-alone solver and as a preconditioner within a Conjugate Gradient method. Results are compared using different smoothers (i.e. Gauss-Seidel and ILUT) and cycle types. Furthermore, the influence of the coarse grid correction and coarsening strategy on the convergence is investigated. Finally, (normalized) CPU times are presented for p-multigrid using different smoothers. For all numerical experiments, the initial guess u () h,p is chosen randomly, where each entry is sampled from a uniform distribution on the interval [, ] using the same seed. The stopping criterion is based on a relative reduction of the initial residual, where a tolerance of ɛ = 8 is adopted. Hence, the method is considered converged if r (i) h,p < ɛ, (25) r () h,p where r (i) h,p denotes the residual after iteration i. At level p =, the solution of the residual equation is obtained by means of a CG solver with a relatively high tolerance (ɛ = 4 ). Boundary conditions are imposed by using Nitsche s method [27]. Furthermore, the same number of presmoothing and postsmoothing steps are applied for all numerical experiments (ν = ν = ν 2 ) in this section. Table 4 shows the number of V-cycles needed for convergence for the first benchmark using different smoothers. As in the previous sections, both Gauss-Seidel and ILUT are considered as a smoother, with ν = 2. As expected, the number of V-cycles needed with Gauss-Seidel is independent of h, but strongly depends on p. The use of ILUT as a smoother leads to a p-multigrid which exhibits both independence of h and p. Furthermore, the number of iterations needed for convergence is significantly lower. For ν = 4, the number of iterations are shown in Table 5. When applying Gauss-Seidel, doubling the number of smoothing steps at each level halves the number of iterations needed with p-multigrid. For ILUT, this behaviour is less noticeable, as the number of iterations is already relatively low. The h-independence and p-dependence when adopting Gauss-Seidel as a smoother is further illustrated in Figure 7. Here, the normalised residual is shown for different values of h and p. Clearly, the performance of the p-multigrid deteriorates for higher values of p. 6

17 Table 4: Number of V-cycles needed for convergence for the first benchmark with p- multigrid, ν = 2. p = 2 ILUT GS p = 3 ILUT GS p = 4 ILUT GS h = h = h = h = h = h = h = h = h = h = h = h = Table 5: Number of V-cycles needed for convergence for the first benchmark with p- multigrid, ν = 4. p = 2 ILUT GS p = 3 ILUT GS p = 4 ILUT GS h = h = h = h = h = h = h = h = h = h = h = h = Gauss-Seidel (p=3) Gauss-Seidel (h=2 5 ) Normalised Residual h = 2 4 h = 2 5 h = 2 6 Normalised Residual p = 2 p = 3 p = V-cycles V-cycles Figure 7: Normalised residual for different values of p and h respectively. For the second benchmark, the number of V-cycles needed for convergence are shown in Table 6. The use of Gauss-Seidel leads to a non-converging multigrid method for all numerical experiments. On the other hand, the number of iterations needed when using ILUT as a smoother increases only slightly compared to the first benchmark. 7

18 Table 6: Number of iterations needed for convergence for the second benchmark with p-multigrid, ν = 2. p = 2 ILUT GS p = 3 ILUT GS p = 4 ILUT GS h = h = h = h = h = h = h = h = h = h = h = h = As an alternative, the p-multigrid method can be applied as a preconditioner within a Conjugate Gradient method. In the preconditioning phase of each iteration, a single V-cycle is applied. The number of iterations needed for convergence using both type of smoothers for the first benchmark can be found in Table 7. Since (forward) Gauss-Seidel, which has been adopted in the previous experiments, is not symmetric, symmetric Gauss-Seidel (SGS) is used as a smoother instead. The number of iterations needed when applying symmetric Gauss-Seidel is significantly lower compared to the number of p-multigrid V-cycles, especially for higher values of p. However, a dependence of the iteration numbers on p is still present. When adopting ILUT as a smoother, the number of iterations is identical to the number of p-multigrid V-cycles for all configurations. Hence, h- and p-independence is also observed when applying p-multigrid as a preconditioner and ILUT as smoother. Table 7: Number of iterations needed for convergence for the first benchmark with PCG, ν = 2. p = 2 ILUT SGS p = 3 ILUT SGS p = 4 ILUT SGS h = h = h = h = h = h = h = h = h = h = h = h = Similar results are obtained for the second benchmark, as shown in Table 8. Adopting ILUT as a smoother leads to h- and p-independence of the resulting preconditioned CG method, while p-dependence is observed when using symmetric Gauss-Seidel as a smoother. As discussed in Section 3, different multigrid schemes can be applied to solve the resulting linear system of equations. Results obtained when adopting a 8

19 Table 8: Number of iterations needed for convergence for the second benchmark with PCG, ν = 2. p = 2 ILUT SGS p = 3 ILUT SGS p = 4 ILUT SGS h = h = h = h = h = h = h = h = h = h = h = h = W-cycle instead of a V-cycle are presented for both benchmarks in Table 9 and, respectively. Here, the approximation order is fixed to p = 3. Note that for all configurations, the number of iterations needed for convergence is identical. However, since the computational costs per cycle is lower for V-cycles, they are considered throughout the rest of this paper. Table 9: Number of iterations needed for different cycle types for the first benchmark. ILUT GS p = 3 V(2,2) W(2,2) p = 3 V(2,2) W(2,2) h = h = h = h = h = h = h = h = Table : Number of iterations needed for different cycle types for the second benchmark. ILUT GS p = 3 V(2,2) W(2,2) p = 3 V(2,2) W(2,2) h = h = 2 4 h = h = 2 5 h = h = 2 6 h = h = 2 7 ILUT as a preconditioner To investigate the quality of the proposed p-multigrid method in more detail, results are compared using ILUT as a preconditioner within a Conjugate Gradient method. The number of iterations with ILUT as a preconditioner for the first benchmark are shown in Table. As expected, the number of 9

20 CG iterations roughly doubles when the meshwidth h is halved. The number of iterations needed with p-multigrid (with ILUT as a smoother) as a preconditioner is independent of h. Results obtained for the second benchmark are shown in Table 2. As with the first benchmark, the number of CG iterations approximately doubles when h is halved in case ILUT is applied as a preconditioner. Table : Number of iterations needed for convergence for the first benchmark using p-multigrid (pmg) or ILUT as a preconditioner for a CG method, ν = 2. p = 2 pmg ILUT p = 3 pmg ILUT p = 4 pmg ILUT h = h = h = 2 4 h = h = h = h = h = h = h = h = h = Table 2: Number of iterations needed for convergence for the second benchmark using p-multigrid (pmg) or ILUT as a preconditioner for a CG method, ν = 2. p = 2 pmg ILUT p = 3 pmg ILUT p = 4 pmg ILUT h = h = h = h = h = h = h = h = h = h = h = h = Comparison h- and hp-multigrid To assess the quality of the coarse grid correction in more detail, results are compared with h- and hp-multigrid methods. Compared to the proposed p-multigrid method, only the way in which the hierarchy is constructed differs. For the h-multigrid method, coarsening in h is applied, while for hpmultigrid coarsening in h and p is applied simultaneously. Hence, all other components (i.e. prolongation and restriction) are identical for all multigrid methods. Results obtained for both benchmarks with the different coarsening strategies for different values of h and p are shown in Table 3 and Table 4. For all numerical experiments, the number of iterations needed with h- and hp-multigrid are comparable. Note that, for the first benchmark, the number of iterations decreases for increasing values of p and depends on the mesh width h. 2

21 Table 3: Comparison of p-multigrid with h- and hp-multigrid for the first benchmark, ν = 2. p = 2 p h hp p = 3 p h hp p = 4 p h hp h = h = h = 2 4 h = h = h = h = h = h = h = h = h = Table 4: Comparison of p-multigrid with h- and hp-multigrid for the second benchmark, ν = 2. p = 2 p h hp p = 3 p h hp p = 4 p h hp h = h = h = h = h = h = h = h = h = h = h = h = For both benchmarks and all configurations, the number of iterations needed for convergence with p-multigrid is significantly lower compared to both h- multigrid and hp-multigrid. The obtained results indicate that coarsening in p is much more effective compared to the alternative coarsening strategies. CPU times Besides iteration numbers, computational times have been determined when adopting both Gauss-Seidel and ILUT as a smoother within p-multigrid. A serial implementation is considered on a Intel(R) Xeon(R) E5-2687W CPU (3.GHz). Table 5 presents the CPU times for different values of h and p. For all configurations, the use of ILUT as a smoother significantly reduces the CPU time needed before convergence has been reached. Table 5: Computational times (in seconds) for convergence with p-multigrid for the first benchmark, ν = 2. p = 2 ILUT GS p = 3 ILUT GS p = 4 ILUT GS h = h = h = h = h = h = h = h = h = h = h = h =

22 By combining Table 4 and 5, an estimate for the difference in computational time of applying a single smoothing step can be derived. A reduction of the iterations with a factor of γ when applying ILUT as a smoother results in a reduction of the computational time of approximately γ. Hence, applying a 2 smoothing step with ILUT is approximately twice as expensive compared to Gauss-Seidel. For completeness, the normalized CPU times obtained for the second benchmark are presented in Table 6, showing the same behaviour when using ILUT as a smoother. Table 6: Computational times (in seconds) for convergence with p-multigrid for the second benchmark, ν = 2. p = 2 ILUT GS p = 3 ILUT GS p = 4 ILUT GS h = h = h = h = h = h = h = h = h = h = h = h = Since the number of iterations needed with the CG method using ILUT as a preconditioner is relatively low (see Table and 2), CPU times have also been determined using both symmetric Gauss-Seidel and ILUT as a preconditioner. Results for both benchmarks are presented in Table 7 and Table 8. For most of the configurations, the use of ILUT as a preconditioner leads to similar CPU times compared to the use of symmetric Gauss-Seidel. The CPU time needed with ILUT as a preconditioner increases approximately with a factor of 8 when the meshwidth is halved. This increase is expected, as the number of degrees of freedom increases with a factor of 4 and twice as many iterations are needed for convergence. As a consequence, CG preconditioned with ILUT becomes less competitive for smaller values of h compared to the use of p-multigrid (with ILUT as a smoother). Table 7: Computational times (in seconds) for convergence with PCG for the first benchmark. p = 2 ILUT SGS p = 3 ILUT SGS p = 4 ILUT SGS h = h = h = h = h = h = h = h = h = h = h = h =

23 Table 8: Computational times (in seconds) for convergence with PCG for the second benchmark. p = 2 ILUT SGS p = 3 ILUT SGS p = 4 ILUT SGS h = h = h = h = h = h = h = h = h = h = h = h = Conclusions In this paper, we presented a p-multigrid method that uses a smoother based on an ILUT factorization. In contrast to classical smoothers (i.e. Gauss-Seidel), the reduction factors of the general eigenvectors associated with high-frequency modes do not increase for higher values of p. This results in asymptotic convergence factors which are independent of both the mesh width h and approximation order p. Numerical results, obtained for the Poisson equation in 2D on a quarter annulus and the convection-diffusion-reaction equation on the unit square, have been presented when using p-multigrid as a stand-alone solver or as a preconditioner within a CG method. Furthermore, different cycle types have been considered (i.e. V- and W-cycles). For all configurations, the number of iterations needed when using ILUT as a smoother are significantly lower compared to the use of Gauss-Seidel. The quality of the coarsening strategy adopted in p-multigrid has been compared with the one in both h- and hpmultigrid methods. Results indicate that the coarse grid correction with p-multigrid is more effective compared to the other coarsening strategies. Finally, CPU times have been presented, showing a significant improvement when adopting ILUT as a smoother. Future research will focus on the application of p-multigrid methods for higher-order partial differential equations (i.e. biharmonic equation), where the use of basis functions with high continuity is necessary. Furthermore, using the proposed p multigrid method on multipatches will be investigated. Finally, the multigrid method can be applied within a HPC framework. Here, the ILUT smoother can easily be parallelized using colouring, as frequently incorporated in multiplicative Schwarz methods [28]. 23

24 References [] T.J.R. Hughes, J.A. Cottrell and Y.Bazilevs. Isogeometric analysis: CAD, f inite elements, NURBS, exact geometry and mesh ref inement. Computer Methods in Applied Mechanics and Engineering, 94(39-4): , 25 [2] T.J.R. Hughes, A. Reali and G. Sangalli, Duality and unified analysis of discrete approximations in structural dynamics and wave propagation: Comparison of p-method finite elements with k-method NURBS. Computer Methods in Applied Mechanics and Engineering, 97(49-5): , 28 [3] J.A. Cottrell, A. Reali, Y.Bazilevs and T.J.R. Hughes. Isogeometric analysis of structural vibrations. Computer Methods in Applied Mechanics and Engineering, 95(4-43): , 26 [4] Y. Bazilevs, V.M. Calo, Y. Zhang and T.J.R. Hughes. Isogeometric Fluid-structure Interaction Analysis with Applications to Arterial Blood Flow. Computational Mechanics, 38(4-5): 3-322, 26 [5] W.A. Wall, M.A. Frenzel and C. Cyron. Isogeometric structural shape optimization. Computer Methods in Applied Mechanics and Engineering, 97(33-4): , 28 [6] K.J. Fidkowski, T.A. Oliver, J. LU and D.L. Darmofal. p-multigrid solution of high-order discontinuous Galerkin discretizations of the compressible Navier-Stokes equations. Journal of Computational Physics, 27(): 92-3, 25 [7] H. Luo, J.D. Baum and R. Löhner. A p-multigrid discontinuous Galerkin method for the Euler equations on unstructured grids. Journal of Computational Physics, 2(2): , 26 [8] H. Luo, J. D. Baum, and R. Löhner. Fast p-multigrid Discontinuous Galerkin Method for Compressible Flows at All Speeds, AIAA Journal, 46(3): , 28 [9] P. van Slingerland and C. Vuik. Fast linear solver for diffusion problems with applications to pressure computation in layered domains. Computational Geosciences, 8(3-4): , 24 24

25 [] B. Helenbrook, D. Mavriplis and H. Atkins. Analysis of p-multigrid for Continuous and Discontinuous Finite Element Discretizations, 6 th AIAA Computational Fluid Dynamics Conference, Fluid Dynamics and Co-located Conferences [] R. Tielen, M. Möller and C. Vuik. Efficient multigrid based solvers for Isogeometric Analysis.. Proceedings of the 6 th European Conference on Computational Mechanics and the 7 th European Conference on Computational Fluid Dynamics, Glasgow, UK. [2] Y. Saad, ILUT: A dual threshold incomplete LU factorization, Numerical Linear Algebra with Applications, (4): , 994. [3] G. Sangalli and M. Tani. Isogeometric preconditioners based on fast solvers for the Sylvester equation. SIAM Journal on Scientific Computing, 38(6): , 26 [4] L. Beirao da Veiga, D. Cho. L.F. Pavarino and S.Scacchi. Overlapping Schwarz methods for isogeometric analysis. SIAM Journal on Numerical Analysis, 5(3): , 22 [5] K.P.S. Gahalaut, J.K. Kraus and S.K. Tomar. Multigrid methods for isogeometric discretizations. Computer Methods in Applied Mechanics and Engineering, 253: , 23 [6] M. Donatelli, C. Garoni, C. Manni, S. Capizzano and H. Speleers. Symbol-based multigrid methods for Galerkin B-spline isogeometric analysis. SIAM Journal on Numerical Analysis, 55(): 3-62, 27 [7] C. Hofreither, S. Takacs and W. Zulehner. A robust multigrid method for Isogeometric Analysis in two dimensions using boundary correction. Computer methods in Applied Mechanics and Engineering, 36: 22-42, 27 [8] A. de la Riva, C. Rodrigo and F. Gaspar. An efficient multigrid solver for isogeometric analysis. arxiv: v [9] C. De Boor. A practical guide to splines. st edn. Springer-verlag, New York,

26 [2] S.C. Brenner and L.R. Scott, The mathematical theory of finite element methods, Texts Applied Mathematics, 5, Springer, New York, 994 [2] W.L. Briggs, V. E. Henson and S.F. McCormick, A Multigrid Tutorial 2nd edition, SIAM, Philadelphia, 2. [22] R.S. Sampath and G. Biros, A parallel geometric multigrid method for f inite elements on octree meshes., SIAM Journal on Scientific Computing, 32(3): , 2 [23] G. Guennebaud, J. Benoît et al., Eigen v3, 2 [24] Y. Saad. SPARSKIT: a basic tool kit for sparse matrix computations. 994 [25] C. Hofreither and W. Zulehner, Spectral Analysis of Geometric Multigrid Methods for Isogeometric Analysis., Numerical Methods and Applications, 8962: 23-29, 25 [26] U. Trottenberg, C. Oosterlee and A. Schüller. Multigrid, Academic Press, 2 [27] J. Nitsche. Uber ein Variations zur Lösung von Dirichlet-Problemen bei Verwendung von Teilräumen die keinen Randbedingungen unterworfen sind. Abhandlungen aus dem mathematischen Seminar der Universität Hamburg, 36(): 9-5, 97 [28] E. Chow and A. Patel, Fine-Grained Parallel Incomplete LU Factorization. SIAM Journal on Scientific Computing, 37(2): 69-93, 25 26

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

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

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

Geometric Multigrid Methods

Geometric Multigrid Methods 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 Ideas

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

Isogeometric Analysis:

Isogeometric Analysis: Isogeometric Analysis: some approximation estimates for NURBS L. Beirao da Veiga, A. Buffa, Judith Rivas, G. Sangalli Euskadi-Kyushu 2011 Workshop on Applied Mathematics BCAM, March t0th, 2011 Outline

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

An Introduction to the Discontinuous Galerkin Method

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

More information

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

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

Key words. preconditioned conjugate gradient method, saddle point problems, optimal control of PDEs, control and state constraints, multigrid method

Key words. preconditioned conjugate gradient method, saddle point problems, optimal control of PDEs, control and state constraints, multigrid method PRECONDITIONED CONJUGATE GRADIENT METHOD FOR OPTIMAL CONTROL PROBLEMS WITH CONTROL AND STATE CONSTRAINTS ROLAND HERZOG AND EKKEHARD SACHS Abstract. Optimality systems and their linearizations arising in

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

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

Discrete Projection Methods for Incompressible Fluid Flow Problems and Application to a Fluid-Structure Interaction

Discrete Projection Methods for Incompressible Fluid Flow Problems and Application to a Fluid-Structure Interaction Discrete Projection Methods for Incompressible Fluid Flow Problems and Application to a Fluid-Structure Interaction Problem Jörg-M. Sautter Mathematisches Institut, Universität Düsseldorf, Germany, sautter@am.uni-duesseldorf.de

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

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

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

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

More information

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

The Conjugate Gradient Method

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

More information

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

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

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

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

More information

An Efficient Low Memory Implicit DG Algorithm for Time Dependent Problems

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

More information

Overlapping Schwarz preconditioners for Fekete spectral elements

Overlapping Schwarz preconditioners for Fekete spectral elements Overlapping Schwarz preconditioners for Fekete spectral elements R. Pasquetti 1, L. F. Pavarino 2, F. Rapetti 1, and E. Zampieri 2 1 Laboratoire J.-A. Dieudonné, CNRS & Université de Nice et Sophia-Antipolis,

More information

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

Research Article Evaluation of the Capability of the Multigrid Method in Speeding Up the Convergence of Iterative Methods

Research Article Evaluation of the Capability of the Multigrid Method in Speeding Up the Convergence of Iterative Methods International Scholarly Research Network ISRN Computational Mathematics Volume 212, Article ID 172687, 5 pages doi:1.542/212/172687 Research Article Evaluation of the Capability of the Multigrid Method

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

JOHANNES KEPLER UNIVERSITY LINZ. Institute of Computational Mathematics

JOHANNES KEPLER UNIVERSITY LINZ. Institute of Computational Mathematics JOHANNES KEPLER UNIVERSITY LINZ Institute of Computational Mathematics Robust Multigrid for Isogeometric Analysis Based on Stable Splittings of Spline Spaces Clemens Hofreither Institute of Computational

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

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

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

Numerical Programming I (for CSE)

Numerical Programming I (for CSE) Technische Universität München WT 1/13 Fakultät für Mathematik Prof. Dr. M. Mehl B. Gatzhammer January 1, 13 Numerical Programming I (for CSE) Tutorial 1: Iterative Methods 1) Relaxation Methods a) Let

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

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

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

More information

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

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

Condition number estimates for matrices arising in the isogeometric discretizations

Condition number estimates for matrices arising in the isogeometric discretizations www.oeaw.ac.at Condition number estimates for matrices arising in the isogeometric discretizations K. Gahalaut, S. Tomar RICAM-Report -3 www.ricam.oeaw.ac.at Condition number estimates for matrices arising

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

Spectral element agglomerate AMGe

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

More information

Multigrid absolute value preconditioning

Multigrid absolute value preconditioning Multigrid absolute value preconditioning Eugene Vecharynski 1 Andrew Knyazev 2 (speaker) 1 Department of Computer Science and Engineering University of Minnesota 2 Department of Mathematical and Statistical

More information

An introduction to Isogeometric Analysis

An introduction to Isogeometric Analysis An introduction to Isogeometric Analysis A. Buffa 1, G. Sangalli 1,2, R. Vázquez 1 1 Istituto di Matematica Applicata e Tecnologie Informatiche - Pavia Consiglio Nazionale delle Ricerche 2 Dipartimento

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

Numerical Methods I Non-Square and Sparse Linear Systems

Numerical Methods I Non-Square and Sparse Linear Systems Numerical Methods I Non-Square and Sparse Linear Systems Aleksandar Donev Courant Institute, NYU 1 donev@courant.nyu.edu 1 MATH-GA 2011.003 / CSCI-GA 2945.003, Fall 2014 September 25th, 2014 A. Donev (Courant

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

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

A Hybrid Method for the Wave Equation. beilina

A Hybrid Method for the Wave Equation.   beilina A Hybrid Method for the Wave Equation http://www.math.unibas.ch/ beilina 1 The mathematical model The model problem is the wave equation 2 u t 2 = (a 2 u) + f, x Ω R 3, t > 0, (1) u(x, 0) = 0, x Ω, (2)

More information

DELFT UNIVERSITY OF TECHNOLOGY

DELFT UNIVERSITY OF TECHNOLOGY DELFT UNIVERSITY OF TECHNOLOGY REPORT 10-19 Fast Iterative Methods for Discontinuous Galerin Discretizations for Elliptic PDEs P. van Slingerland, and C. Vui ISSN 1389-650 Reports of the Department of

More information

2.29 Numerical Fluid Mechanics Spring 2015 Lecture 9

2.29 Numerical Fluid Mechanics Spring 2015 Lecture 9 Spring 2015 Lecture 9 REVIEW Lecture 8: Direct Methods for solving (linear) algebraic equations Gauss Elimination LU decomposition/factorization Error Analysis for Linear Systems and Condition Numbers

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 Algorithms for High-Order Discontinuous Galerkin Discretizations of the Compressible Navier-Stokes Equations

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

More information

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

Lehrstuhl für Informatik 10 (Systemsimulation)

Lehrstuhl für Informatik 10 (Systemsimulation) FRIEDRICH-ALEXANDER-UNIVERSITÄT ERLANGEN-NÜRNBERG INSTITUT FÜR INFORMATIK (MATHEMATISCHE MASCHINEN UND DATENVERARBEITUNG) Lehrstuhl für Informatik 10 (Systemsimulation) Comparison of two implementations

More information

The solution of the discretized incompressible Navier-Stokes equations with iterative methods

The solution of the discretized incompressible Navier-Stokes equations with iterative methods The solution of the discretized incompressible Navier-Stokes equations with iterative methods Report 93-54 C. Vuik Technische Universiteit Delft Delft University of Technology Faculteit der Technische

More information

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

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

More information

Lecture 18 Classical Iterative Methods

Lecture 18 Classical Iterative Methods Lecture 18 Classical Iterative Methods MIT 18.335J / 6.337J Introduction to Numerical Methods Per-Olof Persson November 14, 2006 1 Iterative Methods for Linear Systems Direct methods for solving Ax = b,

More information

6. Iterative Methods for Linear Systems. The stepwise approach to the solution...

6. Iterative Methods for Linear Systems. The stepwise approach to the solution... 6 Iterative Methods for Linear Systems The stepwise approach to the solution Miriam Mehl: 6 Iterative Methods for Linear Systems The stepwise approach to the solution, January 18, 2013 1 61 Large Sparse

More information

A greedy strategy for coarse-grid selection

A greedy strategy for coarse-grid selection A greedy strategy for coarse-grid selection S. MacLachlan Yousef Saad August 3, 2006 Abstract Efficient solution of the very large linear systems that arise in numerical modelling of real-world applications

More information

Scientific Computing WS 2018/2019. Lecture 9. Jürgen Fuhrmann Lecture 9 Slide 1

Scientific Computing WS 2018/2019. Lecture 9. Jürgen Fuhrmann Lecture 9 Slide 1 Scientific Computing WS 2018/2019 Lecture 9 Jürgen Fuhrmann juergen.fuhrmann@wias-berlin.de Lecture 9 Slide 1 Lecture 9 Slide 2 Simple iteration with preconditioning Idea: Aû = b iterative scheme û = û

More information

Fine-grained Parallel Incomplete LU Factorization

Fine-grained Parallel Incomplete LU Factorization Fine-grained Parallel Incomplete LU Factorization Edmond Chow School of Computational Science and Engineering Georgia Institute of Technology Sparse Days Meeting at CERFACS June 5-6, 2014 Contribution

More information

Robust Preconditioned Conjugate Gradient for the GPU and Parallel Implementations

Robust Preconditioned Conjugate Gradient for the GPU and Parallel Implementations Robust Preconditioned Conjugate Gradient for the GPU and Parallel Implementations Rohit Gupta, Martin van Gijzen, Kees Vuik GPU Technology Conference 2012, San Jose CA. GPU Technology Conference 2012,

More information

Algebraic Multigrid Preconditioners for Computing Stationary Distributions of Markov Processes

Algebraic Multigrid Preconditioners for Computing Stationary Distributions of Markov Processes Algebraic Multigrid Preconditioners for Computing Stationary Distributions of Markov Processes Elena Virnik, TU BERLIN Algebraic Multigrid Preconditioners for Computing Stationary Distributions of Markov

More information

Algebraic multigrid and multilevel methods A general introduction. Outline. Algebraic methods: field of application

Algebraic multigrid and multilevel methods A general introduction. Outline. Algebraic methods: field of application Algebraic multigrid and multilevel methods A general introduction Yvan Notay ynotay@ulbacbe Université Libre de Bruxelles Service de Métrologie Nucléaire May 2, 25, Leuven Supported by the Fonds National

More information

Linear Solvers. Andrew Hazel

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

More information

AN HELMHOLTZ ITERATIVE SOLVER FOR THE THREE-DIMENSIONAL SEISMIC IMAGING PROBLEMS?

AN HELMHOLTZ ITERATIVE SOLVER FOR THE THREE-DIMENSIONAL SEISMIC IMAGING PROBLEMS? European Conference on Computational Fluid Dynamics ECCOMAS CFD 2006 P. Wesseling, E. Oñate, J. Périaux (Eds) c TU Delft, Delft The Netherlands, 2006 AN HELMHOLTZ ITERATIVE SOLVER FOR THE THREE-DIMENSIONAL

More information

Multigrid and Multilevel Preconditioners for Computational Photography

Multigrid and Multilevel Preconditioners for Computational Photography Multigrid and Multilevel Preconditioners for Computational Photography Dilip Krishnan Department of Computer Science New York University dilip@cs.nyu.edu Richard Szeliski Interactive Visual Media Group

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

Optimizing Runge-Kutta smoothers for unsteady flow problems

Optimizing Runge-Kutta smoothers for unsteady flow problems Optimizing Runge-Kutta smoothers for unsteady flow problems Philipp Birken 1 November 24, 2011 1 Institute of Mathematics, University of Kassel, Heinrich-Plett-Str. 40, D-34132 Kassel, Germany. email:

More information

OUTLINE ffl CFD: elliptic pde's! Ax = b ffl Basic iterative methods ffl Krylov subspace methods ffl Preconditioning techniques: Iterative methods ILU

OUTLINE ffl CFD: elliptic pde's! Ax = b ffl Basic iterative methods ffl Krylov subspace methods ffl Preconditioning techniques: Iterative methods ILU Preconditioning Techniques for Solving Large Sparse Linear Systems Arnold Reusken Institut für Geometrie und Praktische Mathematik RWTH-Aachen OUTLINE ffl CFD: elliptic pde's! Ax = b ffl Basic iterative

More information

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

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

More information

Incomplete Cholesky preconditioners that exploit the low-rank property

Incomplete Cholesky preconditioners that exploit the low-rank property anapov@ulb.ac.be ; http://homepages.ulb.ac.be/ anapov/ 1 / 35 Incomplete Cholesky preconditioners that exploit the low-rank property (theory and practice) Artem Napov Service de Métrologie Nucléaire, Université

More information

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

Benchmarking high order finite element approximations for one-dimensional boundary layer problems

Benchmarking high order finite element approximations for one-dimensional boundary layer problems Benchmarking high order finite element approximations for one-dimensional boundary layer problems Marcello Malagù,, Elena Benvenuti, Angelo Simone Department of Engineering, University of Ferrara, Italy

More information

ISOGEOMETRIC METHODS IN STRUCTURAL DYNAMICS AND WAVE PROPAGATION

ISOGEOMETRIC METHODS IN STRUCTURAL DYNAMICS AND WAVE PROPAGATION COMPDYN 29 ECCOMAS Thematic Conference on Computational Methods in Structural Dynamics and Earthquake Engineering M. Papadrakakis, N.D. Lagaros, M. Fragiadakis (eds.) Rhodes, Greece, 22-24 June 29 ISOGEOMETRIC

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

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

A multilevel algorithm for inverse problems with elliptic PDE constraints

A multilevel algorithm for inverse problems with elliptic PDE constraints A multilevel algorithm for inverse problems with elliptic PDE constraints George Biros and Günay Doǧan School of Engineering and Applied Science, University of Pennsylvania, Philadelphia, PA 19104 E-mail:

More information

Lecture 8: Fast Linear Solvers (Part 7)

Lecture 8: Fast Linear Solvers (Part 7) Lecture 8: Fast Linear Solvers (Part 7) 1 Modified Gram-Schmidt Process with Reorthogonalization Test Reorthogonalization If Av k 2 + δ v k+1 2 = Av k 2 to working precision. δ = 10 3 2 Householder Arnoldi

More information

A fast method for the solution of the Helmholtz equation

A fast method for the solution of the Helmholtz equation A fast method for the solution of the Helmholtz equation Eldad Haber and Scott MacLachlan September 15, 2010 Abstract In this paper, we consider the numerical solution of the Helmholtz equation, arising

More information

Lab 1: Iterative Methods for Solving Linear Systems

Lab 1: Iterative Methods for Solving Linear Systems Lab 1: Iterative Methods for Solving Linear Systems January 22, 2017 Introduction Many real world applications require the solution to very large and sparse linear systems where direct methods such as

More information

Scientific Computing WS 2017/2018. Lecture 18. Jürgen Fuhrmann Lecture 18 Slide 1

Scientific Computing WS 2017/2018. Lecture 18. Jürgen Fuhrmann Lecture 18 Slide 1 Scientific Computing WS 2017/2018 Lecture 18 Jürgen Fuhrmann juergen.fuhrmann@wias-berlin.de Lecture 18 Slide 1 Lecture 18 Slide 2 Weak formulation of homogeneous Dirichlet problem Search u H0 1 (Ω) (here,

More information

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

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

More information

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

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

More information

Finite Element Methods with Linear B-Splines

Finite Element Methods with Linear B-Splines Finite Element Methods with Linear B-Splines K. Höllig, J. Hörner and M. Pfeil Universität Stuttgart Institut für Mathematische Methoden in den Ingenieurwissenschaften, Numerik und geometrische Modellierung

More information

Sparse Matrix Techniques for MCAO

Sparse Matrix Techniques for MCAO Sparse Matrix Techniques for MCAO Luc Gilles lgilles@mtu.edu Michigan Technological University, ECE Department Brent Ellerbroek bellerbroek@gemini.edu Gemini Observatory Curt Vogel vogel@math.montana.edu

More information

Scientific Computing: An Introductory Survey

Scientific Computing: An Introductory Survey Scientific Computing: An Introductory Survey Chapter 11 Partial Differential Equations Prof. Michael T. Heath Department of Computer Science University of Illinois at Urbana-Champaign Copyright c 2002.

More information

PREPRINT 2010:25. Fictitious domain finite element methods using cut elements: II. A stabilized Nitsche method ERIK BURMAN PETER HANSBO

PREPRINT 2010:25. Fictitious domain finite element methods using cut elements: II. A stabilized Nitsche method ERIK BURMAN PETER HANSBO PREPRINT 2010:25 Fictitious domain finite element methods using cut elements: II. A stabilized Nitsche method ERIK BURMAN PETER HANSBO Department of Mathematical Sciences Division of Mathematics CHALMERS

More information

Implicit Solution of Viscous Aerodynamic Flows using the Discontinuous Galerkin Method

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

More information

Scientific Computing II

Scientific Computing II Technische Universität München ST 008 Institut für Informatik Dr. Miriam Mehl Scientific Computing II Final Exam, July, 008 Iterative Solvers (3 pts + 4 extra pts, 60 min) a) Steepest Descent and Conjugate

More information

A Domain Decomposition Based Jacobi-Davidson Algorithm for Quantum Dot Simulation

A Domain Decomposition Based Jacobi-Davidson Algorithm for Quantum Dot Simulation A Domain Decomposition Based Jacobi-Davidson Algorithm for Quantum Dot Simulation Tao Zhao 1, Feng-Nan Hwang 2 and Xiao-Chuan Cai 3 Abstract In this paper, we develop an overlapping domain decomposition

More information

DELFT UNIVERSITY OF TECHNOLOGY

DELFT UNIVERSITY OF TECHNOLOGY DELFT UNIVERSITY OF TECHNOLOGY REPORT 12-10 Fast linear solver for pressure computation in layered domains P. van Slingerland and C. Vuik ISSN 1389-6520 Reports of the Department of Applied Mathematical

More information

Background. Background. C. T. Kelley NC State University tim C. T. Kelley Background NCSU, Spring / 58

Background. Background. C. T. Kelley NC State University tim C. T. Kelley Background NCSU, Spring / 58 Background C. T. Kelley NC State University tim kelley@ncsu.edu C. T. Kelley Background NCSU, Spring 2012 1 / 58 Notation vectors, matrices, norms l 1 : max col sum... spectral radius scaled integral norms

More information

Course Notes: Week 1

Course Notes: Week 1 Course Notes: Week 1 Math 270C: Applied Numerical Linear Algebra 1 Lecture 1: Introduction (3/28/11) We will focus on iterative methods for solving linear systems of equations (and some discussion of eigenvalues

More information

HW4, Math 228A. Multigrid Solver. Fall 2010

HW4, Math 228A. Multigrid Solver. Fall 2010 HW4, Math 228A. Multigrid Solver Date due 11/30/2010 UC Davis, California Fall 2010 Nasser M. Abbasi Fall 2010 Compiled on January 20, 2019 at 4:13am [public] Contents 1 Problem 1 3 1.1 Restriction and

More information

An Angular Multigrid Acceleration Method for S n Equations with Highly Forward-Peaked Scattering

An Angular Multigrid Acceleration Method for S n Equations with Highly Forward-Peaked Scattering An Angular Multigrid Acceleration Method for S n Equations with Highly Forward-Peaked Scattering Bruno Turcksin & Jean C. Ragusa & Jim E. Morel Texas A&M University, Dept. of Nuclear Engineering Bruno

More information

THE EFFECT OF MULTIGRID PARAMETERS IN A 3D HEAT DIFFUSION EQUATION

THE EFFECT OF MULTIGRID PARAMETERS IN A 3D HEAT DIFFUSION EQUATION Int. J. of Applied Mechanics and Engineering, 2018, vol.23, No.1, pp.213-221 DOI: 10.1515/ijame-2018-0012 Brief note THE EFFECT OF MULTIGRID PARAMETERS IN A 3D HEAT DIFFUSION EQUATION F. DE OLIVEIRA *

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

A PRECONDITIONER FOR THE HELMHOLTZ EQUATION WITH PERFECTLY MATCHED LAYER

A PRECONDITIONER FOR THE HELMHOLTZ EQUATION WITH PERFECTLY MATCHED LAYER European Conference on Computational Fluid Dynamics ECCOMAS CFD 2006 P. Wesseling, E. Oñate and J. Périaux (Eds) c TU Delft, The Netherlands, 2006 A PRECONDITIONER FOR THE HELMHOLTZ EQUATION WITH PERFECTLY

More information

Geometric Multigrid Methods for the Helmholtz equations

Geometric Multigrid Methods for the Helmholtz equations Geometric Multigrid Methods for the Helmholtz equations Ira Livshits Ball State University RICAM, Linz, 4, 6 November 20 Ira Livshits (BSU) - November 20, Linz / 83 Multigrid Methods Aim: To understand

More information

Iterative Methods for Solving A x = b

Iterative Methods for Solving A x = b Iterative Methods for Solving A x = b A good (free) online source for iterative methods for solving A x = b is given in the description of a set of iterative solvers called templates found at netlib: http

More information

Lecture Note 7: Iterative methods for solving linear systems. Xiaoqun Zhang Shanghai Jiao Tong University

Lecture Note 7: Iterative methods for solving linear systems. Xiaoqun Zhang Shanghai Jiao Tong University Lecture Note 7: Iterative methods for solving linear systems Xiaoqun Zhang Shanghai Jiao Tong University Last updated: December 24, 2014 1.1 Review on linear algebra Norms of vectors and matrices vector

More information