Fast solver for fractional differential equations based on Hierarchical Matrices

Size: px
Start display at page:

Download "Fast solver for fractional differential equations based on Hierarchical Matrices"

Transcription

1

2 International Conference on Fractional Differentiation and its Applications, Novi Sad, Seria, July 18-20, 2016 Fast solver for fractional differential equations ased on Hierarchical Matrices Xuan Zhao 2,1, Xiaozhe Hu 3, Wei Cai 1,4, George Em Karniadakis 5 1 Division of Algorithms, Beijing Computational Science Research Center, Beijing, P. R. China 2 Department of Mathematics, Southeast University, Nanjing , P. R. China xuanzhao11@seu.edu.cn; xuanzhao11@gmail.com 3 Department of Mathematics, Tufts University, Medford, MA, USA xiaozhe.hu@tufts.edu 4 Department of Mathematics and Statistics, University of North Carolina at Charlotte, Charlotte, NC, USA wcai@csrc.ac.cn 5 Division of Applied Mathematics, Brown University, Providence, RI, USA george karniadakis@rown.edu Astract A roust and fast solver for the fractional differential equation (FDEs) involving the Riesz fractional derivative is developed using an adaptive finite element method on nonuniform meshes. It is ased on the utilization of hierarchical matrices (H-Matrices) for the representation of the stiffness matrix resulting from the finite element discretization of the FDEs. We employ a geometric multigrid method for the solution of the algeraic system of equations. We comine it with an adaptive algorithm ased on a posteriori error estimation to deal with general-type singularities arising in the solution of the FDEs. Through various test examples we demonstrate the efficiency of the method and the highaccuracy of the numerical solution even in the presence of singularities. To the est of our knowledge, there are currently no other methods for FDEs that resolve singularities accurately at linear complexity as the one we propose here. Key words: Hierarchical Matrices, Riesz derivative, geometric multigrid method, adaptivity, non-smooth solutions, finite element method 1 Introduction Numerical methods for differential equations involving fractional derivatives either in time or space have een studied widely since they have various physical and iological applications [3, 15, 17]. However, as the size of the prolem increases, the time required to solve the final system of equations increases consideraly due to the nonlocality of the

3 X. Zhao, X. Hu, W. Cai, G. E. Karniadakis: Fast solver for FDEs ased on H-Matrices fractional differential operators. Generally, there are two main difficulties in solving space fractional prolems. First, the matrix otained y the numerical discretization is fully populated. This leads to increased storage memory requirements as well as increased solution time. Since the matrix is dense, the memory required to store its coefficients is of order O(N 2 ), where N denotes the numer of unknowns, and the solution of the system requires O(N 3 ) operations if direct solvers are used. Second, the solution of a space fractional prolem has singularities around the oundaries even with smooth input data since the definition involves the integration of weak singular kernels. So far good progress has een made on reducing the computational complexity of the space FDEs for uniform mesh discretizations ased on the oservation that the coefficient matrices are Toeplitz-like if a uniform mesh is employed. This results in efficient matrixvector multiplications [11, 14, 18], which in conjunction with effective preconditioners lead to enhanced efficiency [8, 10, 12]. The multigrid method [4, 9, 14] has also een employed to reduce the computational cost to O(N log(n)). However, to the est of our knowledge, most of the existing fast solvers depend on the Toeplitz-like structure of the matrices, which implies that the underlying meshes have to e uniform. Therefore, the existing efficient solvers cannot e readily applied when a nonuniform mesh is used, including the important case of non-uniform meshes generated y adaptive discretizations employed to deal with singularities. Another effective approach to deal with such singularities is y tuning the appropriate asis, e.g.. in Galerkin and collocation spectral methods. For example, the weighted Jacoi polynomials can e used to accommodate the weak singularity if one has some information aout the solution [5, 19, 20, 21]; the proper choice of the asis results in significant improvement in the accuracy of numerical solutions. However, in the current work we assume that we do not have any information on the non-smoothness of the solution. H-Matrices [6] have een developed over the last twenty years as a powerful datasparse approximation of dense matrices. This representation has een used for solving integral equations and elliptic partial differential equations [1, 2, 7]. The main advantage of H-Matrices are the reduction of storage requirement and efficiency in solving linear system, e.g. when storing a dense matrix, which requires O(N 2 ) units of storage, while H- Matrices provide an approximation requiring only O(N k log(n)) units of storage, where k is a parameter controlling the accuracy of the approximation. In this work, instead of using the Topelitz-like structure of the matrices to reduce the computational complexity, we adapt the H-Matrices representation to approximate the dense matrices arising from the discretization of the FDEs. Our H-Matrices approach does not restrict to the uniform meshes and can e easily generalized to the non-uniform meshes. Therefore, it is suitale for the adaptive finite element method (AFEM) for FDEs. We will show theoretically that the error of such H-Matrices representation decays like O(3 k ) while the storage complexity is O(Nk log(n)). Thanks to the newly designed algorithm for solving the linear system of equations, the new AFEM for FDEs achieves the optimal computational complexity, while it maintains the optimal convergence order. The key to such AFEM algorithm for FDEs is the optimal linear solver we developed ased on H-Matrices representation and the geometric multigrid (GMG) method. The remainder of the paper is structured as follows. The finite element discretization and H-Matrices representation for FDE are discussed in Section 2. The overall AFEM algorithm is discussed in detail in Section 3, and numerical experiments are presented in Section 4 to demonstrate the high efficiency and accuracy of the proposed new method.

4 X. Zhao, X. Hu, W. Cai, G. E. Karniadakis: Fast solver for FDEs ased on H-Matrices 2 Discretization of the prolem ased on H-Matrices representation We consider the following fractional differential equation D α x u(x) = f(x), x (, c), 1 < α < 2, (1) where f L 2 ([, c]) and Dx α denotes the Riesz fractional derivative, sujected to the oundary conditions u() = 0, u(c) = 0. Following the Galerkin approach, we solve equation (1) projected onto the finite dimensional space V := span{ϕ 1,, ϕ N } and V H0 1 ([, c]), where H0 1 ([, c]) is the standard Soolev space on [, c] and {ϕ i } are standard piecewise linear asis functions defined on a mesh = x 0 < x 1 < < x N < x N+1 = c with meshsize h i = x i+1 x i, i = 1, 2,, N. We multiply v V y (1) and integrate over [, c], D α x u(x)ϕ i (x) dx = f(x)ϕ i (x) dx. (2) By integration y parts, we otain the following weak formulation of (1): find u(x) V, such that [ 1 d c ] x ξ 1 α u(ξ) dξ v (x) dx = f(x)v(x) dx, v V 2c(α) dx where c(α) = cos(απ/2)γ(2 α). We rewrite the discrete solution u n = N j=1 u jϕ j V and then the coefficient vector u = (u 1, u 2,, u N ) is the solution of the linear system where and A ij := [ 1 2c(α) d dx f i := Au = f, ] x ξ 1 α ϕ j (ξ) dξ ϕ i(x) dx, (3) ϕ i (x)f(x) dx. (4) The matrix A is dense as all entries are nonzero. Our aim is to approximate A y a matrix à which can e stored in a data-sparse (not necessarily sparse) format. The idea is to replace the kernel S(x, ξ) = x ξ 1 α y a degenerate kernel 2.1 Taylor Expansion of the Kernel k 1 S(x, ξ) = p ν (x)q ν (ξ). (5) ν=0 Let τ := [a, ], σ := [c, d ], τ σ [c, d] [c, d] e a sudomain with the property < c such that the intervals are disjoint: τ σ =. Then the kernel function is nonsingular in τ σ.

5 X. Zhao, X. Hu, W. Cai, G. E. Karniadakis: Fast solver for FDEs ased on H-Matrices Lemma 1 Taylor expansions of the left/right kernel ν x ν x [ (x ξ) 1 α ] ν = ( 1) ν (α + l 2)(x ξ) 1 α ν, [ (ξ x) 1 α ] = l=1 ν (α + l 2)(ξ x) 1 α ν. l=1 Then we can use the truncated Talyor series at x 0 := (a + )/2 to approximate the kernel and eventually otain an approximation of the stiffness matrix, i. e., where S(x, ξ) := k 1 ν=0 [ ν ] 1 (α + l 2)(ξ x 0 ) 1 α ν (x x 0 ) ν := ν! l=1 k 1 p ν (x)q ν (ξ), (6) ν=0 p ν (x) = (x x 0 ) ν, (7) q ν (ξ) = 1 ν (α + l 2)(ξ x 0 ) 1 α ν. ν! (8) l=1 2.2 Low rank approximation of Matrix Blocks If τ σ is admissile, then we can approximate the kernel S in this sudomain y the truncated Taylor series S from (6) and replace the matrix entries A ij y the use of the degenerate kernel S(x, ξ) for the indices (i, j) t s : Ã ij = [ 1 2c(α) d c S(x, ξ)ϕ dx j (ξ) dξ ] ϕ i(x) dx, (9) in which the doule integral is separated into two integrals: [ c ] 1 d c k 1 Ã ij = p ν (x)q ν (ξ)ϕ 2c(α) dx j (ξ) dξ ϕ i(x) dx (10) = 1 2c(α) ν=0 k 1 [ ] [ p ν(x)ϕ i(x) dx ν=0 ] q ν (ξ)ϕ j (ξ) dξ Thus, the sumatrix A t s can e represented in a factorized form A t s = 1 2c(α) CRT, C R t {0,,k 1} s {0,,k 1}, R R where the entries of the matrix factors C and R are C iν := p ν(x)ϕ i(x) dx, R jν := (11) q ν (ξ)ϕ j (ξ) dξ. (12) Now we have the following error estimation for the H-Matrix representation.

6 X. Zhao, X. Hu, W. Cai, G. E. Karniadakis: Fast solver for FDEs ased on H-Matrices Theorem 2 (Element-wise Approximation Error) Let τ := [a, ], σ := [c, d ], < c, x 0 = (a + )/2, and k 2, we have A ij Ãij 1 [ ] 3 [ ] k k(k 1)(h i + h i+1 )(h j + h j+1 ) diam(τ) + 2dist(τ, σ) dist(τ, σ) 8c(α) ( x 0 a + c ) α , x 0 a 2 2dist(τ, σ) diam(τ) (13) where diam(τ) is the diameter of τ and dist(τ, σ) is the distance etween the intervals τ and σ. If dist(τ,σ) diam(τ) 1, we have A ij Ãij 27 1 k(k 1)(h i + h i+1 )(h j + h j+1 ) 64 c(α) ( x 0 a + c ) α 1 x 0 a 2 (3) k. (14) Figure 1: Error in the Froenius norm ( A Ã F, where M F := i j M ij ) mainly depends on the ratio rather than on α. Left: ratio := dist(τ,σ) diam(τ) with diam(τ) the diameter of the interval τ and dist(τ, σ) the distance etween the intervals τ and σ; Right: α (1, 2) is the order of the fractional derivative. [ ] k, In the error estimate (13), we can see that the dominating term is dist(τ,σ) diam(τ) which determines the decaying rate and, thus, the quality of the approximation. If dist(τ, σ) 0, the approximation will degenerate. However, if we require diam(τ) dist(τ, σ) as in the Theorem 2, we can have a nearly uniform ound A ij Ãij = O(3 k ). Moreover, the element-wise error mainly depends on the ratio dist(τ,σ) diam(τ) if we assume diam(τ) dist(τ, σ), and the igger the ratio the etter the approximation. The error decays exponentially with respect to the order k. Figure 1 shows how the error decays with respect to k when we vary the ratio or α; we can see clearly that the error depends strongly on the ratio rather than α, which supports our error estimates.

7 X. Zhao, X. Hu, W. Cai, G. E. Karniadakis: Fast solver for FDEs ased on H-Matrices 3 Adaptive Finite Element Method for Fractional PDEs In this section, we discuss the adaptive finite element method (AFEM) for solving FDEs. We follow the idea of standard AFEM, which is characterized y the following iteration SOLVE ESTIMATE MARK REFINE. Such iteration generates a sequence of discrete solutions converging to the exact one. We want to emphasize that one of the main difficulties of applying the AFEM to the FDEs is the SOLVE step. As usual, the SOLVE module should take the current grid as the input and output the corresponding finite element approximation. Note here that the current grid, in general, is otained y adaptive refinement and, therefore, it is an unstructured grid. To the est of our knowledge, all the existing fast solvers can not e used which makes AFEM infeasile. Our SOLVE module use the hierarchical matrix representation mentioned in Section 2 to assemle the linear system of equations stored in H-Matrix format and we also design efficient GMG method to solve it ased on the H-matrix format. More precisely, adaptive refinement gives us a natural nested unstructured grids ased on which we uild the GMG hierarchy. As usual, the main components of our GMG method are the smoother and prolongation. The latter is defined y the standard inclusion operator etween the grids ecause the grids are nested. For the smoother, we adapt the Gauss-Seidel smoother ut modify it ased on the H-Matrix representation in order to keep the computational complexity optimal. Finally, V-cycle GMG is defined y recursion on coarser grids and it is easy to check the overall computational complexity of our GMG method is O(kN l log N l ) where N l is the numer of the degrees of freedom on level l. Given a grid T l and finite element approximation ũ l V l, the ESTIMATE module computes a posteriori error estimators {η l (ũ l, τ)} τ Tl, which should e computale on each element τ T l and indicate the true error. In this work, we adopt the gradient recovery ased error estimators due to its simplicity and prolem-independence. It is easy to check that the computational complexity of ESTIMATE module is O(N l ) ecause all the computations are done locally on the elements τ and on each element τ, the operations are finite and independent of N l. The MARK module selects elements τ T l whose local error η l (U l, τ) is relatively large and needs to e refined in the refinement. This module is independent of the model prolems and we can directly use the strategies developed for second order elliptic PDEs for FDES here. In this work, we use the so-called Döflers marking strategy. The REFINE module is also prolem independent. It takes the marked elements and current grid T k as inputs and outputs a refined grid T l+1, which will e used as a new grid. In this work, ecause we are only considering the 1D case, the refinement procedure is just isection. Namely, if an element [x l i 1, xl i ] T l is marked, it will e divided into two suintervals [x l i 1, xl i ] and [ xl i, xl i ] y the midpoint xl i = (xl i 1 + xl i )/2. The overall computational cost of each iteration of the AFEM method is O(kN l log N l ) or O(N l log N l ) when k N l. 4 Numerical example Example 1: Solving model prolem (1) with right hand side f(x) = 1 + sin(x).

8 X. Zhao, X. Hu, W. Cai, G. E. Karniadakis: Fast solver for FDEs ased on H-Matrices The aove example we consider here does not have exact solution. However, due to the property of the FDEs, we expect the solution to have singularities near the oundaries, which leads to degenerated convergence rate in the errors of finite element approximations on uniform grids. This is confirmed y the numerical results as shown in Figure 2 for α = 1.5. The convergence rates of the L 2 errors for oth full matrix and H-Matrix approaches are aout 1.24, which reflects the singularity of the solution and the necessity for the AFEM method. These comparisons show that the AFEM algorithm can achieve etter accuracy with less computational cost, which demonstrates the effectiveness of the AFEM algorithm for FDEs. Figure 2: Convergence rates for full matrix and H-Matrix representation on uniform grids. Next we apply the AFEM algorithm to solve Example 1. The results are shown in Figure 3. We can see that, using the AFEM method, the optimal convergence rates of oth L 2 error and L have een recovered for α = 1.5. This demonstrates the effectiveness and roustness of the our AFEM methods. In Figure 4, we plot the numerical solutions on adaptive meshes for α = 1.5. The adaptive refinement near the oundary points demonstrates that our error estimate captures the singularities well and overall roustness of our AFEM algorithm. As mentioned in Section 3, one distinct feature of our proposed AFEM method is that in the SOLVE module, the H-Matrix representation and the multigrid method are used, hence providing nearly optimal computational complexity O(N log N). In Figure 5, we show the CPU time of the GMG method for the H-Matrix used in the SOLVE module for different fractional orders. We can see that, for all cases, the computational complexity is optimal, which confirms our expectation. Next we compare the computational costs of FEM on uniform grids and AFEM. The results are shown in Tale 1. Here DoFs denotes the degrees of freedom. For AFEM, we start the adaptive refinement from a coarse grid of size 32. For AFEM, T-DoFs denotes the sum of the DoFs of all the adaptive grids starting from the coarse grid to current adaptive grid and T-Time denotes the total CPU time of the whole AFEM algorithm while Time denotes the CPU time of solving the FDES on the current adaptive grid. For FEM on a uniform grid of size 16, 383, the L 2 error is and the CPU time is aout seconds. However, if we use AFEM, solving the prolem on an adaptive

9 X. Zhao, X. Hu, W. Cai, G. E. Karniadakis: Fast solver for FDEs ased on H-Matrices Figure 3: Convergence rates of FEM on uniform grid and AFEM for α = 1.5. Figure 4: Numerical solution on adaptive meshes. Figure 5: CPU time of GMG method on nonuniform grid grid of size 1, 059 leads to accuracy in the L 2 norm. This means that the AFEM achieves aout 2.7 times etter results using a 15.5 times smaller grid. Even the total DoFs, which is 6, 382, is aout 2.6 times smaller than the size of the uniform grid. The speed up is aout 18.3 if we only consider the final adaptive grid and is aout 3.2 if we consider the whole AFEM procedure. In Figure 6, we report the reakdown of computational cost of the AFEM on the finest adaptive grid. As we can see, the SOLVE module (Assemling and H-Matrix & MG Solve) dominates the whole AFEM algorithm. The computational cost of the other three modules, ESTIMATE module (Estimate Error), MARK module (Mark), and REFINE module (Adaptive Refine), are roughly the same and could e ignored compared with the SOLVE module. This is mainly ecause our experiments are in 1D in the current paper. We can expect those three modules to ecome more and more time consuming in 2D and 3D cases. However, the SOLVE module should still e the dominant module in terms of computational cost and that is why we introduce the H-Matrix and the GMG method together to make sure that we achieve optimal computational complexity.

10 X. Zhao, X. Hu, W. Cai, G. E. Karniadakis: Fast solver for FDEs ased on H-Matrices Tale 1: (α = 1.5): Computational cost comparison etween FEM on uniform grids and AFEM. (The time unit is second) Uniform Adaptive L 2 error DoFs Time L 2 error DoFs Time T-DoFs T-Time , , , , , , Figure 6: (α = 1.5): Breakdown of CPU time of AFEM 5 Conclusions In this paper, we presented an adaptive FEM (AFEM) method for a fractional differential equation with Riesz derivative, targeting in particular non-smooth solutions that they may arise even in the presence of smooth right-hand-sides in the equation. To this end, uniform grids result in suoptimal and in fact su-linear convergence rate, while the AFEM yields optimal second-order accuracy. The demonstrated efficiency of the method is ased on comining two effective ideas, which act synergistically. First, we approximated the singular kernel in the fractional derivative using an H-Matrix representation, and second, we employed a geometric multigrid method with nearly linear overall computational complexity. In the current paper, we developed these ideas for the one-dimensional case ut the greater challenge is to consider higher dimensions, where adaptive refinement has to resolve oth solution singularities and geometric singularities around the oundaries. Acknowledgments This work was supported y the OSD/ARO/MURI on Fractional PDEs for Conservation Laws and Beyond: Theory, Numerics and Applications (W911NF ) and Fundamental Research Funds for the Central Universities.

11 X. Zhao, X. Hu, W. Cai, G. E. Karniadakis: Fast solver for FDEs ased on H-Matrices References [1] Beendorf M., Approximation of oundary element matrices, Numer. Math., 86, , [2] Brm, S., Grasedyck, L., Hyrid cross approximation of integral operators, Numer. Math., 101, , [3] Carpinteri, A., Mainardi, F., Fractals and fractional calculus in continuum mechanics, Springer, 378, [4] Chen, M., wang, Y., Cheng, X., Deng, W., Second-order LOD multigrid method for multidimensional Riesz fractional diffusion equation, BIT Numer. Math., 54, , [5] Chen, S., Shen, J., Wang, L.L., Generalized Jacoi functions and their applications to fractional differential equations, Math. Comp., 85, , [6] Hackusch, W., A sparse matrix arithmetic ased on H-matrices. Part I: Introduction to H-matrices, Computing, 62, , [7] Ho, K.L., Ying, L., Hierarchical interpolative factorization for elliptic operators: differential equations, Comm. Pure. Appl. Math., [8] Jia, J., Wang, H., A preconditioned fast finite volume scheme for a fractional differential equation discretized on a locally refined composite mesh, J. Comput. Phys., 299, , [9] Jiang, Y., Xu, X., Multigrid methods for space fractional partial differential equations, J. Comput. Phys., 302, , [10] Lei, S.L., Sun, H.W., A circulant preconditioner for fractional diffusion equations, J. Comput. Phys., 242, , [11] Lin, F.R., Yang, S.W., Jin, X.Q., Preconditioned iterative methods for fractional diffusion equation, J. Comput. Phys., 256, , [12] Moroney, T., Yang, Q., A anded preconditioner for the two-sided, nonlinear spacefractional diffusion equation, Comput. Math. Appl., 66, , [14] Pang, H.K., Sun, H.W., Multigrid method for fractional diffusion equations, J. Comput. Phys., 231, , [15] Reenshtok, A., Denisov, S., Hnggi, P., Barkai, E., Non-normalizale densities in strong anomalous diffusion: eyond the central limit theorem, Phys. Rev. Lett., 112, , [17] Sun, H., Chen, W., Chen, Y., Variale-order fractional differential operators in anomalous diffusion modeling, Phys. A, 388, , [18] Wang, H., Du, N., A fast finite difference method for three-dimensional timedependent space-fractional diffusion equations and its efficient implementation, J. Comput. Phys., 253, 50 63, [19] Zayernouri, M., Karniadakis, G.E., Fractional spectral collocation method, SIAM J. Sci. Comput., 36, A40 A62, [20] Zeng, F., Zhang, Z., Karniadakis, G.E., A generalized spectral collocation method with tunale accuracy for variale-order fractional differential equations, SIAM J. Sci. Comput., 37, A2710 A2732, [21] Zhao, X., Zhang, Z., Superconvergence points of fractional spectral interpolation, SIAM J. Sci. Comput., 38, A598 A613, 2016.

arxiv: v1 [math.na] 4 Mar 2016

arxiv: v1 [math.na] 4 Mar 2016 ADAPTIVE FINITE ELEMENT METHOD FOR FRACTIONAL DIFFERENTIAL EQUATIONS USING HIERARCHICAL MATRICES XUAN ZHAO, XIAOZHE HU, WEI CAI, AND GEORGE EM KARNIADAKIS arxiv:1603.01358v1 [math.na] 4 Mar 2016 Astract.

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

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

Fast Structured Spectral Methods

Fast Structured Spectral Methods Spectral methods HSS structures Fast algorithms Conclusion Fast Structured Spectral Methods Yingwei Wang Department of Mathematics, Purdue University Joint work with Prof Jie Shen and Prof Jianlin Xia

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

Fractional Spectral and Spectral Element Methods

Fractional Spectral and Spectral Element Methods Fractional Calculus, Probability and Non-local Operators: Applications and Recent Developments Nov. 6th - 8th 2013, BCAM, Bilbao, Spain Fractional Spectral and Spectral Element Methods (Based on PhD thesis

More information

arxiv: v2 [math.na] 2 Apr 2018

arxiv: v2 [math.na] 2 Apr 2018 USING HIERARCHICAL MATRICES IN THE SOLUTION OF THE TIME-FRACTIONAL HEAT EQUATION BY MULTIGRID WAVEFORM RELAXATION XIAOZHE HU, CARMEN RODRIGO, AND FRANCISCO J. GASPAR arxiv:76.7632v2 [math.na] 2 Apr 28

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

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

APPROXIMATING GAUSSIAN PROCESSES

APPROXIMATING GAUSSIAN PROCESSES 1 / 23 APPROXIMATING GAUSSIAN PROCESSES WITH H 2 -MATRICES Steffen Börm 1 Jochen Garcke 2 1 Christian-Albrechts-Universität zu Kiel 2 Universität Bonn and Fraunhofer SCAI 2 / 23 OUTLINE 1 GAUSSIAN PROCESSES

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

Mathematics Research Report No. MRR 003{96, HIGH RESOLUTION POTENTIAL FLOW METHODS IN OIL EXPLORATION Stephen Roberts 1 and Stephan Matthai 2 3rd Febr

Mathematics Research Report No. MRR 003{96, HIGH RESOLUTION POTENTIAL FLOW METHODS IN OIL EXPLORATION Stephen Roberts 1 and Stephan Matthai 2 3rd Febr HIGH RESOLUTION POTENTIAL FLOW METHODS IN OIL EXPLORATION Stephen Roberts and Stephan Matthai Mathematics Research Report No. MRR 003{96, Mathematics Research Report No. MRR 003{96, HIGH RESOLUTION POTENTIAL

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

An Adaptive Hierarchical Matrix on Point Iterative Poisson Solver

An Adaptive Hierarchical Matrix on Point Iterative Poisson Solver Malaysian Journal of Mathematical Sciences 10(3): 369 382 (2016) MALAYSIAN JOURNAL OF MATHEMATICAL SCIENCES Journal homepage: http://einspem.upm.edu.my/journal An Adaptive Hierarchical Matrix on Point

More information

Expansion formula using properties of dot product (analogous to FOIL in algebra): u v 2 u v u v u u 2u v v v u 2 2u v v 2

Expansion formula using properties of dot product (analogous to FOIL in algebra): u v 2 u v u v u u 2u v v v u 2 2u v v 2 Least squares: Mathematical theory Below we provide the "vector space" formulation, and solution, of the least squares prolem. While not strictly necessary until we ring in the machinery of matrix algera,

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

H 2 -matrices with adaptive bases

H 2 -matrices with adaptive bases 1 H 2 -matrices with adaptive bases Steffen Börm MPI für Mathematik in den Naturwissenschaften Inselstraße 22 26, 04103 Leipzig http://www.mis.mpg.de/ Problem 2 Goal: Treat certain large dense matrices

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

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

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

Superconvergence of discontinuous Galerkin methods for 1-D linear hyperbolic equations with degenerate variable coefficients

Superconvergence of discontinuous Galerkin methods for 1-D linear hyperbolic equations with degenerate variable coefficients Superconvergence of discontinuous Galerkin methods for -D linear hyperbolic equations with degenerate variable coefficients Waixiang Cao Chi-Wang Shu Zhimin Zhang Abstract In this paper, we study the superconvergence

More information

ON SPECTRAL METHODS FOR VOLTERRA INTEGRAL EQUATIONS AND THE CONVERGENCE ANALYSIS * 1. Introduction

ON SPECTRAL METHODS FOR VOLTERRA INTEGRAL EQUATIONS AND THE CONVERGENCE ANALYSIS * 1. Introduction Journal of Computational Mathematics, Vol.6, No.6, 008, 85 837. ON SPECTRAL METHODS FOR VOLTERRA INTEGRAL EQUATIONS AND THE CONVERGENCE ANALYSIS * Tao Tang Department of Mathematics, Hong Kong Baptist

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

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

ANALYSIS AND NUMERICAL METHODS FOR SOME CRACK PROBLEMS

ANALYSIS AND NUMERICAL METHODS FOR SOME CRACK PROBLEMS INTERNATIONAL JOURNAL OF NUMERICAL ANALYSIS AND MODELING, SERIES B Volume 2, Number 2-3, Pages 155 166 c 2011 Institute for Scientific Computing and Information ANALYSIS AND NUMERICAL METHODS FOR SOME

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

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

für Mathematik in den Naturwissenschaften Leipzig

für Mathematik in den Naturwissenschaften Leipzig ŠܹÈÐ Ò ¹ÁÒ Ø ØÙØ für Mathematik in den Naturwissenschaften Leipzig Nonlinear multigrid for the solution of large scale Riccati equations in low-rank and H-matrix format (revised version: May 2007) by

More information

Solving the Stochastic Steady-State Diffusion Problem Using Multigrid

Solving the Stochastic Steady-State Diffusion Problem Using Multigrid Solving the Stochastic Steady-State Diffusion Problem Using Multigrid Tengfei Su Applied Mathematics and Scientific Computing Advisor: Howard Elman Department of Computer Science Sept. 29, 2015 Tengfei

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

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

256 Summary. D n f(x j ) = f j+n f j n 2n x. j n=1. α m n = 2( 1) n (m!) 2 (m n)!(m + n)!. PPW = 2π k x 2 N + 1. i=0?d i,j. N/2} N + 1-dim.

256 Summary. D n f(x j ) = f j+n f j n 2n x. j n=1. α m n = 2( 1) n (m!) 2 (m n)!(m + n)!. PPW = 2π k x 2 N + 1. i=0?d i,j. N/2} N + 1-dim. 56 Summary High order FD Finite-order finite differences: Points per Wavelength: Number of passes: D n f(x j ) = f j+n f j n n x df xj = m α m dx n D n f j j n= α m n = ( ) n (m!) (m n)!(m + n)!. PPW =

More information

arxiv: v2 [math.na] 8 Apr 2017

arxiv: v2 [math.na] 8 Apr 2017 A LOW-RANK MULTIGRID METHOD FOR THE STOCHASTIC STEADY-STATE DIFFUSION PROBLEM HOWARD C. ELMAN AND TENGFEI SU arxiv:1612.05496v2 [math.na] 8 Apr 2017 Abstract. We study a multigrid method for solving large

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

Numerical Solution I

Numerical Solution I Numerical Solution I Stationary Flow R. Kornhuber (FU Berlin) Summerschool Modelling of mass and energy transport in porous media with practical applications October 8-12, 2018 Schedule Classical Solutions

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

A NEW COLLOCATION METHOD FOR SOLVING CERTAIN HADAMARD FINITE-PART INTEGRAL EQUATION

A NEW COLLOCATION METHOD FOR SOLVING CERTAIN HADAMARD FINITE-PART INTEGRAL EQUATION INTERNATIONAL JOURNAL OF NUMERICAL ANALYSIS AND MODELING Volume 6, Number, Pages 4 54 c 9 Institute for Scientific Computing and Information A NEW COLLOCATION METHOD FOR SOLVING CERTAIN HADAMARD FINITE-PART

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

The Discontinuous Galerkin Finite Element Method

The Discontinuous Galerkin Finite Element Method The Discontinuous Galerkin Finite Element Method Michael A. Saum msaum@math.utk.edu Department of Mathematics University of Tennessee, Knoxville The Discontinuous Galerkin Finite Element Method p.1/41

More information

1 Discretizing BVP with Finite Element Methods.

1 Discretizing BVP with Finite Element Methods. 1 Discretizing BVP with Finite Element Methods In this section, we will discuss a process for solving boundary value problems numerically, the Finite Element Method (FEM) We note that such method is a

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

A Stable and Convergent Finite Difference Scheme for 2D Incompressible Nonlinear Viscoelastic Fluid Dynamics Problem

A Stable and Convergent Finite Difference Scheme for 2D Incompressible Nonlinear Viscoelastic Fluid Dynamics Problem Applied and Computational Mathematics 2018; (1): 11-18 http://www.sciencepulishinggroup.com/j/acm doi: 10.11648/j.acm.2018001.12 ISSN: 2328-5605 (Print); ISSN: 2328-5613 (Online) A Stale and Convergent

More information

Max-Planck-Institut fur Mathematik in den Naturwissenschaften Leipzig H 2 -matrix approximation of integral operators by interpolation by Wolfgang Hackbusch and Steen Borm Preprint no.: 04 200 H 2 -Matrix

More information

ALGEBRAIC MULTILEVEL METHODS FOR GRAPH LAPLACIANS

ALGEBRAIC MULTILEVEL METHODS FOR GRAPH LAPLACIANS The Pennsylvania State University The Graduate School Department of Mathematics ALGEBRAIC MULTILEVEL METHODS FOR GRAPH LAPLACIANS A Dissertation in Mathematics by Yao Chen Submitted in Partial Fulfillment

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

Fourier analysis for discontinuous Galerkin and related methods. Abstract

Fourier analysis for discontinuous Galerkin and related methods. Abstract Fourier analysis for discontinuous Galerkin and related methods Mengping Zhang and Chi-Wang Shu Abstract In this paper we review a series of recent work on using a Fourier analysis technique to study the

More information

Basic Principles of Weak Galerkin Finite Element Methods for PDEs

Basic Principles of Weak Galerkin Finite Element Methods for PDEs Basic Principles of Weak Galerkin Finite Element Methods for PDEs Junping Wang Computational Mathematics Division of Mathematical Sciences National Science Foundation Arlington, VA 22230 Polytopal Element

More information

CONTINUOUS DEPENDENCE ESTIMATES FOR VISCOSITY SOLUTIONS OF FULLY NONLINEAR DEGENERATE ELLIPTIC EQUATIONS

CONTINUOUS DEPENDENCE ESTIMATES FOR VISCOSITY SOLUTIONS OF FULLY NONLINEAR DEGENERATE ELLIPTIC EQUATIONS Electronic Journal of Differential Equations, Vol. 20022002), No. 39, pp. 1 10. ISSN: 1072-6691. URL: http://ejde.math.swt.edu or http://ejde.math.unt.edu ftp ejde.math.swt.edu login: ftp) CONTINUOUS DEPENDENCE

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

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

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

An a posteriori error estimator for the weak Galerkin least-squares finite-element method

An a posteriori error estimator for the weak Galerkin least-squares finite-element method An a posteriori error estimator for the weak Galerkin least-squares finite-element method James H. Adler a, Xiaozhe Hu a, Lin Mu b, Xiu Ye c a Department of Mathematics, Tufts University, Medford, MA 02155

More information

SUPERCONVERGENCE POINTS OF FRACTIONAL SPECTRAL INTERPOLATION

SUPERCONVERGENCE POINTS OF FRACTIONAL SPECTRAL INTERPOLATION SIAM J. SCI. COMPUT. Vol. 38, No. 1, pp. A598 A613 c 16 Society for Industrial and Applied Mathematics SUPERCONVERGENCE POINTS OF FRACTIONAL SPECTRAL INTERPOLATION XUAN ZHAO AND ZHIMIN ZHANG Abstract.

More information

Schwarz Preconditioner for the Stochastic Finite Element Method

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

More information

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

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

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

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

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 Fast O(N log N) Finite Difference Method for the One-Dimensional Space-Fractional Diffusion Equation

A Fast O(N log N) Finite Difference Method for the One-Dimensional Space-Fractional Diffusion Equation Mathematics 2015, 3, 1032-1044; doi:103390/math3041032 OPEN ACCESS mathematics ISSN 2227-7390 wwwmdpicom/journal/mathematics Article A Fast O(N log N) Finite Difference Method for the One-Dimensional Space-Fractional

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

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

Scientific Computing I

Scientific Computing I Scientific Computing I Module 8: An Introduction to Finite Element Methods Tobias Neckel Winter 2013/2014 Module 8: An Introduction to Finite Element Methods, Winter 2013/2014 1 Part I: Introduction to

More information

A multiscale neural network based on hierarchical matrices

A multiscale neural network based on hierarchical matrices 2 3 4 5 6 7 8 9 0 2 3 4 5 6 7 8 9 20 2 22 23 24 25 26 27 28 29 A multiscale neural network ased on hierarchical matrices Yuwei Fan, Lin Lin, Lexing Ying, and Leonardo Zepeda-Núñez Astract. In this work

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

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

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

Matrix assembly by low rank tensor approximation

Matrix assembly by low rank tensor approximation Matrix assembly by low rank tensor approximation Felix Scholz 13.02.2017 References Angelos Mantzaflaris, Bert Juettler, Boris Khoromskij, and Ulrich Langer. Matrix generation in isogeometric analysis

More information

ACM/CMS 107 Linear Analysis & Applications Fall 2017 Assignment 2: PDEs and Finite Element Methods Due: 7th November 2017

ACM/CMS 107 Linear Analysis & Applications Fall 2017 Assignment 2: PDEs and Finite Element Methods Due: 7th November 2017 ACM/CMS 17 Linear Analysis & Applications Fall 217 Assignment 2: PDEs and Finite Element Methods Due: 7th November 217 For this assignment the following MATLAB code will be required: Introduction http://wwwmdunloporg/cms17/assignment2zip

More information

Solving Homogeneous Trees of Sturm-Liouville Equations using an Infinite Order Determinant Method

Solving Homogeneous Trees of Sturm-Liouville Equations using an Infinite Order Determinant Method Paper Civil-Comp Press, Proceedings of the Eleventh International Conference on Computational Structures Technology,.H.V. Topping, Editor), Civil-Comp Press, Stirlingshire, Scotland Solving Homogeneous

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

Multigrid solvers for equations arising in implicit MHD simulations

Multigrid solvers for equations arising in implicit MHD simulations Multigrid solvers for equations arising in implicit MHD simulations smoothing Finest Grid Mark F. Adams Department of Applied Physics & Applied Mathematics Columbia University Ravi Samtaney PPPL Achi Brandt

More information

Finite Element Multigrid Framework for Mimetic Finite Difference Discretizations

Finite Element Multigrid Framework for Mimetic Finite Difference Discretizations Finite Element Multigrid Framework for Mimetic Finite ifference iscretizations Xiaozhe Hu Tufts University Polytopal Element Methods in Mathematics and Engineering, October 26-28, 2015 Joint work with:

More information

Space-time Finite Element Methods for Parabolic Evolution Problems

Space-time Finite Element Methods for Parabolic Evolution Problems Space-time Finite Element Methods for Parabolic Evolution Problems with Variable Coefficients Ulrich Langer, Martin Neumüller, Andreas Schafelner Johannes Kepler University, Linz Doctoral Program Computational

More information

Chapter Two: Numerical Methods for Elliptic PDEs. 1 Finite Difference Methods for Elliptic PDEs

Chapter Two: Numerical Methods for Elliptic PDEs. 1 Finite Difference Methods for Elliptic PDEs Chapter Two: Numerical Methods for Elliptic PDEs Finite Difference Methods for Elliptic PDEs.. Finite difference scheme. We consider a simple example u := subject to Dirichlet boundary conditions ( ) u

More information

An adaptive fast multipole boundary element method for the Helmholtz equation

An adaptive fast multipole boundary element method for the Helmholtz equation An adaptive fast multipole boundary element method for the Helmholtz equation Vincenzo Mallardo 1, Claudio Alessandri 1, Ferri M.H. Aliabadi 2 1 Department of Architecture, University of Ferrara, Italy

More information

Fast matrix algebra for dense matrices with rank-deficient off-diagonal blocks

Fast matrix algebra for dense matrices with rank-deficient off-diagonal blocks CHAPTER 2 Fast matrix algebra for dense matrices with rank-deficient off-diagonal blocks Chapter summary: The chapter describes techniques for rapidly performing algebraic operations on dense matrices

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

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

[2] (a) Develop and describe the piecewise linear Galerkin finite element approximation of,

[2] (a) Develop and describe the piecewise linear Galerkin finite element approximation of, 269 C, Vese Practice problems [1] Write the differential equation u + u = f(x, y), (x, y) Ω u = 1 (x, y) Ω 1 n + u = x (x, y) Ω 2, Ω = {(x, y) x 2 + y 2 < 1}, Ω 1 = {(x, y) x 2 + y 2 = 1, x 0}, Ω 2 = {(x,

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

arxiv: v2 [math.na] 8 Sep 2017

arxiv: v2 [math.na] 8 Sep 2017 arxiv:1704.06339v [math.na] 8 Sep 017 A Monte Carlo approach to computing stiffness matrices arising in polynomial chaos approximations Juan Galvis O. Andrés Cuervo September 3, 018 Abstract We use a Monte

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

Hierarchical Reconstruction with up to Second Degree Remainder for Solving Nonlinear Conservation Laws

Hierarchical Reconstruction with up to Second Degree Remainder for Solving Nonlinear Conservation Laws Hierarchical Reconstruction with up to Second Degree Remainder for Solving Nonlinear Conservation Laws Dedicated to Todd F. Dupont on the occasion of his 65th birthday Yingjie Liu, Chi-Wang Shu and Zhiliang

More information

A Line search Multigrid Method for Large-Scale Nonlinear Optimization

A Line search Multigrid Method for Large-Scale Nonlinear Optimization A Line search Multigrid Method for Large-Scale Nonlinear Optimization Zaiwen Wen Donald Goldfarb Department of Industrial Engineering and Operations Research Columbia University 2008 Siam Conference on

More information

Introduction to Multigrid Methods

Introduction to Multigrid Methods Introduction to Multigrid Methods Chapter 9: Multigrid Methodology and Applications Gustaf Söderlind Numerical Analysis, Lund University Textbooks: A Multigrid Tutorial, by William L Briggs. SIAM 1988

More information

Rational Chebyshev pseudospectral method for long-short wave equations

Rational Chebyshev pseudospectral method for long-short wave equations Journal of Physics: Conference Series PAPER OPE ACCESS Rational Chebyshev pseudospectral method for long-short wave equations To cite this article: Zeting Liu and Shujuan Lv 07 J. Phys.: Conf. Ser. 84

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

LECTURE NOTES ELEMENTARY NUMERICAL METHODS. Eusebius Doedel

LECTURE NOTES ELEMENTARY NUMERICAL METHODS. Eusebius Doedel LECTURE NOTES on ELEMENTARY NUMERICAL METHODS Eusebius Doedel TABLE OF CONTENTS Vector and Matrix Norms 1 Banach Lemma 20 The Numerical Solution of Linear Systems 25 Gauss Elimination 25 Operation Count

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

JACOBI SPECTRAL GALERKIN METHODS FOR VOLTERRA INTEGRAL EQUATIONS WITH WEAKLY SINGULAR KERNEL

JACOBI SPECTRAL GALERKIN METHODS FOR VOLTERRA INTEGRAL EQUATIONS WITH WEAKLY SINGULAR KERNEL Bull. Korean Math. Soc. 53 (016), No. 1, pp. 47 6 http://dx.doi.org/10.4134/bkms.016.53.1.47 JACOBI SPECTRAL GALERKIN METHODS FOR VOLTERRA INTEGRAL EQUATIONS WITH WEAKLY SINGULAR KERNEL Yin Yang Abstract.

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

Finite difference method for elliptic problems: I

Finite difference method for elliptic problems: I Finite difference method for elliptic problems: I Praveen. C praveen@math.tifrbng.res.in Tata Institute of Fundamental Research Center for Applicable Mathematics Bangalore 560065 http://math.tifrbng.res.in/~praveen

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

Lecture 6 January 15, 2014

Lecture 6 January 15, 2014 Advanced Graph Algorithms Jan-Apr 2014 Lecture 6 January 15, 2014 Lecturer: Saket Sourah Scrie: Prafullkumar P Tale 1 Overview In the last lecture we defined simple tree decomposition and stated that for

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

Lehrstuhl Informatik V. Lehrstuhl Informatik V. 1. solve weak form of PDE to reduce regularity properties. Lehrstuhl Informatik V

Lehrstuhl Informatik V. Lehrstuhl Informatik V. 1. solve weak form of PDE to reduce regularity properties. Lehrstuhl Informatik V Part I: Introduction to Finite Element Methods Scientific Computing I Module 8: An Introduction to Finite Element Methods Tobias Necel Winter 4/5 The Model Problem FEM Main Ingredients Wea Forms and Wea

More information

A Matrix Approach to Solving Hyperbolic Partial Differential Equations Using Bernoulli Polynomials

A Matrix Approach to Solving Hyperbolic Partial Differential Equations Using Bernoulli Polynomials Filomat 3:4 216 993 1 DOI 12298/FIL164993E Pulished y Faculty of Sciences and Mathematics University of iš Seria Availale at: http://wwwpmfniacrs/filomat A Matrix Approach to Solving Hyperolic Partial

More information

arxiv: v1 [math.na] 29 Sep 2017

arxiv: v1 [math.na] 29 Sep 2017 SUPERCONVERGENCE POINTS FOR THE SPECTRAL INTERPOLATION OF RIESZ FRACTIONAL DERIVATIVES BEICHUAN DENG, ZHIMIN ZHANG, AND XUAN ZHAO arxiv:79.3v [math.na] 9 Sep 7 Abstract. In this paper, superconvergence

More information

Efficient Solvers for Stochastic Finite Element Saddle Point Problems

Efficient Solvers for Stochastic Finite Element Saddle Point Problems Efficient Solvers for Stochastic Finite Element Saddle Point Problems Catherine E. Powell c.powell@manchester.ac.uk School of Mathematics University of Manchester, UK Efficient Solvers for Stochastic Finite

More information