Stability of implicit extrapolation methods. Abstract. Multilevel methods are generally based on a splitting of the solution

Size: px
Start display at page:

Download "Stability of implicit extrapolation methods. Abstract. Multilevel methods are generally based on a splitting of the solution"

Transcription

1 Contemporary Mathematics Volume 00, 0000 Stability of implicit extrapolation methods Abstract. Multilevel methods are generally based on a splitting of the solution space associated with a nested sequence of coarser grids. Besides the straightforward application of extrapolation on the grid system, we propose to use extrapolation implicitly, similar to multigrid -extrapolation. This implicit extrapolation, when applied to linear nite elements is related to the p-version of the nite element method. The method depends on a stability condition which must be enforced by a suitable modication of the problem. 1. Introduction Multilevel methods decompose the solution space in a nested sequence of subspaces. These subspaces are then used to construct a multigrid or multilevel preconditioned conjugate gradient method. Thus the multilevel structure is the basis for the ecient solution of a partial dierential equation (PDE). In this setting the solution is dened in topmost space and the multilevel structure is just used to accelerate some iterative solution method. Besides this algebraic perspective, the multilevel structure may be also used to improve the accuracy of the discretization itself. Under certain conditions, the nested mesh and space structure can be exploited by various extrapolation schemes. Extrapolation results for nite dierence methods can be found in [7] and for nite elements in [1]. All explicit extrapolation techniques rely on the existence of global error expansions for the approximate solutions, typically of the form (1.1) u h? u = kx i=1 h i e i + R k+1 ; where u h and u are the numerical and the true solution of the dierential equation, where e i are functions independent of h, and where R k+1 is a remainder term. The parameter h denotes the mesh width and can be interpreted as identifying a single space V h in the nested multilevel structure. Once an expansion 1991 Mathematics Subject Classication. 65N22, 65N50, 65N55. Key words and phrases. Implicit extrapolation, multigrid, multilevel subspace splitting. c0000 American Mathematical Society /00 $ $.25 per page 1

2 2 STABILITY OF IMPLICIT EXTRAPOLATION METHODS of the form (1.1) has been proven to exist, and when the exponent 1 of the leading term has been identied, then a linear combination of u h and u 2h of the form u h = ? 1 u 1 h? 2 1? 1 u 2h will lead to an approximation where the dominating error term is eliminated. Using this scheme recursively leads to the well-known Richardson extrapolation table. Extrapolation is only computationally feasible, when the coecients i are known, and when they form a quickly growing sequence. If the coecients are not known a priory, more complicated algorithms, like the -algorithm (see [3]) would have to be used. If the 1 do not grow quickly, so that the expansion has many terms of almost equal order, extrapolation will be less attractive, since many linear combinations are needed before the approximation order is signicantly increased. Unfortunately, these situations are typical in many practical PDE problems when reentrant corners, interfaces with jumps in the coecients or rough data may lead to singularities, each of which may create its own error contributions to the error expansion with a new set of exponents i. In the case of reentrant corner singularities when the i are still known, a local extrapolation technique has been proposed in [2], based on meshes rened locally according to the interior angles. In this paper we will discuss another variant of extrapolation, where the Richardson principle is applied indirectly. Such implicit extrapolation methods have been introduced in [9, 11, 5]. They are closely related to the so-called -extrapolation in multigrid methods, see e.g. [4, chap ]. Implicit extrapolation is based on a local element-by-element analysis of numerical quadrature and dierentiation rules. Thus they primarily depend on the smoothness of the shape functions rather than the global regularity of the solution. The regularity of the solution is of course required to justify the use of high order (polynomial) approximations in general. The advantage of implicit extrapolation is, that it is formally not applied to the solution itself, but only to the nite element functions approximating the solution. Thus the specic analysis is independent of the solution properties. Whether high order nite elements are suitable to approximate a given solution can be decided independently. Furthermore, implicit extrapolation is suitable for nonuniform grids as they may occur in a local renement context. Using extrapolation in a multilevel context is especially attractive, when the extrapolation to obtain higher order discretizations is eciently integrated with a fast multilevel solver. For integrating Richardson extrapolation with a full multigrid method and a comparison with multigrid -extrapolation. see e.g. Lin and Schuller [13]. The implicit extrapolation which is the main topic of this paper is most eciently implemented by the multigrid -extrapolation algorithm. Due to the space limitations in this paper we refer here for all details of the al-

3 STABILITY OF IMPLICIT EXTRAPOLATION METHODS 3 gorithms to [9, 5]. Here we remark only that implicit extrapolation amounts to only a trivial change of a conventional (FAS) multigrid method, which consists of only a multiplication by an additional extrapolation factor in the ne-to-coarse transfer. Thus integrating implicit extrapolation into an existing multilevel algorithm is easy, and the basic solver remains untouched, since the higher order accuracy is obtained by a defect correction-like iteration. 2. The implicit extrapolation method For exposition, we consider the simplest case of an elliptic PDE in one dimension only (2.1) u 00 = f; u(0) = u(1) = 0: We will use the equivalent formulation as a minimization problem (2.2) min E(u); where E(u) = u2h0 1(0;1) Z 1 0 (u 0 (x)) 2? 2u(x)f(x) dx: Next, we introduce the mesh 0 = x 0 < x 1 < : : : < x n = 1, and discretize (2.2) directly, by representing the continuous function u by the vector u h = (u h 0; : : : ; u h n) T. With the mesh widths h i = x i+1?x i and the midpoints x i+1=2 = 1=2(x i+1 + x i ), we may replace u 0 (x i+1=2 ) u(x i+1)? u(x i ) h i and the integration by the midpoint sum Z 1 0 f(x) dx n?1 X i=0 h i f(x i+1=2 ) for the numerical approximation to (u 0 (x)) 2 and the trapezoidal sum Z 1 0 f(x) dx n?1 X i=0 h i 2 (f(x i+1) + f(x i )) for approximating the integral over u(x)f(x), see Fig. 1. Figure 1. Trapezoidal and Midpoint rule for integration

4 4 STABILITY OF IMPLICIT EXTRAPOLATION METHODS These approximations combined, lead to E(u) E h (u h ) = " n?1 X 1 ui+1? u i h i 2 h i i=0 The corresponding normal equations are?u i+1 + u i h i+1 + u i? u i?1 h i u 0 = f i+1u i+1 + f i u i + h i+1 + h i 2 f i = 0 for i = 1; : : : ; N? 1 u N = 0 : Thus we have recovered the discretization by second order nite dierences, or, equivalently, the discretization by piecewise linear nite elements with lumped mass matrix. The basic reason for deriving the discrete system in this form is the existence of asymptotic error expansions for (2.3) E(u)? E h (u) = e 2 h 2 + : : : + e 2k h 2k + R 2k+1 when u is suciently smooth. This result holds even for a nonuniform basic discretization x 0 ; : : : ; x n, if only the rened grids are constructed by recursively inserting the interval midpoints. This result is proved in [6]. Based on the expansion (2.3) we may now consider extrapolated functionals of the form (2.4) E h (u h ) = 4 3 E h(u h ) 1? 3 E 2h(u h ); Eh (u h ) = 16 E 15 h (u h ) 1? E 15 2h (u h ); etc. Here we interpret u h simply as a vector of values, and note that E 2h (u h ) only uses every second value in u h. Obviously, each of the extrapolated functionals denes a new system of normal equations for u h. In section 3 we will give conditions, when the higher order representation of the functional results in an improved accuracy for u h. Before we continue this argument, we mention that results analogous to (2.3) hold in two space dimensions, as proved in [12] for the case of triangular meshes. Of course this is a crucial result, since the main interest here is in methods which generalize to higher space dimensions. In [5] it is furthermore shown that the implicit extrapolation method is equivalent to using higher order nite elements in a special case. 3. Stability of implicit extrapolation In the above section we have introduced the implicit extrapolation principle for deriving discretizations of potentially higher order for elliptic PDE. Here we will now interpret the technique in a nite element setting. Thus we interpret u h as a nite element approximation with lowest oder, that is piecewise linear nite elements. By the extrapolation, as in (2.4), we construct higher order representations of the integrals. These extrapolated quadrature rules are dened for 2 # :

5 STABILITY OF IMPLICIT EXTRAPOLATION METHODS 5 the continued renement of a basic mesh x 0 ; x 1 ; : : : ; x n by recursively inserting the interval midpoints. If the basic mesh is associated with the space of piecewise linear nite element functions V h, it would seem natural to identify each of the rened meshes with the corresponding (hierarchical) nite element spaces V h V h=2 V h=4 : : :. of piecewise linear functions. However, since the basic integration/dierentiation rules are already correct in all these spaces, their approximation properties cannot be improved by their extrapolation. If there is a positive eect of the implicit extrapolation, it cannot be directly understood within the h-renement space structure. Therefore, we consider a p-renement where the basic space of piecewise linear approximations V h is enlarged by piecewise polynomials of increasing order. Thus the rst renement from space V h to Vh=2 with a rst step of extrapolation corresponds to adding quadratic functions in each interval (x i ; x i+1 ). The next step to Vh=4 introduces two additional degrees of freedom in each element and this corresponds to adding cubic and 4th order basis functions. In the next level V h=8 another four degrees of freedom are added and thus all polynomials up to degree 8. At the same time as we add p-renement, the extrapolation increases the accuracy of the integration. Unfortunately, this increase of accuracy does not keep up with the rapid growth of the paces. Only in the rst step, when quadratic shape functions are added, the extrapolation provides suciently accurate integration rules. In the second step of extrapolation only the functions up to degree 3 are integrated exactly, however, cubic and 4th order functions are added. Thus there is a mismatch between the functions in the nite element space and the accuracy of the extrapolated quadrature rules. Only in the rst step the method (as dened so far) is equivalent to a p-version nite element method. In conventional nite element analysis, the need for numerical quadrature to compute the stiness matrix (and right hand side) is rarely made explicit. The nite element space is basic, and the use of another space (say of nodal values) for numerical quadrature is usually not explicit in the basic analysis. Here, in the context of implicit extrapolation, the converse is true. We directly work in the space used for quadrature and our interpretation of this as a p-version nite element space is just an artifact. Generally speaking, we are faced with the following situation. The continued renement has produced a large space V which we deliberately identify with a p-renement of our basic discretization. The associated nite element problem is denoted by (3.1) mine(u); where E(u) = a(u; u)? 2(f; u): u2v In the space V, however, we cannot assume that we represent the functionals correctly. Our extrapolation procedure falls behind in accuracy,

6 6 STABILITY OF IMPLICIT EXTRAPOLATION METHODS so what we really solve is not (3.1) but (3.2) min ~u2v ~E(~u); where ~ E(~u) = ~a(~u; ~u)? 2(f; ~u) Though we cannot say, how accurate ~ E is with respect to E in the full space V, we have constructed the method such, that V has a subspace W, where both functionals agree well with each other, say (3.3) je(w)? ~ E(w)j jjwjj2 for all w 2 W : In W we consider the equation dened by the original functional (3.4) min E(w) w2w The best we can hope for in this situation is that our computed solution ~u of problem (3.2) is close to the solution w of problem (3.4). We have the following theorem. Theorem 3.1 (Stability of implicit extrapolation). Let V be a Hilbert space with norm jj jj and bilinear forms a(; ) and ~a(; ), f 2 V with positive constants c 1 ; c 2 such that c 1 jjvjj 2 a(u; u) c 2 jjvjj 2 : Let u, ~u, and w be dened by ( 3.1), ( 3.2), and ( 3.4), respectively. Assume that ( 3.3) holds and that (3.5) ~a(v; v) a(v; v) for all v 2 V: Then there exists c > 0 such that jjw? ~ujj c( p jjwjj + jjw? ujj): Proof. ~a(w? ~u; w? ~u) = ~a(w; w? ~u)? ~a(~u; w? ~u) = ~a(w; w? ~u)? a(u; w? ~u) = ~a(w; w? ~u)? a(w; w? ~u) + a(w? u; w? ~u) = (~a? a)(w; w? ~u) + a(w? u; w? ~u) p p p (~a? a)(w; w) (~a? a)(w? ~u; w? p ~u) + a(w? u; w? u) a(w? ~u; w? ~u) (~a? a)(w; w) ~a(w? ~u; w? ~u) + a(w? u; w? u) ~a(w? ~u; w? ~u): Therefore p~a(w? ~u; w? ~u) p (~a? a)(w; w) + p a(w? u; w? u): and thus there exists c > 0 with jjw? ~ujj c( p jjwjj + jjw? ujj):

7 STABILITY OF IMPLICIT EXTRAPOLATION METHODS 7 This stability theorem requires condition (3.5), which states that we must not underestimate the true energy E(u) in our numerical analogue ~ E(u). In many practical situations this condition is violated as soon as we attempt a second step of extrapolation, and the potential increase in accuracy is not reected in the solution. A computational remedy has been suggested in [10]. Obviously it is sucient so solve (3.2) subject to the constraint ~u 2 W. If such a constraint is used to make V coincide with W, the instability cannot occur. However, condition (3.5) indicates that we need not strictly impose ~u 2 W, but it suces to correct a possible underestimate of the energy of solution components which do not lie in W. Since the orthogonal complement of W in V consists of all polynomials of degree larger than some k 0 and smaller than k 1, it is simple to construct such a correction. Thus (3.2) becomes modied to (3.6) min ~u2v ~E(~u) + D(~u); where is a suciently large real parameter and D(~u) is a quadratic form which vanishes on all (piecewise) polynomials of degree k 0 and is positive for all (piecewise) polynomials of degree > k 0 and k 1. Thus the accuracy condition (3.3) is maintained, and clearly, for some large enough, the stability condition (3.5) will be satised, too. Consequently, an ansatz of the form (3.6) where E ~ is constructed by implicit extrapolation may obtain any approximation order, provided that the penalty term D is chosen appropriately. D(~u) can e.g. be constructed by computing the nite dierences estimating the kth derivatives for k 0 < k k 1 in each element. Thus D(~u) is a local operator, eecting only nodal values within a single element. Computational experiments showing the eectiveness of this technique are given in [10]. 4. A numerical experiment for a singular interface problem The implicit extrapolation technique can be generalized to two and three space dimensions. We will now present a two-dimensional numerical experiment in a nontrivial situation. We consider the diusion equation (4.1) (4.2) r (x; y)ru(x; y) = 0 in (0; 1) 2 u(x; y) = g(x; y) 1) 2 ; where the coecient has jumps across the lines x = 1=2 and y = 1=2. particular, we assume In (x; y) = 1 in (0; 1=2) (1=2; 1) [ (1=2; 1) (0; 1=2) 3 in (0; 1=2) 2 [ (1=2; 1) 2 : We choose the boundary data such that the solution has the form u(x; y) = u(r; ) = ()r (2=3) ;

8 8 STABILITY OF IMPLICIT EXTRAPOLATION METHODS where (r; ) are polar coordinates with respect to the point (x; y) = (1=2; 1=2), and where () is of the form () = sin(2=3 + ) in each of the four quadrants of the domain, with chosen such that the interface conditions for the normal derivatives are satised. The solution is depicted in Fig. 2. Since the singularity is of the same type as in the case of an L-shaped Figure 2. Solution of problem (4.1,4.2) and convergence rates. domain, we expect poor convergence. It has been shown, that in a point-wise sense and for a uniform discretization with piecewise linear triangular elements, we can only expect a convergence rate of O(h 4=3 ) This is reected in the upper (unbroken) line of Fig. 2. A conventional technique to improve on this is to use local renement to better resolve the singularity. An alternative is based on extrapolation, as in [2] or [8]. This is the approach we will take, focussing on implicit extrapolation. Thus we solve a system of the form (2.3), however, we must adapt the extrapolation parameter to the nonstandard leading term in the expansion. We thus minimize (2 4=3?1)?1 (2 (4=3) E h (u h )?E 2h (u h )). The convergence rate for the corresponding solution is shown in the lower (broken) line of Fig. 2. The errors visualized in Figs. 3. The eect of implicit extrapolation is clearly visible. Since we have not rened locally, the poor resolution of the singularity is not signicantly improved. However, with implicit extrapolation, the global spreading of the error, the so-called pollution eect is fully suppressed. This is also clear form the convergence graph in Fig. 2, where it is shown that implicit extrapolation has recovered O(h 2 ) convergence away from the singularity. 5. Conclusions In this paper we have presented briey the implicit extrapolation method. We have proved a stability condition and have suggested computational techniques

9 STABILITY OF IMPLICIT EXTRAPOLATION METHODS 9 Figure 3. Error for standard discretization and implicit extrapolation. to satisfy the stability condition in a general setting. A numerical example has shown, how the method can be used even in the case of singular interface problems. Many more aspects of the method, in particular its combination with splitting extrapolation (see [14]) and the so-called sparse grid techniques remain to be analyzed in the future. Some preliminary results are given in [10]. References 1. H. Blum, Q. Lin, and R. Rannacher, Asymptotic error expansions and Richardson extrapolation for linear nite elements, Numer. Math. 49 (1986), 11{ H. Blum and R. Rannacher, Extrapolation techniques for reducing the pollution eect of reentrant corners in the nite element method, Numer. Math. 52 (1988), 539{ C. Brezinski and M. Redivo Zaglia, Extrapolation methods: Theory and practice, Studies in Computational Mathematics, vol. 2, North Holland, Amsterdam, W. Hackbusch, Multigrid methods and applications, Springer Verlag, Berlin, M. Jung and U. Rude, Implicit extrapolation methods for multilevel nite element computations, Preliminary Proceedings of the Colorado Conference on Iterative Methods, Breckenridge, Colorado, April 4-10, 1994 (T. Manteuel, ed.), 1994, To appear in S.J.Sci.Comput., 17(1), J.N. Lyness, The calculation of the Stieltjes' integral, Num. Math. 12 (1968), 252{ G.I. Marchuk and V.V. Shaidurov, Dierence methods and their extrapolations, Springer, New York, U. Rude, On the accurate computation of singular solutions of Laplace's and Poisson's equation, Multigrid Methods: Theory, Applications, Supercomputing: Proceedings of the Third Copper Mountain Conference on Multigrid Methods, April 5-10, 1987 (New York, NY, USA) (S. F. McCormick, ed.), Marcel Dekker, , Adaptive higher order multigrid methods, Proceedings of the Third European Conference on Multigrid Methods, October 1-4, 1990 (Boston, MA, USA) (W. Hackbusch and U. Trottenberg, eds.), Birkhauser, 1991, International Series of Numerical Mathematics, Vol. 98, pp. 339{ , Extrapolation and related techniques for solving elliptic equations, Bericht I-9135, Institut fur Informatik, TU Munchen, September , The hierarchical basis extrapolation method, SIAM J. Sci. Stat. Comput. 13 (1992), no. 1, 307{318, Proceedings of the First Copper Mountain Conference on Iterative Methods, April 1-5, 1990, T. Manteuel ed.

10 10 STABILITY OF IMPLICIT EXTRAPOLATION METHODS 12., Extrapolation techniques for constructing higher order nite element methods, Bericht I-9304, Institut fur Informatik, TU Munchen, A. Schuller and Qun Lin, Ecient high order algorithms for elliptic boundary value problems combining full multigrid techniques and extrapolation methods, Arbeitspapiere der GMD 192, Gesellschaft fur Mathematik und Datenverarbeitung, December Lu Tao, Tsi min Shih, and Chin bo Liem, An analysis of splitting extrapolation for multidimensional problems, Systems Science and Mathematical Sciences 3 (1990), no. 3, 261{272. (U. Rude) Institut fur Informatik Technische Universitat Munchen Arcisstr. 21, D Munchen 2, Germany address: ruede@informatik.tu-muenchen.de

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

Compact High Order Finite Difference Stencils for Elliptic Variable Coefficient and Interface Problems

Compact High Order Finite Difference Stencils for Elliptic Variable Coefficient and Interface Problems Compact High Order Finite Difference Stencils for Elliptic Variable Coefficient and Interface Problems Daniel Ritter 1, Ulrich Rüde 1, Björn Gmeiner 1, Rochus Schmid 2 Copper Mountain, March 18th, 2013

More information

Convergence of The Multigrid Method With A Wavelet. Abstract. This new coarse grid operator is constructed using the wavelet

Convergence of The Multigrid Method With A Wavelet. Abstract. This new coarse grid operator is constructed using the wavelet Convergence of The Multigrid Method With A Wavelet Coarse Grid Operator Bjorn Engquist Erding Luo y Abstract The convergence of the two-level multigrid method with a new coarse grid operator is studied.

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

A Finite Element Method for an Ill-Posed Problem. Martin-Luther-Universitat, Fachbereich Mathematik/Informatik,Postfach 8, D Halle, Abstract

A Finite Element Method for an Ill-Posed Problem. Martin-Luther-Universitat, Fachbereich Mathematik/Informatik,Postfach 8, D Halle, Abstract A Finite Element Method for an Ill-Posed Problem W. Lucht Martin-Luther-Universitat, Fachbereich Mathematik/Informatik,Postfach 8, D-699 Halle, Germany Abstract For an ill-posed problem which has its origin

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

PIECEWISE LINEAR FINITE ELEMENT METHODS ARE NOT LOCALIZED

PIECEWISE LINEAR FINITE ELEMENT METHODS ARE NOT LOCALIZED PIECEWISE LINEAR FINITE ELEMENT METHODS ARE NOT LOCALIZED ALAN DEMLOW Abstract. Recent results of Schatz show that standard Galerkin finite element methods employing piecewise polynomial elements of degree

More information

Robust multigrid methods for nonsmooth coecient elliptic linear systems

Robust multigrid methods for nonsmooth coecient elliptic linear systems Journal of Computational and Applied Mathematics 123 (2000) 323 352 www.elsevier.nl/locate/cam Robust multigrid methods for nonsmooth coecient elliptic linear systems Tony F. Chan a; ; 1, W.L. Wan b; 2

More information

October 7, :8 WSPC/WS-IJWMIP paper. Polynomial functions are renable

October 7, :8 WSPC/WS-IJWMIP paper. Polynomial functions are renable International Journal of Wavelets, Multiresolution and Information Processing c World Scientic Publishing Company Polynomial functions are renable Henning Thielemann Institut für Informatik Martin-Luther-Universität

More information

A very short introduction to the Finite Element Method

A very short introduction to the Finite Element Method A very short introduction to the Finite Element Method Till Mathis Wagner Technical University of Munich JASS 2004, St Petersburg May 4, 2004 1 Introduction This is a short introduction to the finite element

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

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

XIAO-CHUAN CAI AND MAKSYMILIAN DRYJA. strongly elliptic equations discretized by the nite element methods.

XIAO-CHUAN CAI AND MAKSYMILIAN DRYJA. strongly elliptic equations discretized by the nite element methods. Contemporary Mathematics Volume 00, 0000 Domain Decomposition Methods for Monotone Nonlinear Elliptic Problems XIAO-CHUAN CAI AND MAKSYMILIAN DRYJA Abstract. In this paper, we study several overlapping

More information

ROB STEVENSON (\non-overlapping") errors in each subspace, that is, the errors that are not contained in the subspaces corresponding to coarser levels

ROB STEVENSON (\non-overlapping) errors in each subspace, that is, the errors that are not contained in the subspaces corresponding to coarser levels Report No. 9533, University of Nijmegen. Submitted to Numer. Math. A ROBUST HIERARCHICAL BASIS PRECONDITIONER ON GENERAL MESHES ROB STEVENSON Abstract. In this paper, we introduce a multi-level direct

More information

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

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

More information

quantitative information on the error caused by using the solution of the linear problem to describe the response of the elastic material on a corner

quantitative information on the error caused by using the solution of the linear problem to describe the response of the elastic material on a corner Quantitative Justication of Linearization in Nonlinear Hencky Material Problems 1 Weimin Han and Hong-ci Huang 3 Abstract. The classical linear elasticity theory is based on the assumption that the size

More information

INSTITUT F UR INFORMATIK. Sonderforschungsbereich 342: Methoden und Werkzeuge fur die Nutzung. Preconditioners based on. Coarsening and Algebraic-

INSTITUT F UR INFORMATIK. Sonderforschungsbereich 342: Methoden und Werkzeuge fur die Nutzung. Preconditioners based on. Coarsening and Algebraic- TECHNISCHE UNIVERSIT AT M U N C H E N INSTITUT F UR INFORMATIK Sonderforschungsbereich 342: Methoden und Werkzeuge fur die Nutzung paralleler Rechnerarchitekturen Additive Multilevel- Preconditioners based

More information

Problem Set 9 Due: In class Tuesday, Nov. 27 Late papers will be accepted until 12:00 on Thursday (at the beginning of class).

Problem Set 9 Due: In class Tuesday, Nov. 27 Late papers will be accepted until 12:00 on Thursday (at the beginning of class). Math 3, Fall Jerry L. Kazdan Problem Set 9 Due In class Tuesday, Nov. 7 Late papers will be accepted until on Thursday (at the beginning of class).. Suppose that is an eigenvalue of an n n matrix A and

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

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

2 where n i is the ion density, v i the ion velocity, the potential, e the elementary charge and M the mass of the ions. Finally, Poisson's equation c

2 where n i is the ion density, v i the ion velocity, the potential, e the elementary charge and M the mass of the ions. Finally, Poisson's equation c Numerical Modelling of the Plasma Source Ion Implantation Process in 2D Linda Stals Michael Paulus y Ulrich Rude Bernd Rauschenbach y 1 Introduction The application of ion beams for alternating the properties

More information

Numerical Integration for Multivariable. October Abstract. We consider the numerical integration of functions with point singularities over

Numerical Integration for Multivariable. October Abstract. We consider the numerical integration of functions with point singularities over Numerical Integration for Multivariable Functions with Point Singularities Yaun Yang and Kendall E. Atkinson y October 199 Abstract We consider the numerical integration of functions with point singularities

More information

Multigrid Approaches to Non-linear Diffusion Problems on Unstructured Meshes

Multigrid Approaches to Non-linear Diffusion Problems on Unstructured Meshes NASA/CR-2001-210660 ICASE Report No. 2001-3 Multigrid Approaches to Non-linear Diffusion Problems on Unstructured Meshes Dimitri J. Mavriplis ICASE, Hampton, Virginia ICASE NASA Langley Research Center

More information

The Algebraic Multigrid Projection for Eigenvalue Problems; Backrotations and Multigrid Fixed Points. Sorin Costiner and Shlomo Ta'asan

The Algebraic Multigrid Projection for Eigenvalue Problems; Backrotations and Multigrid Fixed Points. Sorin Costiner and Shlomo Ta'asan The Algebraic Multigrid Projection for Eigenvalue Problems; Backrotations and Multigrid Fixed Points Sorin Costiner and Shlomo Ta'asan Department of Applied Mathematics and Computer Science The Weizmann

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

t x 0.25

t x 0.25 Journal of ELECTRICAL ENGINEERING, VOL. 52, NO. /s, 2, 48{52 COMPARISON OF BROYDEN AND NEWTON METHODS FOR SOLVING NONLINEAR PARABOLIC EQUATIONS Ivan Cimrak If the time discretization of a nonlinear parabolic

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

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

arxiv: v1 [math.na] 29 Feb 2016

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

More information

the sum of two projections. Finally, in Section 5, we apply the theory of Section 4 to the case of nite element spaces. 2. Additive Algorithms for Par

the sum of two projections. Finally, in Section 5, we apply the theory of Section 4 to the case of nite element spaces. 2. Additive Algorithms for Par ON THE SPECTRA OF SUMS OF ORTHOGONAL PROJECTIONS WITH APPLICATIONS TO PARALLEL COMPUTING PETTER E. BJRSTAD y AND JAN MANDEL z Abstract. Many parallel iterative algorithms for solving symmetric, positive

More information

Solving Large Nonlinear Sparse Systems

Solving Large Nonlinear Sparse Systems Solving Large Nonlinear Sparse Systems Fred W. Wubs and Jonas Thies Computational Mechanics & Numerical Mathematics University of Groningen, the Netherlands f.w.wubs@rug.nl Centre for Interdisciplinary

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

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

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

Nodal O(h 4 )-superconvergence of piecewise trilinear FE approximations

Nodal O(h 4 )-superconvergence of piecewise trilinear FE approximations Preprint, Institute of Mathematics, AS CR, Prague. 2007-12-12 INSTITTE of MATHEMATICS Academy of Sciences Czech Republic Nodal O(h 4 )-superconvergence of piecewise trilinear FE approximations Antti Hannukainen

More information

THEORETICAL FOUNDATION, NUMERICAL EXPERIMENT KLAUS BERNERT

THEORETICAL FOUNDATION, NUMERICAL EXPERIMENT KLAUS BERNERT -EXTRAPOLATION THEORETICAL FOUNDATION, NUMERICAL EXPERIMENT AND APPLICATION TO NAVIER-STOKES EQUATIONS KLAUS BERNERT Abstract. This article deals with -extrapolation { a modication of the multigrid method,

More information

A mixed nite volume element method based on rectangular mesh for biharmonic equations

A mixed nite volume element method based on rectangular mesh for biharmonic equations Journal of Computational and Applied Mathematics 7 () 7 3 www.elsevier.com/locate/cam A mixed nite volume element method based on rectangular mesh for biharmonic equations Tongke Wang College of Mathematical

More information

The Mortar Wavelet Method Silvia Bertoluzza Valerie Perrier y October 29, 1999 Abstract This paper deals with the construction of wavelet approximatio

The Mortar Wavelet Method Silvia Bertoluzza Valerie Perrier y October 29, 1999 Abstract This paper deals with the construction of wavelet approximatio The Mortar Wavelet Method Silvia Bertoluzza Valerie Perrier y October 9, 1999 Abstract This paper deals with the construction of wavelet approximation spaces, in the framework of the Mortar method. We

More information

Local discontinuous Galerkin methods for elliptic problems

Local discontinuous Galerkin methods for elliptic problems COMMUNICATIONS IN NUMERICAL METHODS IN ENGINEERING Commun. Numer. Meth. Engng 2002; 18:69 75 [Version: 2000/03/22 v1.0] Local discontinuous Galerkin methods for elliptic problems P. Castillo 1 B. Cockburn

More information

A JACOBI-DAVIDSON ITERATION METHOD FOR LINEAR EIGENVALUE PROBLEMS. GERARD L.G. SLEIJPEN y AND HENK A. VAN DER VORST y

A JACOBI-DAVIDSON ITERATION METHOD FOR LINEAR EIGENVALUE PROBLEMS. GERARD L.G. SLEIJPEN y AND HENK A. VAN DER VORST y A JACOBI-DAVIDSON ITERATION METHOD FOR LINEAR EIGENVALUE PROBLEMS GERARD L.G. SLEIJPEN y AND HENK A. VAN DER VORST y Abstract. In this paper we propose a new method for the iterative computation of a few

More information

Operator Dependent Interpolation. A. Krechel. K. Stuben. German National Research Center for Information Technology (GMD)

Operator Dependent Interpolation. A. Krechel. K. Stuben. German National Research Center for Information Technology (GMD) Operator Dependent Interpolation in Algebraic Multigrid A. Krechel K. Stuben German National Research Center for Information Technology (GMD) Institute for Algorithms and Scientic Computing (SCAI) Schloss

More information

Splitting of Expanded Tridiagonal Matrices. Seongjai Kim. Abstract. The article addresses a regular splitting of tridiagonal matrices.

Splitting of Expanded Tridiagonal Matrices. Seongjai Kim. Abstract. The article addresses a regular splitting of tridiagonal matrices. Splitting of Expanded Tridiagonal Matrices ga = B? R for Which (B?1 R) = 0 Seongai Kim Abstract The article addresses a regular splitting of tridiagonal matrices. The given tridiagonal matrix A is rst

More information

Bifurcation analysis of incompressible ow in a driven cavity F.W. Wubs y, G. Tiesinga z and A.E.P. Veldman x Abstract Knowledge of the transition point of steady to periodic ow and the frequency occurring

More information

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

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

More information

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

on! 0, 1 and 2 In the Zienkiewicz-Zhu SPR p 1 and p 2 are obtained by solving the locally discrete least-squares p

on! 0, 1 and 2 In the Zienkiewicz-Zhu SPR p 1 and p 2 are obtained by solving the locally discrete least-squares p Analysis of a Class of Superconvergence Patch Recovery Techniques for Linear and Bilinear Finite Elements Bo Li Zhimin Zhang y Abstract Mathematical proofs are presented for the derivative superconvergence

More information

Reference values for drag and lift of a two-dimensional time-dependent ow around a cylinder

Reference values for drag and lift of a two-dimensional time-dependent ow around a cylinder INTERNATIONAL JOURNAL FOR NUMERICAL METHODS IN FLUIDS Int. J. Numer. Meth. Fluids 2004; 44:777 788 (DOI: 10.1002/d.679) Reference values for drag and lift of a two-dimensional time-dependent ow around

More information

Multigrid and Domain Decomposition Methods for Electrostatics Problems

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

More information

A memory-ecient nite element method for systems of reaction diusion equations with non-smooth forcing

A memory-ecient nite element method for systems of reaction diusion equations with non-smooth forcing Available online at www.sciencedirect.com Journal of Computational and Applied Mathematics 169 (2004) 431 458 www.elsevier.com/locate/cam A memory-ecient nite element method for systems of reaction diusion

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 Balancing Algorithm for Mortar Methods

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

More information

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

quantum semiconductor devices. The model is valid to all orders of h and to rst order in the classical potential energy. The smooth QHD equations have

quantum semiconductor devices. The model is valid to all orders of h and to rst order in the classical potential energy. The smooth QHD equations have Numerical Simulation of the Smooth Quantum Hydrodynamic Model for Semiconductor Devices Carl L. Gardner and Christian Ringhofer y Department of Mathematics Arizona State University Tempe, AZ 8587-84 Abstract

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

Fixed point iteration and root finding

Fixed point iteration and root finding Fixed point iteration and root finding The sign function is defined as x > 0 sign(x) = 0 x = 0 x < 0. It can be evaluated via an iteration which is useful for some problems. One such iteration is given

More information

Local Mesh Refinement with the PCD Method

Local Mesh Refinement with the PCD Method Advances in Dynamical Systems and Applications ISSN 0973-5321, Volume 8, Number 1, pp. 125 136 (2013) http://campus.mst.edu/adsa Local Mesh Refinement with the PCD Method Ahmed Tahiri Université Med Premier

More information

On the solution of incompressible two-phase ow by a p-version discontinuous Galerkin method

On the solution of incompressible two-phase ow by a p-version discontinuous Galerkin method COMMUNICATIONS IN NUMERICAL METHODS IN ENGINEERING Commun. Numer. Meth. Engng 2006; 22:741 751 Published online 13 December 2005 in Wiley InterScience (www.interscience.wiley.com). DOI: 10.1002/cnm.846

More information

A FAST SOLVER FOR ELLIPTIC EQUATIONS WITH HARMONIC COEFFICIENT APPROXIMATIONS

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

More information

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

From Completing the Squares and Orthogonal Projection to Finite Element Methods

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

More information

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

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

More information

Simple Examples on Rectangular Domains

Simple Examples on Rectangular Domains 84 Chapter 5 Simple Examples on Rectangular Domains In this chapter we consider simple elliptic boundary value problems in rectangular domains in R 2 or R 3 ; our prototype example is the Poisson equation

More information

LECTURE 15 + C+F. = A 11 x 1x1 +2A 12 x 1x2 + A 22 x 2x2 + B 1 x 1 + B 2 x 2. xi y 2 = ~y 2 (x 1 ;x 2 ) x 2 = ~x 2 (y 1 ;y 2 1

LECTURE 15 + C+F. = A 11 x 1x1 +2A 12 x 1x2 + A 22 x 2x2 + B 1 x 1 + B 2 x 2. xi y 2 = ~y 2 (x 1 ;x 2 ) x 2 = ~x 2 (y 1 ;y 2  1 LECTURE 5 Characteristics and the Classication of Second Order Linear PDEs Let us now consider the case of a general second order linear PDE in two variables; (5.) where (5.) 0 P i;j A ij xix j + P i,

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

ASYMPTOTICALLY EXACT A POSTERIORI ESTIMATORS FOR THE POINTWISE GRADIENT ERROR ON EACH ELEMENT IN IRREGULAR MESHES. PART II: THE PIECEWISE LINEAR CASE

ASYMPTOTICALLY EXACT A POSTERIORI ESTIMATORS FOR THE POINTWISE GRADIENT ERROR ON EACH ELEMENT IN IRREGULAR MESHES. PART II: THE PIECEWISE LINEAR CASE MATEMATICS OF COMPUTATION Volume 73, Number 246, Pages 517 523 S 0025-5718(0301570-9 Article electronically published on June 17, 2003 ASYMPTOTICALLY EXACT A POSTERIORI ESTIMATORS FOR TE POINTWISE GRADIENT

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 Optimal Finite Element Mesh for Elastostatic Structural. Analysis Problems. P.K. Jimack. University of Leeds. Leeds LS2 9JT, UK.

An Optimal Finite Element Mesh for Elastostatic Structural. Analysis Problems. P.K. Jimack. University of Leeds. Leeds LS2 9JT, UK. An Optimal Finite Element Mesh for Elastostatic Structural Analysis Problems P.K. Jimack School of Computer Studies University of Leeds Leeds LS2 9JT, UK Abstract This paper investigates the adaptive solution

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

An Accurate Fourier-Spectral Solver for Variable Coefficient Elliptic Equations

An Accurate Fourier-Spectral Solver for Variable Coefficient Elliptic Equations An Accurate Fourier-Spectral Solver for Variable Coefficient Elliptic Equations Moshe Israeli Computer Science Department, Technion-Israel Institute of Technology, Technion city, Haifa 32000, ISRAEL Alexander

More information

Linear Algebra (part 1) : Vector Spaces (by Evan Dummit, 2017, v. 1.07) 1.1 The Formal Denition of a Vector Space

Linear Algebra (part 1) : Vector Spaces (by Evan Dummit, 2017, v. 1.07) 1.1 The Formal Denition of a Vector Space Linear Algebra (part 1) : Vector Spaces (by Evan Dummit, 2017, v. 1.07) Contents 1 Vector Spaces 1 1.1 The Formal Denition of a Vector Space.................................. 1 1.2 Subspaces...................................................

More information

Technische Universität Graz

Technische Universität Graz Technische Universität Graz A note on the stable coupling of finite and boundary elements O. Steinbach Berichte aus dem Institut für Numerische Mathematik Bericht 2009/4 Technische Universität Graz A

More information

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

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

More information

Linear Regression and Its Applications

Linear Regression and Its Applications Linear Regression and Its Applications Predrag Radivojac October 13, 2014 Given a data set D = {(x i, y i )} n the objective is to learn the relationship between features and the target. We usually start

More information

Integration, differentiation, and root finding. Phys 420/580 Lecture 7

Integration, differentiation, and root finding. Phys 420/580 Lecture 7 Integration, differentiation, and root finding Phys 420/580 Lecture 7 Numerical integration Compute an approximation to the definite integral I = b Find area under the curve in the interval Trapezoid Rule:

More information

for Finite Element Simulation of Incompressible Flow Arnd Meyer Department of Mathematics, Technical University of Chemnitz,

for Finite Element Simulation of Incompressible Flow Arnd Meyer Department of Mathematics, Technical University of Chemnitz, Preconditioning the Pseudo{Laplacian for Finite Element Simulation of Incompressible Flow Arnd Meyer Department of Mathematics, Technical University of Chemnitz, 09107 Chemnitz, Germany Preprint{Reihe

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

Jim Lambers MAT 460/560 Fall Semester Practice Final Exam

Jim Lambers MAT 460/560 Fall Semester Practice Final Exam Jim Lambers MAT 460/560 Fall Semester 2009-10 Practice Final Exam 1. Let f(x) = sin 2x + cos 2x. (a) Write down the 2nd Taylor polynomial P 2 (x) of f(x) centered around x 0 = 0. (b) Write down the corresponding

More information

Monte Carlo Methods for Statistical Inference: Variance Reduction Techniques

Monte Carlo Methods for Statistical Inference: Variance Reduction Techniques Monte Carlo Methods for Statistical Inference: Variance Reduction Techniques Hung Chen hchen@math.ntu.edu.tw Department of Mathematics National Taiwan University 3rd March 2004 Meet at NS 104 On Wednesday

More information

(f(x) P 3 (x)) dx. (a) The Lagrange formula for the error is given by

(f(x) P 3 (x)) dx. (a) The Lagrange formula for the error is given by 1. QUESTION (a) Given a nth degree Taylor polynomial P n (x) of a function f(x), expanded about x = x 0, write down the Lagrange formula for the truncation error, carefully defining all its elements. How

More information

Solution of the Two-Dimensional Steady State Heat Conduction using the Finite Volume Method

Solution of the Two-Dimensional Steady State Heat Conduction using the Finite Volume Method Ninth International Conference on Computational Fluid Dynamics (ICCFD9), Istanbul, Turkey, July 11-15, 2016 ICCFD9-0113 Solution of the Two-Dimensional Steady State Heat Conduction using the Finite Volume

More information

INTRODUCTION TO FINITE ELEMENT METHODS ON ELLIPTIC EQUATIONS LONG CHEN

INTRODUCTION TO FINITE ELEMENT METHODS ON ELLIPTIC EQUATIONS LONG CHEN INTROUCTION TO FINITE ELEMENT METHOS ON ELLIPTIC EQUATIONS LONG CHEN CONTENTS 1. Poisson Equation 1 2. Outline of Topics 3 2.1. Finite ifference Method 3 2.2. Finite Element Method 3 2.3. Finite Volume

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

J.TAUSCH AND J.WHITE 1. Capacitance Extraction of 3-D Conductor Systems in. Dielectric Media with high Permittivity Ratios

J.TAUSCH AND J.WHITE 1. Capacitance Extraction of 3-D Conductor Systems in. Dielectric Media with high Permittivity Ratios JTAUSCH AND JWHITE Capacitance Extraction of -D Conductor Systems in Dielectric Media with high Permittivity Ratios Johannes Tausch and Jacob White Abstract The recent development of fast algorithms for

More information

The WENO Method for Non-Equidistant Meshes

The WENO Method for Non-Equidistant Meshes The WENO Method for Non-Equidistant Meshes Philip Rupp September 11, 01, Berlin Contents 1 Introduction 1.1 Settings and Conditions...................... The WENO Schemes 4.1 The Interpolation Problem.....................

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

Supraconvergence of a Non-Uniform Discretisation for an Elliptic Third-Kind Boundary-Value Problem with Mixed Derivatives

Supraconvergence of a Non-Uniform Discretisation for an Elliptic Third-Kind Boundary-Value Problem with Mixed Derivatives Supraconvergence of a Non-Uniform Discretisation for an Elliptic Third-Kind Boundary-Value Problem with Mixed Derivatives Etienne Emmrich Technische Universität Berlin, Institut für Mathematik, Straße

More information

MIXED FINITE ELEMENT METHODS FOR PROBLEMS WITH ROBIN BOUNDARY CONDITIONS

MIXED FINITE ELEMENT METHODS FOR PROBLEMS WITH ROBIN BOUNDARY CONDITIONS MIXED FINITE ELEMENT METHODS FOR PROBLEMS WITH ROBIN BOUNDARY CONDITIONS JUHO KÖNNÖ, DOMINIK SCHÖTZAU, AND ROLF STENBERG Abstract. We derive new a-priori and a-posteriori error estimates for mixed nite

More information

SPECTRAL METHODS ON ARBITRARY GRIDS. Mark H. Carpenter. Research Scientist. Aerodynamic and Acoustic Methods Branch. NASA Langley Research Center

SPECTRAL METHODS ON ARBITRARY GRIDS. Mark H. Carpenter. Research Scientist. Aerodynamic and Acoustic Methods Branch. NASA Langley Research Center SPECTRAL METHODS ON ARBITRARY GRIDS Mark H. Carpenter Research Scientist Aerodynamic and Acoustic Methods Branch NASA Langley Research Center Hampton, VA 368- David Gottlieb Division of Applied Mathematics

More information

BOUNDARY CONTROLLABILITY IN PROBLEMS JOHN E. LAGNESE. linear hyperbolic systems having piecewise constant coecients in

BOUNDARY CONTROLLABILITY IN PROBLEMS JOHN E. LAGNESE. linear hyperbolic systems having piecewise constant coecients in ESAIM: Control, Optimisation and Calculus of Variations URL: http://www.emath.fr/cocv/,, BOUNDARY CONTROLLABILITY IN PROBLEMS OF TRANSMISSION FOR A CLASS OF SECOND ORDER HYPERBOLIC SYSTEMS JOHN E. LAGNESE

More information

Waveform Relaxation Method with Toeplitz. Operator Splitting. Sigitas Keras. August Department of Applied Mathematics and Theoretical Physics

Waveform Relaxation Method with Toeplitz. Operator Splitting. Sigitas Keras. August Department of Applied Mathematics and Theoretical Physics UNIVERSITY OF CAMBRIDGE Numerical Analysis Reports Waveform Relaxation Method with Toeplitz Operator Splitting Sigitas Keras DAMTP 1995/NA4 August 1995 Department of Applied Mathematics and Theoretical

More information

Order Results for Mono-Implicit Runge-Kutta Methods. K. Burrage, F. H. Chipman, and P. H. Muir

Order Results for Mono-Implicit Runge-Kutta Methods. K. Burrage, F. H. Chipman, and P. H. Muir Order Results for Mono-Implicit Runge-Kutta Methods K urrage, F H hipman, and P H Muir bstract The mono-implicit Runge-Kutta methods are a subclass of the wellknown family of implicit Runge-Kutta methods

More information

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

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

More information

Domain Decomposition Algorithms for an Indefinite Hypersingular Integral Equation in Three Dimensions

Domain Decomposition Algorithms for an Indefinite Hypersingular Integral Equation in Three Dimensions Domain Decomposition Algorithms for an Indefinite Hypersingular Integral Equation in Three Dimensions Ernst P. Stephan 1, Matthias Maischak 2, and Thanh Tran 3 1 Institut für Angewandte Mathematik, Leibniz

More information

Multilevel and Adaptive Iterative Substructuring Methods. Jan Mandel University of Colorado Denver

Multilevel and Adaptive Iterative Substructuring Methods. Jan Mandel University of Colorado Denver Multilevel and Adaptive Iterative Substructuring Methods Jan Mandel University of Colorado Denver The multilevel BDDC method is joint work with Bedřich Sousedík, Czech Technical University, and Clark Dohrmann,

More information

Incomplete Block LU Preconditioners on Slightly Overlapping. E. de Sturler. Delft University of Technology. Abstract

Incomplete Block LU Preconditioners on Slightly Overlapping. E. de Sturler. Delft University of Technology. Abstract Incomplete Block LU Preconditioners on Slightly Overlapping Subdomains for a Massively Parallel Computer E. de Sturler Faculty of Technical Mathematics and Informatics Delft University of Technology Mekelweg

More information

IN p-version AND SPECTRAL ELEMENT METHODS MARIO A. CASARIN

IN p-version AND SPECTRAL ELEMENT METHODS MARIO A. CASARIN DIAGONAL EDGE PRECONDITIONERS IN p-version AND SPECTRAL ELEMENT METHODS MARIO A. CASARIN Abstract. Domain decomposition preconditioners for high-order Galerkin methods in two dimensions are often built

More information

K. BLACK To avoid these diculties, Boyd has proposed a method that proceeds by mapping a semi-innite interval to a nite interval [2]. The method is co

K. BLACK To avoid these diculties, Boyd has proposed a method that proceeds by mapping a semi-innite interval to a nite interval [2]. The method is co Journal of Mathematical Systems, Estimation, and Control Vol. 8, No. 2, 1998, pp. 1{2 c 1998 Birkhauser-Boston Spectral Element Approximations and Innite Domains Kelly Black Abstract A spectral-element

More information

SOLVING MESH EIGENPROBLEMS WITH MULTIGRID EFFICIENCY

SOLVING MESH EIGENPROBLEMS WITH MULTIGRID EFFICIENCY SOLVING MESH EIGENPROBLEMS WITH MULTIGRID EFFICIENCY KLAUS NEYMEYR ABSTRACT. Multigrid techniques can successfully be applied to mesh eigenvalue problems for elliptic differential operators. They allow

More information

Technische Universität Graz

Technische Universität Graz Technische Universität Graz Stability of the Laplace single layer boundary integral operator in Sobolev spaces O. Steinbach Berichte aus dem Institut für Numerische Mathematik Bericht 2016/2 Technische

More information