FOR ALL GRID SIZES. Thor Gjesdal. Christian Michelsen Research A/S. N-5036 Fantoft, Norway SUMMARY

Size: px
Start display at page:

Download "FOR ALL GRID SIZES. Thor Gjesdal. Christian Michelsen Research A/S. N-5036 Fantoft, Norway SUMMARY"

Transcription

1 A CELL-CENTERED MULTIGRID ALGORITHM FOR ALL GRID SIZES Thor Gjesdal Christian Michelsen Research A/S N-5036 Fantoft, Norway SUMMARY Multigrid methods are optimal; that is, their rate of convergence is independent of the number of grid points, because they use a nested sequence of coarse grids to represent dierent scales of the solution. This nesting does, however, usually lead to certain restrictions of the permissible size of the discretised problem. In cases where the modeler is free to specify the whole problem, such constraints are of little importance because they can be taken into consideration from the outset. We consider the situation in which there are other competing constraints on the resolution. These restrictions may stem from the physical problem (e.g., if the discretised operator contains experimental data measured on a xed grid) or from the need to avoid limitations set by the hardware. In this paper we discuss a modication to the cell-centered multigrid algorithm, so that it can be used for problems with any resolution. We discuss in particular a coarsening strategy and choice of intergrid transfer operators that can handle grids with both an even or odd number of cells. The method is described and applied to linear equations obtained by discretisation of two- and three-dimensional second-order elliptic PDEs. INTRODUCTION Multigrid methods have during the last decades developed into an important tool in many areas of scientic computation. Because they use a nested sequence of grids to represent dierent scales of the solution, the multigrid algorithms are optimal in the sense that their computational complexity is linearly proportional to the total number of unknowns in the discretised problem. This nesting does however lead to certain restrictions on the permissible size of the discrete problem, similar to those encountered in other ecient `divide-and-conquer' algorithms such as the fast Fourier transform or cyclic reduction. In a standard multigrid algorithm, coarsening is usually This work was supported by the Research Council of Norway through Grant number /410 and program number STP{30074.

2 performed by doubling the mesh-spacing. The number of cells in the grid will then be of the form n l = C l 2 k, where n l is the number of cells in direction l and C l is some suitable (small) integer. Early applications of multigrid methods for general grid sizes consisted of padding the ne grid with empty cells. Such padding can lead to potential large overheads in storage requirements and computational complexity. Dendy [1] and Adams [2] have both described modications of vertex-centered multigrid algorithms that are extended to handle general grid-sizes. In cases with an odd number of cells, Dendy employs a dummy point on the coarse grid, while Adams has devised a special coarsening strategy using a uniform grid spacing at all levels. Often the modeler is free to specify the whole problem, and then such constraints are of no importance because they can be taken into consideration from the outset. We consider here the situation in which there are other competing constraints on the resolution. These restrictions may stem from the physical problem (e.g., if the discretised operator contains experimental data measured on a xed grid) or from the need to avoid limitations set by the hardware. We believe that these restrictions must be overcome if the multigrid methods are ever to become a standard inventory in the modeler's toolbox. In this paper we discuss a modication to the cell-centered multigrid algorithm, so that it can be used for problems with any resolution. The cell-centered algorithm is attractive because cell-centered discretisations are in widespread use, and cellcentered multigrid also has the ability to handle problems with discontinuous or rapidly varying diusion coecients using standard grid transfer operators [3, 4, 5]. In the next section we will describe the method with special emphasis on the grid coarsening and construction of the intergrid transfer functions. We will apply the method to linear equations obtained by discretisation of two- and three-dimensional second-order elliptic PDEs and show that the convergence rates are indeed independent of the grid size (even grids with an odd number of cells). MULTIGRID ALGORITHM Two level algorithm To describe the method, we will consider a two-level algorithm for the discretised problem Au = b; where A is the discretised dierential operator, which we assume is linear. The two-level algorithm consists of a smoothing step and a correction step where the update to the solution is calculated on a coarse grid. The two components of the multigrid algorithm are complementary; that is, smoothing is used to reduce high frequency error components, while the coarse grid correction is good at eliminating low frequencies in the error. We will denote coarse grid quantities by an overbar, and we can then write the algorithm in symbolic form as M = S 2 (I? P A?1 RA)S 1 ;

3 Level nx ny Figure 1: Multigrid hierarchy for ve-level system to illustrate grid coarsening strategy. where M is the two-level error reduction operator; R; P are the restriction and prolongation operators, and S is the smoothing operator with 1 ; 2 the number of preand post-smoothing sweeps, respectively. We obtain the multigrid algorithm by recursive application of the two-level algorithm to solve the coarse level defect equation Ae = Rr = R(b? Au). Grid coarsening For a given ne grid, we choose the coarse grid size as n l = bn l =2c + mod(n l ; 2) (1) where bc is the oor function. Standard coarsening, or coarsening in all coordinate directions, is performed as far as possible. For rectangular grids, semi-coarsening is then continued until the coarsest grid has a small number of cells in each direction. In this way, a coarse grid hierarchy is dened for any ne grid, and multigrid iterations can be performed. To illustrate the coarsening strategy, gure 1 shows an example of two ve-level systems. The rst example shows the standard case with a suitable number of cells and full coarsening in four levels. In the second example we have `bad' numbers (an odd number of cells in both directions and a moderately rectangular grid). Then we apply full coarsening for two levels and continue semi-coarsening for two levels to obtain a small system on the coarsest grid. Transfer operators In this section will we describe the restriction and prolongation operators. For simplicity we will concentrate on the one-dimensional operators. We will then describe briey how we obtain the higher dimensional operators. The grid transfer operators must satisfy the well-known accuracy requirement m R + m P > 2M; where m R and m P are the order of the restriction and the prolongation, respectively, and 2M is the order of the dierential operator. The order of the grid transfer operators and this rule can be determined either by considering how the interpolation acts

4 on the Fourier components (Brandt [6], Hemker [7]) or the order of the polynomials used in the interpolation rule (Hackbusch [8]). If we consider second order elliptic operators, we will use a restriction based on linear interpolation, which gives m R = 2, and for the prolongation we will use piecewise constant interpolation (m P = 1). This seems to be more robust than the opposite alternative (m R = 1; m P = 2) [9]. Prolongation, or coarse-to-ne interpolation, is performed by cell-based piecewise constant interpolation; that is, the coarse grid function values are transferred directly to the ne-grid points that belong to each coarse grid cell. The ne-to-coarse restriction is dened by the average u i = (Ru) i = X j R(i; j)u i+j ; = dn=ne : (2) The one-dimensional restriction operator is given by the adjoint of linear interpolation. In the standard case, where n is an even number, this restriction is simply given by the stencil h i R = : In general, when n is either odd or even, we can envisage two methods to construct the restriction operator. First, we can adopt an approach akin to that of Adams [2] and assume that both the coarse and the ne computational grids are given as a uniform distribution of cells on the unit interval, with spacing h = 1=n. The restriction weights can then be calculated by R(i; j) = max 0; 1? (2i + j? 1)h? (i? 1)h)=h 2 2 : (3) This will give a three- or four-point stencil in all cases. These restriction weights should be scaled so that they add up to the ratio n=n [10]. If the ne grid has an even number of cells, this formula will reproduce the standard stencil. This approach will unfortunately not produce a stable coarse-grid operator when we use the Galerkin approximation, and as a consequence the convergence rate of the method will deteriorate. We have therefore instead developed a restriction operator based on true cell-based coarsening. In this case, one cell at the boundary will be identical to the boundary cell at the ner level, as illustrated in gure 2. A similar aproach was suggested by Hutchinson and Raithby [11] in connection with the use of a low-order restriction operator. For a restriction based on the adjoint of linear interpolation we must modify the stencil in the cells close to the boundary. We get 1 3 R(n? 1; :) = [ 1? w 0 ]; 4 4 R(n; :) = [ w ]; where w = a=b. If k is the number of immediately preceding ner levels that has an odd number of cells, a and b are given by a 1 = 1 a k = 2a k?1 ; b 1 = 3 b k = 2b k?1? 1:

5 1/3 1 Fine Grid Coarse grid Figure 2: Fine and coarse cells at boundary when the ne grid has an odd number of cells. The numbers indicate the restriction weights for the end point. When semicoarsening is used, a direction exists in which n = n. In this case = 1, and both the restriction and the prolongation are given by the identity operator I = [ ]. In the multidimensional case, the stencils for restriction and prolongation are determined by tensor products of the one-dimensional stencils. If we let i and j denote multi-indices, we will for example have for the restriction stencil in 3D R 3D (i; j) = R x (i 1 ; j 1 )R y (i 2 ; j 2 )R z (i 3 ; j 3 ): (4) In other words, in two- and three dimensions restriction will be given by the adjoint of bi- and tri-linear interpolation, respectively. Coarse grid approximation There coarse grid matrices are determined by the use of the Galerkin approximation A = RAP. The Galerkin coarse grid approximation is preferable to straightforward discretisation, because the coarse grid operator can be automatically calculated from the ne grid stencils. This can give the multigrid solver the appearance of a black-box solver where the user only has to supply the coecients of the discretised equations. Because the restriction operator is based on bi- and tri-linear interpolation in higher dimensions, the coarse grid stencil will be full (9 points in 2D, 27 points in 3D.) The stencil elements can readily be calculated by the algorithm given by Wesseling [10]. Smoothing A point that should be noted is that the coarsening strategy we described in the previous section may change the (an-)isotropy of the coarse-grid operator compared

6 to the operator on the ne grid. This might have to be taken into consideration when we select the smoother. In two dimensions the alternating line Gauss-Seidel method is a robust smoother that is not too expensive. In practice its performance is often quite comparable to Red-Black point relaxation even for isotropic operators. In 3D, the only really robust smoother is alternating plane relaxations, which unfortunately is rather expensive even if a multigrid method is used, to solve the two-dimensional planes. It is therefore dicult to recommend this smoother without reservation. If we have enough knowledge of the problem at hand to decide that a line relaxation method would suce, a potential gain can be harvested, but for a truly black-box solution plane relaxation is probably the safest bet. Implementation aspects In this section we will discuss briey some practical aspects of the algorithm. The use of one-dimensional interpolation rules makes the implementation fairly modular, and by using features such as derived data types and dynamic memory allocation that are now available in Fortran we have written a combined two- and three-dimensional solver where the PDE can be discretised on any compact stencil (the most common are 5, 7, or 9 points in 2D and 7, 12, 19, or 27 points in 3D). With the use of recursion, it is also possible that the solver calls itself for plane smoothing in 3D problems. Depending on how restriction and prolongation are treated, a modest overhead related to the transfer operations will be realized. In our implementation, this overhead is on the order of nx ny nz oating point operations (roughly equivalent to one residual calculation on the ne grid) per iteration and nx+ny+nz memory locations. The overhead related to work can however be eliminated if all stencil elements are precomputed and stored. This option will of course lead to a larger storage penalty. COMPUTATIONAL EXAMPLES In this section we will demonstrate the convergence of the method for some selected test examples. Laplace/Poisson equation First we consider the Laplace equation on rectangular regions with Dirichlet or Neumann boundary conditions. r 2 u = 0; x 2 u = 1; x or = 0; x

7 Table 1: Two-Dimensional Laplace Equation with Dirichlet Boundary Conditions Grid size Levels Reduction factor Iterations D and 3D calculations with a uniform ne grid The rst set of calculations is performed on the Laplace equation with Dirichlet boundary conditions in a case in which the grid spacing is the same in each direction, so that the ne-grid operator is isotropic. The iterations start o from random initial values in the unknowns and are performed until the residual norm is reduced by a factor of 10?12. The average residual reduction rate,, is dened as = krn k 2 kr 0 k 2! 1=n : Table 1 shows results of two-dimensional calculations using alternating line Gauss- Seidel as the smoother for a series of dierent grid sizes. The results are given for a V(0,1) (sawtooth) cycle. We see from the table that the method works equally well for problem sizes that include both `good' and `bad' multigrid numbers. Results of three-dimensional calculations are given in table 2. The results indicate that the alternating line smoother is suciently robust to handle cases in which either odd-numbered grids or semi-coarsening lead to anisotropy in the coarse grid problems Table 2: Three-Dimensional Laplace Equation with Dirichlet Boundary Conditions Grid size Line GS Plane GS Reduction Iterations time Reduction Iterations time

8 Table 3: Two-Dimensional Laplace Equation with Homogeneous Neumann Boundary Conditions on a Stretched Grid Stretching factor: Grid size n n n Diverge as long as the problem on the ne grid is isotropic. The dramatic slow-down seen in the case where we use alternating plane relaxation may be caused by the start-up overhead of the multigrid solver. A way to alleviate this might be to rework the plane-smoother to precompute the coecients in all the planes. This will however lead to a considerable storage overhead. Another alternative is to investigate whether the three-dimensional coecients that are already computed can be used also in the plane solver. Examples with a non-uniform grid In this section, we will study the eect of anisotropy by introducing a nonuniform grid. Botta and Wubs [12] have shown that solution of partial dierential equations on a stretched grid can pose a challenging test case for iterative methods. One of their test cases consists of the two-dimensional Laplace equation on the unit square with homogeneous Neumann boundary conditions. The initial eld is given by f = x 2 (1? y) 2, and the convergence criterion used is that the absolute error should be below 10?6. The grid is generated by geometric stretching so that s = h i+1 =h i is constant. We use a V(0,1) cycle and the alternating line smoother; the results are shown in table 3. We note that the method fails to converge for large values of the stretching factor. The experiments indicate that a critical stretching factor exists depending on the grid size, and that iterations will diverge if the stretching is greater than this limit. In practice will we however only encounter moderate stretching, because an appreciable loss of accuracy occurs even for stretching factors larger than, say, s 5=4. We also performed the same experiment in a 3D case with a 32 3 grid, and we noticed that for moderate stretching rates, s 2, we obtained essentially no degradation in the convergence using the alternating line smoother. For s = 5, we did, however, notice a signicant slow-down as expected. Stone's problem This problem was introduced by Stone [13] as a test case for the Strongly Implicit Procedure (SIP), which is a relaxation method based on an incomplete LU decomposition. The problem consists of a heterogeneous diusion problem on the unit square

9 Source = 0.5 Kx = Ky = 0 Sink = Kx = Ky = 1 Sink = Kx = 100 Ky = 1 Kx = 1 Ky = 100 Source = 1.0 Source = 0.6 given by Figure 3: Geometry for Stone's model problem. r diag(k x ; K y )ru ~n ru? = f; (x; y) 2 [0; 1] 2 ; = 0: The geometry of the problem, specifying the conductivities and the sources, is depicted in gure 3. This problem was solved on a grid with cells, using 4 levels in the multigrid iterations. The initial eld was identically zero. The convergence factors for this problem are given in table 4. SIMPLE pressure correction equation The pressure correction equation in the SIMPLE algorithm for solution of the incompressible Navier-Stokes equations can be interpreted as an elliptic operator in Table 4: Stone's Model Problem ( = 10?8 ) Cycle Reduction factor Iterations V(0,1) V(1,1)

10 Table 5: Pressure Correction Equation in the Two Backward Facing Step Examples; Results for the First 20 Outer Iterations BFS BFS-POR Iteration n n Average the form D(Gp 0 ) = Du; where D and G are discretised divergence and gradient operators, respectively, p 0 is the pressure correction and u is the intermediate velocity eld. The diusivity consists of the inverse of a diagonalisation of the momentum operator and geometric terms. The equation is usually employed with homogeneous Neumann boundary conditions. The multigrid solver has been used to solve the pressure correction equation for the test case of a backward-facing step at Re = 800. The step size was half the channel height, and the channel had a length of 30 step heights. The grid had cells, which gives a grid aspect ratio of 5 : 1. In the rst test, the standard set-up from the benchmark results of Gartling [14] was used. In order to assess the eect of the use of porosities on convergence rates, we performed a second test in which a thin vertical plate with zero porosity and a height equal to the step height was placed in the channel downstream of the two main recirculation bubbles. Table 5 shows the residual reduction rates for the multigrid solver in the two examples. The results show that even though the convergence of the solver deteriorates in the case for which we have zero porosity (and as a consequence, zero diusivity ), its performance is still good. CONCLUSIONS We have described a generalisation of the cell-centered multigrid algorithm to cover problems with general resolution. Smoothing and the multigrid scheduling are not aected by the extensions, but changes have been made in the grid coarsening strategy and, consequently, in the design of the intergrid transfer operators. We found that cell-based coarsening was better than a mapping of the coarse grid to a uniform mesh. Numerical experiments show that the solver gives multigrid convergence for all

11 grid sizes in a number of test cases. The alternating line Gauss-Seidel relaxation is a good smoother for the two-dimensional solver. Its performance was also satisfactory in some 3D problems. In some cases involving extreme grid stretching the method seems to fail. This failure is, however, of small practical importance. REFERENCES [1] Dendy, J. E., Black box multigrid, J. Comput. Phys., 48:366{386, [2] Adams, J. C., MUDPACK 2: multigrid software for approximating elliptic partial dierential equations on uniform grids with any resolution, Appl. Math. Comput., 53:235{249, [3] Wesseling, P., Cell-centered multigrid for interface problems, J. Comput. Phys., 79:85{91, [4] Khalil, M., Analysis of Linear Multigrid Methods for Elliptic Dierential Equations with Discontinuous and Anisotropic Coecients, Ph.D. thesis, Delft University of Technology, [5] Khalil, M. and Wesseling, P., Vertex-centered and cell-centered multigrid for interface problems, J. Comput. Phys., 98:1{20, [6] Brandt, A., Guide to multigrid development, in Hackbusch, W. and Trottenberg, U., editors, Multigrid Methods, volume 960 of Lecture Notes in Mathematics, pp. 220{312, Springer-Verlag, Berlin, [7] Hemker, P. W., On the order of prolongations and restrictions in multigrid procedures, J. Comput. Appl. Math., 32:423{429, [8] Hackbusch, W., Multigrid Methods and Applications, volume 4 of Computational Mathematics, Springer{Verlag, Berlin, [9] Ersland, B. G. and Teigland, R., Comparison of two cell{centered multigrid schemes for problems with discontinuous coecients, Numer. Meth. for PDE, 9:265{283, [10] Wesseling, P., An Introduction to Multigrid Methods, Pure and Applied Mathematics, John Wiley & Sons, Chichester, [11] Hutchinson, B. R. and Raithby, G. D., A Multigrid Method Based on the Additive Correction Strategy, Numer. Heat Transf., 9:511{537, [12] Botta, E. F. F. and Wubs, F. W., The convergence behaviour of iterative methods on severely stretched grids, Int. J. Numer. Meth. Engng., 36:3333{3350, 1993.

12 [13] Stone, H. L., Iterative Solution of Implicit Approximations of Multidimensional Partial Dierential Equations, SIAM J. Numer. Anal., 5:530{558, [14] Gartling, D. K., A Test Problem for Outow Boundary Conditions Flow over a Backward-Facing Step, Int. J. Numer. Methods Fluids, 11:953{967, 1990.

SELECTIVE ALGEBRAIC MULTIGRID IN FOAM-EXTEND

SELECTIVE ALGEBRAIC MULTIGRID IN FOAM-EXTEND Student Submission for the 5 th OpenFOAM User Conference 2017, Wiesbaden - Germany: SELECTIVE ALGEBRAIC MULTIGRID IN FOAM-EXTEND TESSA UROIĆ Faculty of Mechanical Engineering and Naval Architecture, Ivana

More information

Multigrid Third-Order Least-Squares Solution of Cauchy-Riemann Equations on Unstructured Triangular Grids

Multigrid Third-Order Least-Squares Solution of Cauchy-Riemann Equations on Unstructured Triangular Grids INTERNATIONAL JOURNAL FOR NUMERICAL METHODS IN FLUIDS Int. J. Numer. Meth. Fluids ; : 6 Prepared using fldauth.cls [Version: /9/8 v.] Multigrid Third-Order Least-Squares Solution of Cauchy-Riemann Equations

More information

ETNA Kent State University

ETNA Kent State University Electronic Transactions on Numerical Analysis. Volume, 2, pp. 92. Copyright 2,. ISSN 68-963. ETNA BEHAVIOR OF PLANE RELAXATION METHODS AS MULTIGRID SMOOTHERS IGNACIO M. LLORENTE AND N. DUANE MELSON Abstract.

More information

Introduction to Multigrid and its Parallelization

Introduction to Multigrid and its Parallelization Introduction to Multigrid and its Parallelization! Thomas D. Economon Lecture 14a May 28, 2014 Announcements 2 HW 1 & 2 have been returned. Any questions? Final projects are due June 11, 5 pm. If you are

More information

Multigrid Pattern. I. Problem. II. Driving Forces. III. Solution

Multigrid Pattern. I. Problem. II. Driving Forces. III. Solution Multigrid Pattern I. Problem Problem domain is decomposed into a set of geometric grids, where each element participates in a local computation followed by data exchanges with adjacent neighbors. The grids

More information

A MULTIGRID ALGORITHM FOR IMMERSED INTERFACE PROBLEMS. Loyce Adams 1. University of Washington SUMMARY

A MULTIGRID ALGORITHM FOR IMMERSED INTERFACE PROBLEMS. Loyce Adams 1. University of Washington SUMMARY A MULTIGRID ALGORITHM FOR IMMERSED INTERFACE PROBLEMS Loyce Adams Dept. of Applied Mathematics University of Washington SUMMARY Many physical problems involve interior interfaces across which the coecients

More information

What is Multigrid? They have been extended to solve a wide variety of other problems, linear and nonlinear.

What is Multigrid? They have been extended to solve a wide variety of other problems, linear and nonlinear. AMSC 600/CMSC 760 Fall 2007 Solution of Sparse Linear Systems Multigrid, Part 1 Dianne P. O Leary c 2006, 2007 What is Multigrid? Originally, multigrid algorithms were proposed as an iterative method to

More information

Contents. I The Basic Framework for Stationary Problems 1

Contents. I The Basic Framework for Stationary Problems 1 page v Preface xiii I The Basic Framework for Stationary Problems 1 1 Some model PDEs 3 1.1 Laplace s equation; elliptic BVPs... 3 1.1.1 Physical experiments modeled by Laplace s equation... 5 1.2 Other

More information

PhD Student. Associate Professor, Co-Director, Center for Computational Earth and Environmental Science. Abdulrahman Manea.

PhD Student. Associate Professor, Co-Director, Center for Computational Earth and Environmental Science. Abdulrahman Manea. Abdulrahman Manea PhD Student Hamdi Tchelepi Associate Professor, Co-Director, Center for Computational Earth and Environmental Science Energy Resources Engineering Department School of Earth Sciences

More information

An Investigation into Iterative Methods for Solving Elliptic PDE s Andrew M Brown Computer Science/Maths Session (2000/2001)

An Investigation into Iterative Methods for Solving Elliptic PDE s Andrew M Brown Computer Science/Maths Session (2000/2001) An Investigation into Iterative Methods for Solving Elliptic PDE s Andrew M Brown Computer Science/Maths Session (000/001) Summary The objectives of this project were as follows: 1) Investigate iterative

More information

Multigrid Algorithms for Three-Dimensional RANS Calculations - The SUmb Solver

Multigrid Algorithms for Three-Dimensional RANS Calculations - The SUmb Solver Multigrid Algorithms for Three-Dimensional RANS Calculations - The SUmb Solver Juan J. Alonso Department of Aeronautics & Astronautics Stanford University CME342 Lecture 14 May 26, 2014 Outline Non-linear

More information

An Efficient, Geometric Multigrid Solver for the Anisotropic Diffusion Equation in Two and Three Dimensions

An Efficient, Geometric Multigrid Solver for the Anisotropic Diffusion Equation in Two and Three Dimensions 1 n Efficient, Geometric Multigrid Solver for the nisotropic Diffusion Equation in Two and Three Dimensions Tolga Tasdizen, Ross Whitaker UUSCI-2004-002 Scientific Computing and Imaging Institute University

More information

PROGRAMMING OF MULTIGRID METHODS

PROGRAMMING OF MULTIGRID METHODS PROGRAMMING OF MULTIGRID METHODS LONG CHEN In this note, we explain the implementation detail of multigrid methods. We will use the approach by space decomposition and subspace correction method; see Chapter:

More information

Seed Point. Agglomerated Points

Seed Point. Agglomerated Points AN ASSESSMENT OF LINEAR VERSUS NON-LINEAR MULTIGRID METHODS FOR UNSTRUCTURED MESH SOLVERS DIMITRI J. MAVRIPLIS Abstract. The relative performance of a non-linear FAS multigrid algorithm and an equivalent

More information

Higher order nite element methods and multigrid solvers in a benchmark problem for the 3D Navier Stokes equations

Higher order nite element methods and multigrid solvers in a benchmark problem for the 3D Navier Stokes equations INTERNATIONAL JOURNAL FOR NUMERICAL METHODS IN FLUIDS Int. J. Numer. Meth. Fluids 2002; 40:775 798 (DOI: 10.1002/d.377) Higher order nite element methods and multigrid solvers in a benchmark problem for

More information

smooth coefficients H. Köstler, U. Rüde

smooth coefficients H. Köstler, U. Rüde A robust multigrid solver for the optical flow problem with non- smooth coefficients H. Köstler, U. Rüde Overview Optical Flow Problem Data term and various regularizers A Robust Multigrid Solver Galerkin

More information

An Efficient Parallel Multigrid Solver for 3-D Convection-dominated Problems

An Efficient Parallel Multigrid Solver for 3-D Convection-dominated Problems NASA/CR-2-21319 ICASE Report No. 2-29 An Efficient Parallel Multigrid Solver for 3-D Convection-dominated Problems Ignacio M. Llorente and Manuel Prieto-Matías Universidad Complutense, Madrid, Spain Boris

More information

Highly Parallel Multigrid Solvers for Multicore and Manycore Processors

Highly Parallel Multigrid Solvers for Multicore and Manycore Processors Highly Parallel Multigrid Solvers for Multicore and Manycore Processors Oleg Bessonov (B) Institute for Problems in Mechanics of the Russian Academy of Sciences, 101, Vernadsky Avenue, 119526 Moscow, Russia

More information

Semicoarsening and Implicit Smoothers for the Simulation of a Flat Plate at Yaw

Semicoarsening and Implicit Smoothers for the Simulation of a Flat Plate at Yaw NASA/CR-21-21871 ICASE Report No. 21-13 Semicoarsening and Implicit Smoothers for the Simulation of a Flat Plate at Yaw Ruben S. Montero and Ignacio M. Llorente Universidad Complutense, Madrid, Spain Manuel

More information

Recent developments for the multigrid scheme of the DLR TAU-Code

Recent developments for the multigrid scheme of the DLR TAU-Code www.dlr.de Chart 1 > 21st NIA CFD Seminar > Axel Schwöppe Recent development s for the multigrid scheme of the DLR TAU-Code > Apr 11, 2013 Recent developments for the multigrid scheme of the DLR TAU-Code

More information

PARALLEL METHODS FOR SOLVING PARTIAL DIFFERENTIAL EQUATIONS. Ioana Chiorean

PARALLEL METHODS FOR SOLVING PARTIAL DIFFERENTIAL EQUATIONS. Ioana Chiorean 5 Kragujevac J. Math. 25 (2003) 5 18. PARALLEL METHODS FOR SOLVING PARTIAL DIFFERENTIAL EQUATIONS Ioana Chiorean Babeş-Bolyai University, Department of Mathematics, Cluj-Napoca, Romania (Received May 28,

More information

Driven Cavity Example

Driven Cavity Example BMAppendixI.qxd 11/14/12 6:55 PM Page I-1 I CFD Driven Cavity Example I.1 Problem One of the classic benchmarks in CFD is the driven cavity problem. Consider steady, incompressible, viscous flow in a square

More information

1.2 Numerical Solutions of Flow Problems

1.2 Numerical Solutions of Flow Problems 1.2 Numerical Solutions of Flow Problems DIFFERENTIAL EQUATIONS OF MOTION FOR A SIMPLIFIED FLOW PROBLEM Continuity equation for incompressible flow: 0 Momentum (Navier-Stokes) equations for a Newtonian

More information

An Investigation of Directional-Coarsening And Line-Implicit Smoothing Applied to Agglomeration Multigrid

An Investigation of Directional-Coarsening And Line-Implicit Smoothing Applied to Agglomeration Multigrid An Investigation of Directional-Coarsening And Line-Implicit Smoothing Applied to Agglomeration Multigrid J. V. Lassaline Ryerson University 35 Victoria St, Toronto, ON, M5B 2K3, Canada D. W. Zingg University

More information

1 2 (3 + x 3) x 2 = 1 3 (3 + x 1 2x 3 ) 1. 3 ( 1 x 2) (3 + x(0) 3 ) = 1 2 (3 + 0) = 3. 2 (3 + x(0) 1 2x (0) ( ) = 1 ( 1 x(0) 2 ) = 1 3 ) = 1 3

1 2 (3 + x 3) x 2 = 1 3 (3 + x 1 2x 3 ) 1. 3 ( 1 x 2) (3 + x(0) 3 ) = 1 2 (3 + 0) = 3. 2 (3 + x(0) 1 2x (0) ( ) = 1 ( 1 x(0) 2 ) = 1 3 ) = 1 3 6 Iterative Solvers Lab Objective: Many real-world problems of the form Ax = b have tens of thousands of parameters Solving such systems with Gaussian elimination or matrix factorizations could require

More information

MATHEMATICAL ANALYSIS, MODELING AND OPTIMIZATION OF COMPLEX HEAT TRANSFER PROCESSES

MATHEMATICAL ANALYSIS, MODELING AND OPTIMIZATION OF COMPLEX HEAT TRANSFER PROCESSES MATHEMATICAL ANALYSIS, MODELING AND OPTIMIZATION OF COMPLEX HEAT TRANSFER PROCESSES Goals of research Dr. Uldis Raitums, Dr. Kārlis Birģelis To develop and investigate mathematical properties of algorithms

More information

AGGLOMERATION MULTIGRID FOR THE THREE-DIMENSIONAL EULER EQUATIONS. MS 132C, NASA Langley Research Center. Abstract

AGGLOMERATION MULTIGRID FOR THE THREE-DIMENSIONAL EULER EQUATIONS. MS 132C, NASA Langley Research Center. Abstract AGGLOMERATION MULTIGRID FOR THE THREE-DIMENSIONAL EULER EQUATIONS V. Venkatakrishnan D. J. Mavriplis y Institute for Computer Applications in Science and Engineering MS 132C, NASA Langley Research Center

More information

i.e. variable extrapolation along the characteristic propagation directions. This leads to a family of rst and second-order accurate schemes with an i

i.e. variable extrapolation along the characteristic propagation directions. This leads to a family of rst and second-order accurate schemes with an i Cell-centered Genuinely Multidimensional Upwind Algorithms and Structured Meshes P. Van Ransbeeck, Ch. Hirsch Department of Fluid Mechanics Vrije Universiteit Brussel Brussels, Belgium A family of cell-centered

More information

f xx + f yy = F (x, y)

f xx + f yy = F (x, y) Application of the 2D finite element method to Laplace (Poisson) equation; f xx + f yy = F (x, y) M. R. Hadizadeh Computer Club, Department of Physics and Astronomy, Ohio University 4 Nov. 2013 Domain

More information

Chapter 13. Boundary Value Problems for Partial Differential Equations* Linz 2002/ page

Chapter 13. Boundary Value Problems for Partial Differential Equations* Linz 2002/ page Chapter 13 Boundary Value Problems for Partial Differential Equations* E lliptic equations constitute the third category of partial differential equations. As a prototype, we take the Poisson equation

More information

Optical Flow Estimation with CUDA. Mikhail Smirnov

Optical Flow Estimation with CUDA. Mikhail Smirnov Optical Flow Estimation with CUDA Mikhail Smirnov msmirnov@nvidia.com Document Change History Version Date Responsible Reason for Change Mikhail Smirnov Initial release Abstract Optical flow is the apparent

More information

Multigrid Solvers in CFD. David Emerson. Scientific Computing Department STFC Daresbury Laboratory Daresbury, Warrington, WA4 4AD, UK

Multigrid Solvers in CFD. David Emerson. Scientific Computing Department STFC Daresbury Laboratory Daresbury, Warrington, WA4 4AD, UK Multigrid Solvers in CFD David Emerson Scientific Computing Department STFC Daresbury Laboratory Daresbury, Warrington, WA4 4AD, UK david.emerson@stfc.ac.uk 1 Outline Multigrid: general comments Incompressible

More information

MESHLESS SOLUTION OF INCOMPRESSIBLE FLOW OVER BACKWARD-FACING STEP

MESHLESS SOLUTION OF INCOMPRESSIBLE FLOW OVER BACKWARD-FACING STEP Vol. 12, Issue 1/2016, 63-68 DOI: 10.1515/cee-2016-0009 MESHLESS SOLUTION OF INCOMPRESSIBLE FLOW OVER BACKWARD-FACING STEP Juraj MUŽÍK 1,* 1 Department of Geotechnics, Faculty of Civil Engineering, University

More information

Finite element solution of multi-scale transport problems using the least squares based bubble function enrichment

Finite element solution of multi-scale transport problems using the least squares based bubble function enrichment Finite element solution of multi-scale transport problems using the least squares based bubble function enrichment A. Yazdani a, V. Nassehi b1 a Cranfield University, School of Applied Sciences, Cranfield,

More information

Smoothers. < interactive example > Partial Differential Equations Numerical Methods for PDEs Sparse Linear Systems

Smoothers. < interactive example > Partial Differential Equations Numerical Methods for PDEs Sparse Linear Systems Smoothers Partial Differential Equations Disappointing convergence rates observed for stationary iterative methods are asymptotic Much better progress may be made initially before eventually settling into

More information

Pressure Correction Scheme for Incompressible Fluid Flow

Pressure Correction Scheme for Incompressible Fluid Flow AALTO UNIVERSITY School of Chemical Technology CHEM-E7160 Fluid Flow in Process Units Pressure Correction Scheme for Incompressible Fluid Flow Ong Chin Kai 620503 Lee De Ming Benedict 620448 Page 1 Abstract

More information

Why Use the GPU? How to Exploit? New Hardware Features. Sparse Matrix Solvers on the GPU: Conjugate Gradients and Multigrid. Semiconductor trends

Why Use the GPU? How to Exploit? New Hardware Features. Sparse Matrix Solvers on the GPU: Conjugate Gradients and Multigrid. Semiconductor trends Imagine stream processor; Bill Dally, Stanford Connection Machine CM; Thinking Machines Sparse Matrix Solvers on the GPU: Conjugate Gradients and Multigrid Jeffrey Bolz Eitan Grinspun Caltech Ian Farmer

More information

A Parallel Multigrid Solver for Viscous Flows on Anisotropic Structured Grids

A Parallel Multigrid Solver for Viscous Flows on Anisotropic Structured Grids NASA/CR-21-211238 ICASE Report No. 21-34 A Parallel Multigrid Solver for Viscous Flows on Anisotropic Structured Grids Manuel Prieto, Ruben S. Montero, and Ignacio M. Llorente Universidad Complutense,

More information

An introduction to mesh generation Part IV : elliptic meshing

An introduction to mesh generation Part IV : elliptic meshing Elliptic An introduction to mesh generation Part IV : elliptic meshing Department of Civil Engineering, Université catholique de Louvain, Belgium Elliptic Curvilinear Meshes Basic concept A curvilinear

More information

Mesh adaption strategies for steady shallow. 1 - Centro di Ricerca, Sviluppo e Studi Superiori in Sardegna

Mesh adaption strategies for steady shallow. 1 - Centro di Ricerca, Sviluppo e Studi Superiori in Sardegna Mesh adaption strategies for steady shallow water ow. M. Marrocu 1 & D. Ambrosi 2 1 - Centro di Ricerca, Sviluppo e Studi Superiori in Sardegna (CRS4), Cagliari, Italy; email: marino@crs4.it 2 - Dipartimento

More information

Numerical Modelling in Fortran: day 6. Paul Tackley, 2017

Numerical Modelling in Fortran: day 6. Paul Tackley, 2017 Numerical Modelling in Fortran: day 6 Paul Tackley, 2017 Today s Goals 1. Learn about pointers, generic procedures and operators 2. Learn about iterative solvers for boundary value problems, including

More information

The Immersed Interface Method

The Immersed Interface Method The Immersed Interface Method Numerical Solutions of PDEs Involving Interfaces and Irregular Domains Zhiiin Li Kazufumi Ito North Carolina State University Raleigh, North Carolina Society for Industrial

More information

GEOMETRIC MULTIGRID METHODS ON STRUCTURED TRIANGULAR GRIDS FOR INCOMPRESSIBLE NAVIER-STOKES EQUATIONS AT LOW REYNOLDS NUMBERS

GEOMETRIC MULTIGRID METHODS ON STRUCTURED TRIANGULAR GRIDS FOR INCOMPRESSIBLE NAVIER-STOKES EQUATIONS AT LOW REYNOLDS NUMBERS INTERNATIONAL JOURNAL OF NUMERICAL ANALYSIS AND MODELING Volume 11, Number 2, Pages 400 411 c 2014 Institute for Scientific Computing and Information GEOMETRIC MULTIGRID METHODS ON STRUCTURED TRIANGULAR

More information

D036 Accelerating Reservoir Simulation with GPUs

D036 Accelerating Reservoir Simulation with GPUs D036 Accelerating Reservoir Simulation with GPUs K.P. Esler* (Stone Ridge Technology), S. Atan (Marathon Oil Corp.), B. Ramirez (Marathon Oil Corp.) & V. Natoli (Stone Ridge Technology) SUMMARY Over the

More information

Hierarchical Hybrid Grids

Hierarchical Hybrid Grids Hierarchical Hybrid Grids IDK Summer School 2012 Björn Gmeiner, Ulrich Rüde July, 2012 Contents Mantle convection Hierarchical Hybrid Grids Smoothers Geometric approximation Performance modeling 2 Mantle

More information

Abstract Stabilized nite element methods have been shown to yield robust, accurate numerical solutions to both the compressible and incompressible Nav

Abstract Stabilized nite element methods have been shown to yield robust, accurate numerical solutions to both the compressible and incompressible Nav A stabilized nite element method for the incompressible Navier-Stokes equations using a hierarchical basis Christian H. Whiting 1 Kenneth E. Jansen 2 Scientic Computation Research Center and the Department

More information

Fully discrete Finite Element Approximations of Semilinear Parabolic Equations in a Nonconvex Polygon

Fully discrete Finite Element Approximations of Semilinear Parabolic Equations in a Nonconvex Polygon Fully discrete Finite Element Approximations of Semilinear Parabolic Equations in a Nonconvex Polygon Tamal Pramanick 1,a) 1 Department of Mathematics, Indian Institute of Technology Guwahati, Guwahati

More information

MULTIGRID SOLUTION STRATEGIES FOR ADAPTIVE MESHING PROBLEMS. NASA Langley Research Center. Hampton, VA ABSTRACT

MULTIGRID SOLUTION STRATEGIES FOR ADAPTIVE MESHING PROBLEMS. NASA Langley Research Center. Hampton, VA ABSTRACT MULTIGRID SOLUTION STRATEGIES FOR ADAPTIVE MESHING PROBLEMS Dimitri J. Mavriplis Institute for Computer Applications in Science and Engineering NASA Langley Research Center Hampton, VA 23681-0001 ABSTRACT

More information

Multigrid solvers M. M. Sussman sussmanm@math.pitt.edu Office Hours: 11:10AM-12:10PM, Thack 622 May 12 June 19, 2014 1 / 43 Multigrid Geometrical multigrid Introduction Details of GMG Summary Algebraic

More information

NIA CFD Seminar, October 4, 2011 Hyperbolic Seminar, NASA Langley, October 17, 2011

NIA CFD Seminar, October 4, 2011 Hyperbolic Seminar, NASA Langley, October 17, 2011 NIA CFD Seminar, October 4, 2011 Hyperbolic Seminar, NASA Langley, October 17, 2011 First-Order Hyperbolic System Method If you have a CFD book for hyperbolic problems, you have a CFD book for all problems.

More information

to be known. Let i be the leg lengths (the distance between A i and B i ), X a 6-dimensional vector dening the pose of the end-eector: the three rst c

to be known. Let i be the leg lengths (the distance between A i and B i ), X a 6-dimensional vector dening the pose of the end-eector: the three rst c A formal-numerical approach to determine the presence of singularity within the workspace of a parallel robot J-P. Merlet INRIA Sophia-Antipolis France Abstract: Determining if there is a singularity within

More information

Numerical Algorithms

Numerical Algorithms Chapter 10 Slide 464 Numerical Algorithms Slide 465 Numerical Algorithms In textbook do: Matrix multiplication Solving a system of linear equations Slide 466 Matrices A Review An n m matrix Column a 0,0

More information

Adaptive-Mesh-Refinement Pattern

Adaptive-Mesh-Refinement Pattern Adaptive-Mesh-Refinement Pattern I. Problem Data-parallelism is exposed on a geometric mesh structure (either irregular or regular), where each point iteratively communicates with nearby neighboring points

More information

Efficient Multigrid based solvers for Isogeometric Analysis

Efficient Multigrid based solvers for Isogeometric Analysis Efficient Multigrid based solvers for Isogeometric Analysis R. Tielen, M. Möller and C. Vuik Delft Institute of Applied Mathematics (DIAM) Numerical Analysis / 22 Isogeometric Analysis (IgA) Extension

More information

u 0+u 2 new boundary vertex

u 0+u 2 new boundary vertex Combined Subdivision Schemes for the design of surfaces satisfying boundary conditions Adi Levin School of Mathematical Sciences, Tel-Aviv University, Tel-Aviv 69978, Israel. Email:fadilev@math.tau.ac.ilg

More information

Control Volume Finite Difference On Adaptive Meshes

Control Volume Finite Difference On Adaptive Meshes Control Volume Finite Difference On Adaptive Meshes Sanjay Kumar Khattri, Gunnar E. Fladmark, Helge K. Dahle Department of Mathematics, University Bergen, Norway. sanjay@mi.uib.no Summary. In this work

More information

A Comparison of Algebraic Multigrid Preconditioners using Graphics Processing Units and Multi-Core Central Processing Units

A Comparison of Algebraic Multigrid Preconditioners using Graphics Processing Units and Multi-Core Central Processing Units A Comparison of Algebraic Multigrid Preconditioners using Graphics Processing Units and Multi-Core Central Processing Units Markus Wagner, Karl Rupp,2, Josef Weinbub Institute for Microelectronics, TU

More information

arxiv: v1 [math.na] 20 Sep 2016

arxiv: v1 [math.na] 20 Sep 2016 arxiv:1609.06236v1 [math.na] 20 Sep 2016 A Local Mesh Modification Strategy for Interface Problems with Application to Shape and Topology Optimization P. Gangl 1,2 and U. Langer 3 1 Doctoral Program Comp.

More information

Automatic Generation of Algorithms and Data Structures for Geometric Multigrid. Harald Köstler, Sebastian Kuckuk Siam Parallel Processing 02/21/2014

Automatic Generation of Algorithms and Data Structures for Geometric Multigrid. Harald Köstler, Sebastian Kuckuk Siam Parallel Processing 02/21/2014 Automatic Generation of Algorithms and Data Structures for Geometric Multigrid Harald Köstler, Sebastian Kuckuk Siam Parallel Processing 02/21/2014 Introduction Multigrid Goal: Solve a partial differential

More information

Index. C m (Ω), 141 L 2 (Ω) space, 143 p-th order, 17

Index. C m (Ω), 141 L 2 (Ω) space, 143 p-th order, 17 Bibliography [1] J. Adams, P. Swarztrauber, and R. Sweet. Fishpack: Efficient Fortran subprograms for the solution of separable elliptic partial differential equations. http://www.netlib.org/fishpack/.

More information

ENERGY-224 Reservoir Simulation Project Report. Ala Alzayer

ENERGY-224 Reservoir Simulation Project Report. Ala Alzayer ENERGY-224 Reservoir Simulation Project Report Ala Alzayer Autumn Quarter December 3, 2014 Contents 1 Objective 2 2 Governing Equations 2 3 Methodolgy 3 3.1 BlockMesh.........................................

More information

Resilient geometric finite-element multigrid algorithms using minimised checkpointing

Resilient geometric finite-element multigrid algorithms using minimised checkpointing Resilient geometric finite-element multigrid algorithms using minimised checkpointing Dominik Göddeke, Mirco Altenbernd, Dirk Ribbrock Institut für Angewandte Mathematik (LS3) Fakultät für Mathematik TU

More information

Flow and Heat Transfer in a Mixing Elbow

Flow and Heat Transfer in a Mixing Elbow Flow and Heat Transfer in a Mixing Elbow Objectives The main objectives of the project are to learn (i) how to set up and perform flow simulations with heat transfer and mixing, (ii) post-processing and

More information

Solution of Ambrosio-Tortorelli Model for Image Segmentation by Generalized Relaxation Method

Solution of Ambrosio-Tortorelli Model for Image Segmentation by Generalized Relaxation Method Solution of Ambrosio-Tortorelli Model for Image Segmentation by Generalized Relaxation Method Pasqua D Ambra, Gaetano Tartaglione Institute for High-Performance Computing and Networking (ICAR), CNR, Via

More information

Minimization of the Truncation Error by Grid Adaptation

Minimization of the Truncation Error by Grid Adaptation NASA/CR-999-0979 ICASE Report No. 99-46 Minimization of the Truncation Error by Grid Adaptation Nail K. Yamaleev NASA Langley Research Center, Hampton, Virginia Institute for Computer Applications in Science

More information

results obtained using the distributive relaxation scheme employed by Ehret [6] and the new relaxation

results obtained using the distributive relaxation scheme employed by Ehret [6] and the new relaxation A new relaxation scheme for solving EHL problems (E. Nurgat and M. Berzins) a a School of Computer Studies, University of Leeds, Leeds LS 9JT, United Kingdom A New Relaxation Scheme (NRS) is presented

More information

Exploring unstructured Poisson solvers for FDS

Exploring unstructured Poisson solvers for FDS Exploring unstructured Poisson solvers for FDS Dr. Susanne Kilian hhpberlin - Ingenieure für Brandschutz 10245 Berlin - Germany Agenda 1 Discretization of Poisson- Löser 2 Solvers for 3 Numerical Tests

More information

UNSTRUCTURED GRIDS ON NURBS SURFACES. The surface grid can be generated either in a parameter. surfaces. Generating grids in a parameter space is

UNSTRUCTURED GRIDS ON NURBS SURFACES. The surface grid can be generated either in a parameter. surfaces. Generating grids in a parameter space is UNSTRUCTURED GRIDS ON NURBS SURFACES Jamshid Samareh-Abolhassani 1 Abstract A simple and ecient computational method is presented for unstructured surface grid generation. This method is built upon an

More information

Adaptive sparse grid multilevel methods for elliptic. PDEs based on nite dierences. Abstract

Adaptive sparse grid multilevel methods for elliptic. PDEs based on nite dierences. Abstract Adaptive sparse grid multilevel methods for elliptic PDEs based on nite dierences M. Griebel, Bonn Abstract We present a multilevel approach for the solution of partial dierential equations. It is based

More information

A linear solver based on algebraic multigrid and defect correction for the solution of adjoint RANS equations

A linear solver based on algebraic multigrid and defect correction for the solution of adjoint RANS equations INTERNATIONAL JOURNAL FOR NUMERICAL METHODS IN FLUIDS Int. J. Numer. Meth. Fluids 2014; 74:846 855 Published online 24 January 2014 in Wiley Online Library (wileyonlinelibrary.com)..3878 A linear solver

More information

INTEGRATION OF LOCAL-GLOBAL UPSCALING AND GRID ADAPTIVITY FOR SIMULATION OF SUBSURFACE FLOW IN HETEROGENEOUS FORMATIONS

INTEGRATION OF LOCAL-GLOBAL UPSCALING AND GRID ADAPTIVITY FOR SIMULATION OF SUBSURFACE FLOW IN HETEROGENEOUS FORMATIONS INTEGRATION OF LOCAL-GLOBAL UPSCALING AND GRID ADAPTIVITY FOR SIMULATION OF SUBSURFACE FLOW IN HETEROGENEOUS FORMATIONS M. GERRITSEN AND J. V. LAMBERS Abstract. We propose a methodology, called multi-level

More information

Parallel Multigrid on Cartesian Meshes with Complex Geometry +

Parallel Multigrid on Cartesian Meshes with Complex Geometry + Parallel Multigrid on Cartesian Meshes with Complex Geometry + Marsha Berger a and Michael Aftosmis b and Gedas Adomavicius a a Courant Institute, New York University, 251 Mercer St., New York, NY 10012

More information

An algebraic multigrid method for isotropic linear elasticity problems on anisotropic meshes

An algebraic multigrid method for isotropic linear elasticity problems on anisotropic meshes INTERNATIONAL JOURNAL FOR NUMERICAL METHODS IN BIOMEDICAL ENGINEERING Int. J. Numer. Meth. Biomed. Engng. 2010; 26:534 553 Published online 10 July 2008 in Wiley InterScience (www.interscience.wiley.com)..1140

More information

Image deblurring by multigrid methods. Department of Physics and Mathematics University of Insubria

Image deblurring by multigrid methods. Department of Physics and Mathematics University of Insubria Image deblurring by multigrid methods Marco Donatelli Stefano Serra-Capizzano Department of Physics and Mathematics University of Insubria Outline 1 Restoration of blurred and noisy images The model problem

More information

ON THE IMPLEMENTATION OF THE P-ADAPTIVE FINITE ELEMENT METHOD USING THE OBJECT

ON THE IMPLEMENTATION OF THE P-ADAPTIVE FINITE ELEMENT METHOD USING THE OBJECT ON THE IMPLEMENTATION OF THE P-ADAPTIVE FINITE ELEMENT METHOD USING THE OBJECT ORIENTED PROGRAMMING PHILOSOFY Philippe R.B. Devloo Faculdade de Engenharia Civil - UNICAMP Carlos Armando Magalhaes Duarte

More information

Algebraic Multigrid (AMG) for Ground Water Flow and Oil Reservoir Simulation

Algebraic Multigrid (AMG) for Ground Water Flow and Oil Reservoir Simulation lgebraic Multigrid (MG) for Ground Water Flow and Oil Reservoir Simulation Klaus Stüben, Patrick Delaney 2, Serguei Chmakov 3 Fraunhofer Institute SCI, Klaus.Stueben@scai.fhg.de, St. ugustin, Germany 2

More information

Modeling Skills Thermal Analysis J.E. Akin, Rice University

Modeling Skills Thermal Analysis J.E. Akin, Rice University Introduction Modeling Skills Thermal Analysis J.E. Akin, Rice University Most finite element analysis tasks involve utilizing commercial software, for which you do not have the source code. Thus, you need

More information

DIGITAL TERRAIN MODELLING. Endre Katona University of Szeged Department of Informatics

DIGITAL TERRAIN MODELLING. Endre Katona University of Szeged Department of Informatics DIGITAL TERRAIN MODELLING Endre Katona University of Szeged Department of Informatics katona@inf.u-szeged.hu The problem: data sources data structures algorithms DTM = Digital Terrain Model Terrain function:

More information

Pressure separation a technique for improving the velocity error in finite element discretisations of the Navier Stokes equations

Pressure separation a technique for improving the velocity error in finite element discretisations of the Navier Stokes equations Applied Mathematics and Computation 165 (2005) 275 290 www.elsevier.com/locate/amc Pressure separation a technique for improving the velocity error in finite element discretisations of the Navier Stokes

More information

A higher-order finite volume method with collocated grid arrangement for incompressible flows

A higher-order finite volume method with collocated grid arrangement for incompressible flows Computational Methods and Experimental Measurements XVII 109 A higher-order finite volume method with collocated grid arrangement for incompressible flows L. Ramirez 1, X. Nogueira 1, S. Khelladi 2, J.

More information

Finite Volume Discretization on Irregular Voronoi Grids

Finite Volume Discretization on Irregular Voronoi Grids Finite Volume Discretization on Irregular Voronoi Grids C.Huettig 1, W. Moore 1 1 Hampton University / National Institute of Aerospace Folie 1 The earth and its terrestrial neighbors NASA Colin Rose, Dorling

More information

How to Optimize Geometric Multigrid Methods on GPUs

How to Optimize Geometric Multigrid Methods on GPUs How to Optimize Geometric Multigrid Methods on GPUs Markus Stürmer, Harald Köstler, Ulrich Rüde System Simulation Group University Erlangen March 31st 2011 at Copper Schedule motivation imaging in gradient

More information

A PARALLEL MULTIGRID PRECONDITIONED CONJUGATE GRADIENT ALGORITHM FOR GROUNDWATER FLOW SIMULATIONS. STEVEN F. ASHBY y AND ROBERT D.

A PARALLEL MULTIGRID PRECONDITIONED CONJUGATE GRADIENT ALGORITHM FOR GROUNDWATER FLOW SIMULATIONS. STEVEN F. ASHBY y AND ROBERT D. A PARALLEL MULTIGRID PRECONDITIONED CONJUGATE GRADIENT ALGORITHM FOR GROUNDWATER FLOW SIMULATIONS STEVEN F. ASHBY y AND ROBERT D.FALGOUT z Abstract. This paper discusses the numerical simulation of groundwater

More information

Application of Finite Volume Method for Structural Analysis

Application of Finite Volume Method for Structural Analysis Application of Finite Volume Method for Structural Analysis Saeed-Reza Sabbagh-Yazdi and Milad Bayatlou Associate Professor, Civil Engineering Department of KNToosi University of Technology, PostGraduate

More information

A THREE-DIMENSIONAL ADAPTIVE WAVELET METHOD FOR FLUID STRUCTURE INTERACTION

A THREE-DIMENSIONAL ADAPTIVE WAVELET METHOD FOR FLUID STRUCTURE INTERACTION A THREE-DIMENSIONAL ADAPTIVE WAVELET METHOD FOR FLUID STRUCTURE INTERACTION N.K.-R. Kevlahan 1, O.V. Vasilyev 2, D. Goldstein 2, and A. Jay 1,3 kevlahan@mcmaster.ca 1 Department of Mathematics & Statistics,

More information

Fault Tolerant Domain Decomposition for Parabolic Problems

Fault Tolerant Domain Decomposition for Parabolic Problems Fault Tolerant Domain Decomposition for Parabolic Problems Marc Garbey and Hatem Ltaief Department of Computer Science, University of Houston, Houston, TX 77204 USA garbey@cs.uh.edu, ltaief@cs.uh.edu 1

More information

Parallel Poisson Solver in Fortran

Parallel Poisson Solver in Fortran Parallel Poisson Solver in Fortran Nilas Mandrup Hansen, Ask Hjorth Larsen January 19, 1 1 Introduction In this assignment the D Poisson problem (Eq.1) is to be solved in either C/C++ or FORTRAN, first

More information

A Hybrid Geometric+Algebraic Multigrid Method with Semi-Iterative Smoothers

A Hybrid Geometric+Algebraic Multigrid Method with Semi-Iterative Smoothers NUMERICAL LINEAR ALGEBRA WITH APPLICATIONS Numer. Linear Algebra Appl. 013; 00:1 18 Published online in Wiley InterScience www.interscience.wiley.com). A Hybrid Geometric+Algebraic Multigrid Method with

More information

3D Helmholtz Krylov Solver Preconditioned by a Shifted Laplace Multigrid Method on Multi-GPUs

3D Helmholtz Krylov Solver Preconditioned by a Shifted Laplace Multigrid Method on Multi-GPUs 3D Helmholtz Krylov Solver Preconditioned by a Shifted Laplace Multigrid Method on Multi-GPUs H. Knibbe, C. W. Oosterlee, C. Vuik Abstract We are focusing on an iterative solver for the three-dimensional

More information

Parameterization of Meshes

Parameterization of Meshes 2-Manifold Parameterization of Meshes What makes for a smooth manifold? locally looks like Euclidian space collection of charts mutually compatible on their overlaps form an atlas Parameterizations are

More information

Parallel High-Order Geometric Multigrid Methods on Adaptive Meshes for Highly Heterogeneous Nonlinear Stokes Flow Simulations of Earth s Mantle

Parallel High-Order Geometric Multigrid Methods on Adaptive Meshes for Highly Heterogeneous Nonlinear Stokes Flow Simulations of Earth s Mantle ICES Student Forum The University of Texas at Austin, USA November 4, 204 Parallel High-Order Geometric Multigrid Methods on Adaptive Meshes for Highly Heterogeneous Nonlinear Stokes Flow Simulations of

More information

Topology optimization of heat conduction problems

Topology optimization of heat conduction problems Topology optimization of heat conduction problems Workshop on industrial design optimization for fluid flow 23 September 2010 Misha Marie Gregersen Anton Evgrafov Mads Peter Sørensen Technical University

More information

REDUCING COMPLEXITY IN PARALLEL ALGEBRAIC MULTIGRID PRECONDITIONERS

REDUCING COMPLEXITY IN PARALLEL ALGEBRAIC MULTIGRID PRECONDITIONERS SUBMITTED TO SIAM JOURNAL ON MATRIX ANALYSIS AND APPLICATIONS, SEPTEMBER 2004 REDUCING COMPLEXITY IN PARALLEL ALGEBRAIC MULTIGRID PRECONDITIONERS HANS DE STERCK, ULRIKE MEIER YANG, AND JEFFREY J. HEYS

More information

linearize discretize Galerkin optimize sample

linearize discretize Galerkin optimize sample Fairing by Finite Dierence Methods Leif Kobbelt Abstract. We propose an ecient and exible scheme to fairly interpolate or approximate the vertices of a given triangular mesh. Instead of generating a piecewise

More information

(1,2) (2,2) (0,1) (1,1) (0,0) (1,0) (2,0) (3,0)

(1,2) (2,2) (0,1) (1,1) (0,0) (1,0) (2,0) (3,0) Chapter 8 Elliptic Problems 8.1 Dierence Schemes for Poisson's Equation Models of steady (time independent) problems in science and engineering give rise to elliptic partial dierential systems. Examples

More information

Isotropic Porous Media Tutorial

Isotropic Porous Media Tutorial STAR-CCM+ User Guide 3927 Isotropic Porous Media Tutorial This tutorial models flow through the catalyst geometry described in the introductory section. In the porous region, the theoretical pressure drop

More information

Application of A Priori Error Estimates for Navier-Stokes Equations to Accurate Finite Element Solution

Application of A Priori Error Estimates for Navier-Stokes Equations to Accurate Finite Element Solution Application of A Priori Error Estimates for Navier-Stokes Equations to Accurate Finite Element Solution P. BURDA a,, J. NOVOTNÝ b,, J. ŠÍSTE a, a Department of Mathematics Czech University of Technology

More information

Period #10: Multi dimensional Fluid Flow in Soils (II)

Period #10: Multi dimensional Fluid Flow in Soils (II) Period #10: Multi dimensional Fluid Flow in Soils (II) A. Review Our objective is to solve multi dimensional fluid flow problems in soils. Last time, mass conservation and Darcy s Law were used to derive

More information

Adaptive Estimation of Distributions using Exponential Sub-Families Alan Gous Stanford University December 1996 Abstract: An algorithm is presented wh

Adaptive Estimation of Distributions using Exponential Sub-Families Alan Gous Stanford University December 1996 Abstract: An algorithm is presented wh Adaptive Estimation of Distributions using Exponential Sub-Families Alan Gous Stanford University December 1996 Abstract: An algorithm is presented which, for a large-dimensional exponential family G,

More information

Adaptive numerical methods

Adaptive numerical methods METRO MEtallurgical TRaining On-line Adaptive numerical methods Arkadiusz Nagórka CzUT Education and Culture Introduction Common steps of finite element computations consists of preprocessing - definition

More information