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

Size: px
Start display at page:

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

Transcription

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

2 Mathematics Research Report No. MRR 003{96, HIGH RESOLUTION POTENTIAL FLOW METHODS IN OIL EXPLORATION Stephen Roberts 1 and Stephan Matthai 2 3rd February, 1996 Abstract In Petroleum exploration it is often important to understand the ow of liquids through porous media, which can be described by conservation of uid, and the assumption (Darcy' Law) that the uid ux is given by arp where P is the pressure and a is the permeability of the porous media. Three major problems are associated with solving this problem in the situation of interest. First, the permeability a can range over many orders of magnitude (10 orders being typical). Second, the distribution of the permeability can form complicated geometric stuctures associated with geological stuctures such as faults and permeable layers with dierent ow characteristics. Finally, the permeability data and description of the problem can come in arbitrary sizes depending on the experimental data which is available. Toovercome these problems wehave used a nite element method with an algebrain multigrid solver. We present the results of some simulations of ow through faults associated with oil migration through sand-shale structures. In particular we will demonstrate how uid ow patterns at fault-sand-shale intersections vary with fault permeability Mathematics Subject Classication. primary 76S05 secondary 65N55 65N60 65M55 65M30. Key words and phrases. Flow, Porous Media, Finite Element Method, Multigrid, Oil Exploration. Postal addresses: 1. School of Mathematical Sciences, ANU, Canberra ACT 0200, Australia. 2. Department of Geological and Environmental Sciences, Stanford University, Stanford, CA 94305, USA.

3 1. Introduction In petroleum exploration it is often important to understand the ow of liquids through porous media consisting of a complicated structure of permeable layers and faults. In many cases it is possible to understand the ow eld by using the conservation of uid, together with the assumption (Darcy's Law) that the uid ux is given by Krp where p is the pressure and K is a measure of the permeability of the porous media and is dependent on position (the viscosity and uid density has been absorbed into K). Three major problems are associated with solving this problem in the situation of interest: 1. The permeability K can range over many orders of magnitude (10 orders being typical). This usually leads to slow convergence of the numerical methods. 2. The distribution of the permeability can form complicated geometric structures associated with geological structures such as faults and permeable layers with dierent ow characteristics. We would like our numerical scheme to \adapt" to this inherent structure. 3. The permeability data and description of the problem can come in arbitrary sizes depending on the experimental data which is available. The highly complicated nature of the geometry of our problem and the large range in the permeability has led us to use a standard nite element method with triangular elements and piece-wise linear test functions in which the permeability is constant in each triangular element. We have been working with reasonably large problems with approximately 500k variables (850 by 600 data sets). A very ecient choice of solution method for such problems is the multigrid method. This method has been shown to provide optimal convergence [1] (bounded number of iterative steps independent of problem size) even for problems such as ours in which the permeability may abruptly change. We will present the results of some simulations of ow through faults associated with oil migration through sand-shale structures. In particular we will demonstrate how uid ow patterns at fault-sand-shale intersections vary with fault permeability. 2. The Simplied Mathematical Model We would like to study the ow of uid through porous media. If we assume that: 1

4 The density of the uid is constant, The uid ux satises Darcy's Law (ux proportional to the negative of the gradient of the pressure), and The porosity of the material depends linearly on pressure (hence storativity is constant). Then the pressure for our model problem satises the evolution = rkrp (1) where p(t x y) denotes the pressure as a function of time t and position (x y) 2, a two dimensional domain. K(x y) measures the permeability and S(x y) the storativity of the material. Of particular interest to us is the situation of layers of sand and shale in which oil is released under the inuence of heating. In this case we assume just one uid species (oil). Typically the layers are intersected by a complicated collection of faults (see Figure 1). In this case we are interested in approximating the steady state solution of equation (1). Also of interest is the situation in which the permeability of the faults changes, for instance after earthquakes. In this case the permeabilities of the faults may change abruptly, causing the pressure eld to diuse over time in response to the new permeability data. It should be noted that the ow of water through rocks at depths of several kilometres can also be modelled by equation (1). Once again earthquakes can cause large changes in the permeability of the faults. This in turn can setup situations in whichwater from dierent locations (and hence containing dierent dissolved minerals) can mix and cause precipitation of minerals in the fault regions. We will consider the simple case in which the domain of the problem,, is a rectangle. The pressure at the top and bottom boundaries are assumed to be constant, with the vertical boundary pressures calculated assuming that dp dy (x y) / 1 K(x y) : Here we are assuming that the permeability structure is independent of x near the vertical boundaries. It is also possible to apply zero ux boundary conditions on the vertical boundaries. 2

5 Figure 1: Typical sand shale fault structure for an oil reservoir. Notice how the layers have been displaced along faults. 3. The Finite Element Method Equation (1) is a fairly standard equation to solve. In our situation though we need to take note of the fact that the permeability K ranges over many orders of magnitude and is discontinuous (see Figure 1) and the distribution of K is associated with complicated geological structures and so our numerical method needs to be able to deal with these complicated geometries (see Figure 1). To deal with these complications we decided to use a Finite Element Method (FEM), based on triangular elements, with piece-wise linear test functions to discretize the spatial derivatives. For the time derivative we chose the backward Euler method to ensure stability for the associated sti system of equations. We will assume that the reader has a knowledge of the FEM philosophy (see Johnson's introductory book on FEM's [3]) To paraphrase, the philosophy is \Multiply the Partial Dierential equation by test functions, integrate and then use Green's Theorem to move one derivative to the test function". After this procedure we are led to a variational problem which is \equivalent" to equation (1). The Variational Problem is: Find p(t x y) such that p(t ) 2 H 1 () (the space of functions with square 3

6 integrable spatial derivatives) such that p satises the specied boundary and initial conditions, da = ; Kr rp da for all test functions 2 H0(). 1 It is important to note that we do not have to make any smoothness restrictions on the permeability K or Storativity S other than to ensure that the previous integrals make sense. In particular we can work with discontinuous permeabilities. Also this new equation only needs the function p to have integrable rst derivatives (as opposed to second derivatives in the original Partial Dierential Equation). We can discretize our Variational Problem by restricting the test functions and approximate solution to appropriate nite dimensional spaces of functions. The nite dimensional space that we use is the space of piece-wise linear functions associated with a triangulation of the domain. A triangulation T consists of a nite collection of closed triangles ( ), such that: 1. If K L 2T then K \ L is either empty, a common vertex of K and L, a common edge of K and L, or K = L. 2. S K2T K =. As our applications are often associated with complicated permeability structures, the use of triangulations (as opposed to meshes) allows for a more reasonable matching of the permeability structure to the numerical structure. Indeed we try to adapt the triangulation to the underlying permeability structure, and in particular to the fault structure. For a particular triangulation T, we can consider the associated space of continuous piece-wise linear functions. To explicitly form our discrete equations we need to nd abasisfor our piece-wise linear functions. Let fx i : i = 1 ::: ng denote the set of vertices of the triangulation T, numberedinsuchaway that x i if i>n. Let i be the unique continuous piece-wise linear function which satises i (x j )= ij (see Figure 2 for a typical basis function). The set of functions f i : i =1 ::: ng forms a basis for the space of piece-wise linear functions associated with the triangulation T. The discrete equations can now be written explicitly as: Find ^p(t) = P n j=1 P j(t) j such that i S d^p dt da = ; Kr i r^p da for all i =1 ::: n. 4

7 Figure 2: A typical piecewise linear basis function. Here P j (t) denotes the time dependent coecients of the approximate solution, with respect to the given basis for the piece-wise functions. To simplify the exposition we will neglect the specication of the pressure boundary conditions. As described the function ^p will satisfy a zero ux condition on the boundary. Expanding in terms of the basis functions we obtain a system of Ordinary Dierential Equations (ODE's) for the coecients. nx j=1 dpj S i j da dt (t) =; n X j=1 Dene two n n matrices via A ij = K r i r j da and B ij = K r i r j da P j (t) for all i =1 ::: n. S i j da: If we let P (t) = (P 1 (t) ::: P n (t)) 0 denote the coecient solution vector, then P (t) satises the ODE B dp dt = ;AP: Finally if we use the backward Euler method to discretize this ODE we obtain our numerical scheme: Find P n =(P n 1 (t) ::: P n N(t)) 0 such that B(P n ; P n;1 )=;kap n 5

8 where k denote the time-step for the method and P n denotes the numerical approximation of P (nk). In particular, to calculate P n we must solve the linear equation, (B + ka)p n = P n;1 : (2) The matrices A and B are positive denite (as S > 0andK > 0) and so this linear equation has a unique solution (up to a constant function). On the other hand for complicated permeability structures the matrices may be very large (10 6 by10 6 ) but sparse. In the next section we will provide a very basic description of the multigrid technique used to solve this equation. The pressure boundary conditions can now be specied by changing the lower n ; N n submatrix of B + ka to [0jI] and specifying the explicit boudary conditions in the appropriate components of the righthand side vector. 4. The Algebraic Multigrid Method For a large matrix problem like equation (2), derived from an elliptic Partial Dierential Equation (PDE), it is natural to consider the multigrid method (see [2], [4]). Multigrid methods are optimal in the sense that a solution accurate to the level of the truncation error can be obtained in O(N ) operations, N being the number of unknowns. Also it has been shown by Bramble et al. [1] that this optimal behaviour is maintained even if the underlying PDE has discontinuous permeabilities. Multigrid methods are typically associated with solving PDE's on a hierarchy of rened grids or triangulations. To specify a particular multigrid method, it is necessary to dene a way of transferring approximate solutions between ne and coarse levels (restriction and interpolation operators), specication of approximate solvers on the individual levels (the smoother) and a way of specifying the discrete problem on each level. Multigrid methods then work with the hierarchy of levels and build up a solution on the nest level by recursively solving problems on progressively coarser levels and then smoothly transferring the coarse level solutions back to the ner levels. In this way both local and global information about the solution can be obtained in one iterative sweep of the multigrid method. In our particular case the permeability structure is often given to us in arbitrary sizes, and so there is usually no inherent hierarchical structure to the problem. For this reason we have used the Algebraic Multigrid method (AMG) developed by Ruge and Stuben [5]. We have kindly been provided with the fortran code AMG1R5 written by Ruge, Stuben and Hempel. The 6

9 AMG method takes the matrix associated with the discretization of the problem. Using the connection information inherent in the matrix, an internal hierarchy of matrix problems are produced. A standard Gauss-Seidel smoother is used on each of these matrix problems. The AMG method seems to provide a method which is optimal in the sense described above for standard Multigrid. The major disadvantage of the method is the explicit formation of the discretization matrix and the need for a large amount of work space (the AMG method requires approximately 30N words of storage for the sparse matrix and the workspace, where N is the number of unknowns). In the future we plan to investigate more traditional multigrid method solvers which can be used as preconditioners for our problem. This should reduced the storage requirements markedly Depth, km Width, km log Permeability, m2 Figure 3: Flow through permeable layers joined by faults of similar permeability. 5. Numerical Results As mentioned previous, we would like to be able to study the inuence of changes of permeability in faults on the over all ow and pressure distribution of a simulation. This may be of use to conclude the existence of oil reservoirs, or to approximate the inuence of mixing on the the precipitation of minerals. To give a simple example of a typical situation, in Figures 3 and 4 we have calculated the pressure and velocity eld for a simple conguration of layers and faults. The only dierence between to two situations is the permeabilities of the faults. In Figure 3 the permeability of the fault is the same as the layer 7

10 Depth, km Width, km log Permeability, m2 Figure 4: Flow through permeable layers joined by highly permeable faults. (10 ;16 ), where as the permeability of the faults in Figure 4 are 10 ;11. As can be seen from the plots, the ow through the permeable layers in Figure 4 are appreciable greater than for those of Figure 3. Hence our simulations can provide useful information about the response of the oil reservoir to changes in the permeability of the faults due to say earthquakes. We are presently studying the time evolution of pressure changes caused by similar changes in fault permeabilities. We are also investigating the consequences of permeability of faults on the position of deposition of minerals due to mixing induced by concentration of ow through faults. It should be noted that at present the solution of these ow problems associated with grids of approximately 500 by 800 take about 30min on our SPARC 10 workstation, and need about 150 MB of memory. The large amounts of memory are due to the large overheads incurred in using the algebraic multigrid method. 6. Acknowledgements Wewould like toacknowledge support from the Cooperative Research Centre for Advanced Computational Systems. 8

11 References [1] Bramble J. H., Pasciak J. E., Wang J., and Xu H. Convergence Estimates for Multigrid Algorithms without Regularity Assumptions Math. Comput., 5723{45, 1991 [2] Briggs W. L. A Multigrid Tutorial SIAM, 1987 [3] Johnson C. Numerical Solution of Partial Dierential Equations by the Finite Element Method Cambridge University Press, Cambridge, 1990 [4] McCormick S. F., editor Multigrid Methods Frontiers in Applied Mathematics. SIAM, 1987 [5] Ruge J. W. and Stuben K. Algebraic Multigrid In S. F. McCormick, editor, Multigrid Methods, Frontiers in Applied Mathematics SIAM,

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

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

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

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

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

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

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

AMS526: Numerical Analysis I (Numerical Linear Algebra)

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

More information

where K e 2 h RN h e N h e is a symmetric positive denite (SPD) sparse system matrix, u h 2 R N h e the solution vector, and fh 2 R N h e the load vec

where K e 2 h RN h e N h e is a symmetric positive denite (SPD) sparse system matrix, u h 2 R N h e the solution vector, and fh 2 R N h e the load vec Algebraic Multigrid for Edge Elements Stefan Reitzinger y Joachim Schoberl z 15th June 2000 Abstract This paper presents an algebraic multigrid method for the ecient solution of the linear system arising

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

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

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

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

Algebraic Multigrid as Solvers and as Preconditioner

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

More information

uy Chavent, Jer^ome Jare and Sophie Jegou-Jan The generalized Darcy law says that for each phase the Darcy velocity is proportional to the gradient of

uy Chavent, Jer^ome Jare and Sophie Jegou-Jan The generalized Darcy law says that for each phase the Darcy velocity is proportional to the gradient of Estimation of Relative Permeabilities in Three-Phase Flow in Porous Media uy Chavent 1;2, Jer^ome Jare 2 and Sophie Jan-Jegou 3 1. Universite Paris-Dauphine, CEREMADE, Paris, France 2. INRIA-Rocquencourt,

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

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

2 ZHANGXIN CHEN AND RICHARD EWING dierentiating the resulting pressure and multiplying it by the rough coecient. This approach generates a rough and i

2 ZHANGXIN CHEN AND RICHARD EWING dierentiating the resulting pressure and multiplying it by the rough coecient. This approach generates a rough and i FROM SINGLE-PHASE TO COMPOSITIONAL FLOW: APPLICABILITY OF MIXED FINITE ELEMENTS Zhangxin Chen and Richard E. Ewing Abstract. In this paper we discuss the formulation of the governing equations that describe

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

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

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

A Stable Finite Dierence Ansatz for Higher Order Dierentiation of Non-Exact. Data. Bob Anderssen and Frank de Hoog,

A Stable Finite Dierence Ansatz for Higher Order Dierentiation of Non-Exact. Data. Bob Anderssen and Frank de Hoog, A Stable Finite Dierence Ansatz for Higher Order Dierentiation of Non-Exact Data Bob Anderssen and Frank de Hoog, CSIRO Division of Mathematics and Statistics, GPO Box 1965, Canberra, ACT 2601, Australia

More information

n i,j+1/2 q i,j * qi+1,j * S i+1/2,j

n i,j+1/2 q i,j * qi+1,j * S i+1/2,j Helsinki University of Technology CFD-group/ The Laboratory of Applied Thermodynamics MEMO No CFD/TERMO-5-97 DATE: December 9,997 TITLE A comparison of complete vs. simplied viscous terms in boundary layer

More information

Spurious Chaotic Solutions of Dierential. Equations. Sigitas Keras. September Department of Applied Mathematics and Theoretical Physics

Spurious Chaotic Solutions of Dierential. Equations. Sigitas Keras. September Department of Applied Mathematics and Theoretical Physics UNIVERSITY OF CAMBRIDGE Numerical Analysis Reports Spurious Chaotic Solutions of Dierential Equations Sigitas Keras DAMTP 994/NA6 September 994 Department of Applied Mathematics and Theoretical Physics

More information

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

Stability of implicit extrapolation methods. Abstract. Multilevel methods are generally based on a splitting of the solution 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

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

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

Rening the submesh strategy in the two-level nite element method: application to the advection diusion equation

Rening the submesh strategy in the two-level nite element method: application to the advection diusion equation INTERNATIONAL JOURNAL FOR NUMERICAL METHODS IN FLUIDS Int. J. Numer. Meth. Fluids 2002; 39:161 187 (DOI: 10.1002/d.219) Rening the submesh strategy in the two-level nite element method: application to

More information

Scientific Computing: An Introductory Survey

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

More information

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

arxiv: v1 [math.na] 11 Jul 2011

arxiv: v1 [math.na] 11 Jul 2011 Multigrid Preconditioner for Nonconforming Discretization of Elliptic Problems with Jump Coefficients arxiv:07.260v [math.na] Jul 20 Blanca Ayuso De Dios, Michael Holst 2, Yunrong Zhu 2, and Ludmil Zikatanov

More information

1e N

1e N Spectral schemes on triangular elements by Wilhelm Heinrichs and Birgit I. Loch Abstract The Poisson problem with homogeneous Dirichlet boundary conditions is considered on a triangle. The mapping between

More information

Time Integration Methods for the Heat Equation

Time Integration Methods for the Heat Equation Time Integration Methods for the Heat Equation Tobias Köppl - JASS March 2008 Heat Equation: t u u = 0 Preface This paper is a short summary of my talk about the topic: Time Integration Methods for the

More information

REPORT DOCUMENTATION PAGE

REPORT DOCUMENTATION PAGE REPORT DOCUMENTATION PAGE Form Approved OMB No. 0704-0188 The public reporting burden for this collection of information is estimated to average 1 hour per response, including the time for reviewing instructions,

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

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

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

Numerical Programming I (for CSE)

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

More information

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

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

More information

28344 Bremen, Germany. hdullin or

28344 Bremen, Germany.   hdullin or Ecient Calculation of Actions H.R. Dullin A. Wittek Institut fur Theoretische Physik Universitat Bremen Postfach 330440 28344 Bremen, Germany Phone: +49(0)421-218-2341 Fax: +49(0)421-218-4869 Email: hdullin

More information

A greedy strategy for coarse-grid selection

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

More information

Application of turbulence. models to high-lift airfoils. By Georgi Kalitzin

Application of turbulence. models to high-lift airfoils. By Georgi Kalitzin Center for Turbulence Research Annual Research Briefs 997 65 Application of turbulence models to high-lift airfoils By Georgi Kalitzin. Motivation and objectives Accurate prediction of the ow over an airfoil

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

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

New Multigrid Solver Advances in TOPS

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

More information

Partial Differential Equations

Partial Differential Equations Partial Differential Equations Introduction Deng Li Discretization Methods Chunfang Chen, Danny Thorne, Adam Zornes CS521 Feb.,7, 2006 What do You Stand For? A PDE is a Partial Differential Equation This

More information

AN AGGREGATION MULTILEVEL METHOD USING SMOOTH ERROR VECTORS

AN AGGREGATION MULTILEVEL METHOD USING SMOOTH ERROR VECTORS AN AGGREGATION MULTILEVEL METHOD USING SMOOTH ERROR VECTORS EDMOND CHOW Abstract. Many algebraic multilevel methods for solving linear systems assume that the slowto-converge, or algebraically smooth error

More information

EXACT DE RHAM SEQUENCES OF SPACES DEFINED ON MACRO-ELEMENTS IN TWO AND THREE SPATIAL DIMENSIONS

EXACT DE RHAM SEQUENCES OF SPACES DEFINED ON MACRO-ELEMENTS IN TWO AND THREE SPATIAL DIMENSIONS EXACT DE RHAM SEQUENCES OF SPACES DEFINED ON MACRO-ELEMENTS IN TWO AND THREE SPATIAL DIMENSIONS JOSEPH E. PASCIAK AND PANAYOT S. VASSILEVSKI Abstract. This paper proposes new finite element spaces that

More information

A Hybrid Method for the Wave Equation. beilina

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

More information

1. Introduction Let f(x), x 2 R d, be a real function of d variables, and let the values f(x i ), i = 1; 2; : : : ; n, be given, where the points x i,

1. Introduction Let f(x), x 2 R d, be a real function of d variables, and let the values f(x i ), i = 1; 2; : : : ; n, be given, where the points x i, DAMTP 2001/NA11 Radial basis function methods for interpolation to functions of many variables 1 M.J.D. Powell Abstract: A review of interpolation to values of a function f(x), x 2 R d, by radial basis

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

Algebraic two-level preconditioners. for the Schur complement method. L. M. Carvalho, L. Giraud and P. Le Tallec

Algebraic two-level preconditioners. for the Schur complement method. L. M. Carvalho, L. Giraud and P. Le Tallec Algebraic two-level preconditioners for the Schur complement method L. M. Carvalho, L. Giraud and P. Le Tallec June 1998 TR/PA/98/18 Algebraic two-level preconditioners for the Schur complement method

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

Iterative procedure for multidimesional Euler equations Abstracts A numerical iterative scheme is suggested to solve the Euler equations in two and th

Iterative procedure for multidimesional Euler equations Abstracts A numerical iterative scheme is suggested to solve the Euler equations in two and th Iterative procedure for multidimensional Euler equations W. Dreyer, M. Kunik, K. Sabelfeld, N. Simonov, and K. Wilmanski Weierstra Institute for Applied Analysis and Stochastics Mohrenstra e 39, 07 Berlin,

More information

3.3. SYSTEMS OF ODES 1. y 0 " 2y" y 0 + 2y = x1. x2 x3. x = y(t) = c 1 e t + c 2 e t + c 3 e 2t. _x = A x + f; x(0) = x 0.

3.3. SYSTEMS OF ODES 1. y 0  2y y 0 + 2y = x1. x2 x3. x = y(t) = c 1 e t + c 2 e t + c 3 e 2t. _x = A x + f; x(0) = x 0. .. SYSTEMS OF ODES. Systems of ODEs MATH 94 FALL 98 PRELIM # 94FA8PQ.tex.. a) Convert the third order dierential equation into a rst oder system _x = A x, with y " y" y + y = x = @ x x x b) The equation

More information

Spectral element agglomerate AMGe

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

More information

Multigrid Methods and their application in CFD

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

More information

ADDITIVE SCHWARZ FOR SCHUR COMPLEMENT 305 the parallel implementation of both preconditioners on distributed memory platforms, and compare their perfo

ADDITIVE SCHWARZ FOR SCHUR COMPLEMENT 305 the parallel implementation of both preconditioners on distributed memory platforms, and compare their perfo 35 Additive Schwarz for the Schur Complement Method Luiz M. Carvalho and Luc Giraud 1 Introduction Domain decomposition methods for solving elliptic boundary problems have been receiving increasing attention

More information

Transport Upscaling in Porous Media

Transport Upscaling in Porous Media Transport Upscaling in Porous Media Master of Science Thesis Renewable Energy Anette Nedreli Department of Geophysics University of Bergen June 2, 2014 i Acknowledgments First of all I would like to thank

More information

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

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

More information

= c c + g (n; c) (.b) on the interior of the unit square (; ) (; ) in space and for t (; t final ] in time for the unknown functions n(x; y; t)

= c c + g (n; c) (.b) on the interior of the unit square (; ) (; ) in space and for t (; t final ] in time for the unknown functions n(x; y; t) Splitting Methods for Mixed Hyperbolic-Parabolic Systems Alf Gerisch, David F. Griths y, Rudiger Weiner, and Mark A. J. Chaplain y Institut fur Numerische Mathematik, Fachbereich Mathematik und Informatik

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

Contents. 2.1 Vectors in R n. Linear Algebra (part 2) : Vector Spaces (by Evan Dummit, 2017, v. 2.50) 2 Vector Spaces

Contents. 2.1 Vectors in R n. Linear Algebra (part 2) : Vector Spaces (by Evan Dummit, 2017, v. 2.50) 2 Vector Spaces Linear Algebra (part 2) : Vector Spaces (by Evan Dummit, 2017, v 250) Contents 2 Vector Spaces 1 21 Vectors in R n 1 22 The Formal Denition of a Vector Space 4 23 Subspaces 6 24 Linear Combinations and

More information

2 IVAN YOTOV decomposition solvers and preconditioners are described in Section 3. Computational results are given in Section Multibloc formulat

2 IVAN YOTOV decomposition solvers and preconditioners are described in Section 3. Computational results are given in Section Multibloc formulat INTERFACE SOLVERS AND PRECONDITIONERS OF DOMAIN DECOMPOSITION TYPE FOR MULTIPHASE FLOW IN MULTIBLOCK POROUS MEDIA IVAN YOTOV Abstract. A multibloc mortar approach to modeling multiphase ow in porous media

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

4. Higher Order Linear DEs

4. Higher Order Linear DEs 4. Higher Order Linear DEs Department of Mathematics & Statistics ASU Outline of Chapter 4 1 General Theory of nth Order Linear Equations 2 Homogeneous Equations with Constant Coecients 3 The Method of

More information

An Algebraic Multigrid Method for Eigenvalue Problems

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

More information

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

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

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

More information

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

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

Balancing domain decomposition for mortar mixed nite element methods

Balancing domain decomposition for mortar mixed nite element methods NUMERICAL LINEAR ALGEBRA WITH APPLICATIONS Numer. Linear Algebra Appl. 2003; 10:159 180 (DOI: 10.1002/nla.316) Balancing domain decomposition for mortar mixed nite element methods Gergina Pencheva and

More information

Continuous, discontinuous and coupled discontinuous continuous Galerkin nite element methods for the shallow water equations

Continuous, discontinuous and coupled discontinuous continuous Galerkin nite element methods for the shallow water equations INTERNATIONAL JOURNAL FOR NUMERICAL METHODS IN FLUIDS Int. J. Numer. Meth. Fluids 2006; 52:63 88 Published online 10 February 2006 in Wiley InterScience (www.interscience.wiley.com). DOI: 10.1002/d.1156

More information

On the Development of Implicit Solvers for Time-Dependent Systems

On the Development of Implicit Solvers for Time-Dependent Systems School o something FACULTY School OF OTHER o Computing On the Development o Implicit Solvers or Time-Dependent Systems Peter Jimack School o Computing, University o Leeds In collaboration with: P.H. Gaskell,

More information

2 Introduction Standard conservative schemes will admit non-physical oscillations near material interfaces, which can be avoided by the application of

2 Introduction Standard conservative schemes will admit non-physical oscillations near material interfaces, which can be avoided by the application of A Conservative Approach to the Multiphase Euler Equations without Spurious Pressure Oscillations Xu-Dong Liu Ronald P. Fedkiw Stanley Osher June 8, 998 Abstract In [4], the pressure evolution equation

More information

290 J.M. Carnicer, J.M. Pe~na basis (u 1 ; : : : ; u n ) consisting of minimally supported elements, yet also has a basis (v 1 ; : : : ; v n ) which f

290 J.M. Carnicer, J.M. Pe~na basis (u 1 ; : : : ; u n ) consisting of minimally supported elements, yet also has a basis (v 1 ; : : : ; v n ) which f Numer. Math. 67: 289{301 (1994) Numerische Mathematik c Springer-Verlag 1994 Electronic Edition Least supported bases and local linear independence J.M. Carnicer, J.M. Pe~na? Departamento de Matematica

More information

E cient fully-coupled solution techniques for two-phase ow in porous media Parallel multigrid solution and large scale computations

E cient fully-coupled solution techniques for two-phase ow in porous media Parallel multigrid solution and large scale computations Advances in Water Resources 23 (1999) 199±216 Ecient fully-coupled solution techniques for two-phase ow in porous media Parallel multigrid solution and large scale computations Peter Bastian a,1, Rainer

More information

Streamline calculations. Lecture note 2

Streamline calculations. Lecture note 2 Streamline calculations. Lecture note 2 February 26, 2007 1 Recapitulation from previous lecture Definition of a streamline x(τ) = s(τ), dx(τ) dτ = v(x,t), x(0) = x 0 (1) Divergence free, irrotational

More information

Contents Introduction Energy nalysis of Convection Equation 4 3 Semi-discrete nalysis 6 4 Fully Discrete nalysis 7 4. Two-stage time discretization...

Contents Introduction Energy nalysis of Convection Equation 4 3 Semi-discrete nalysis 6 4 Fully Discrete nalysis 7 4. Two-stage time discretization... Energy Stability nalysis of Multi-Step Methods on Unstructured Meshes by Michael Giles CFDL-TR-87- March 987 This research was supported by ir Force Oce of Scientic Research contract F4960-78-C-0084, supervised

More information

ADAPTIVE ITERATION TO STEADY STATE OF FLOW PROBLEMS KARL H ORNELL 1 and PER L OTSTEDT 2 1 Dept of Information Technology, Scientic Computing, Uppsala

ADAPTIVE ITERATION TO STEADY STATE OF FLOW PROBLEMS KARL H ORNELL 1 and PER L OTSTEDT 2 1 Dept of Information Technology, Scientic Computing, Uppsala ADAPTIVE ITERATION TO STEADY STATE OF FLOW PROBLEMS KARL H ORNELL 1 and PER L OTSTEDT 2 1 Dept of Information Technology, Scientic Computing, Uppsala University, SE-75104 Uppsala, Sweden. email: karl@tdb.uu.se

More information

An explicit nite element method for convection-dominated compressible viscous Stokes system with inow boundary

An explicit nite element method for convection-dominated compressible viscous Stokes system with inow boundary Journal of Computational and Applied Mathematics 156 (2003) 319 343 www.elsevier.com/locate/cam An explicit nite element method for convection-dominated compressible viscous Stokes system with inow boundary

More information

7.2 Steepest Descent and Preconditioning

7.2 Steepest Descent and Preconditioning 7.2 Steepest Descent and Preconditioning Descent methods are a broad class of iterative methods for finding solutions of the linear system Ax = b for symmetric positive definite matrix A R n n. Consider

More information

in order to insure that the Liouville equation for f(?; t) is still valid. These equations of motion will give rise to a distribution function f(?; t)

in order to insure that the Liouville equation for f(?; t) is still valid. These equations of motion will give rise to a distribution function f(?; t) G25.2651: Statistical Mechanics Notes for Lecture 21 Consider Hamilton's equations in the form I. CLASSICAL LINEAR RESPONSE THEORY _q i = @H @p i _p i =? @H @q i We noted early in the course that an ensemble

More information

Numerical Solution Techniques in Mechanical and Aerospace Engineering

Numerical Solution Techniques in Mechanical and Aerospace Engineering Numerical Solution Techniques in Mechanical and Aerospace Engineering Chunlei Liang LECTURE 3 Solvers of linear algebraic equations 3.1. Outline of Lecture Finite-difference method for a 2D elliptic PDE

More information

A Novel Aggregation Method based on Graph Matching for Algebraic MultiGrid Preconditioning of Sparse Linear Systems

A Novel Aggregation Method based on Graph Matching for Algebraic MultiGrid Preconditioning of Sparse Linear Systems A Novel Aggregation Method based on Graph Matching for Algebraic MultiGrid Preconditioning of Sparse Linear Systems Pasqua D Ambra, Alfredo Buttari, Daniela Di Serafino, Salvatore Filippone, Simone Gentile,

More information

Heat and Mass Transfer over Cooled Horizontal Tubes 333 x-component of the velocity: y2 u = g sin x y : (4) r 2 The y-component of the velocity eld is

Heat and Mass Transfer over Cooled Horizontal Tubes 333 x-component of the velocity: y2 u = g sin x y : (4) r 2 The y-component of the velocity eld is Scientia Iranica, Vol., No. 4, pp 332{338 c Sharif University of Technology, October 2004 Vapor Absorption into Liquid Films Flowing over a Column of Cooled Horizontal Tubes B. Farhanieh and F. Babadi

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

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

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

PARALLEL PSEUDO-SPECTRAL SIMULATIONS OF NONLINEAR VISCOUS FINGERING IN MIS- Center for Parallel Computations, COPPE / Federal University of Rio de

PARALLEL PSEUDO-SPECTRAL SIMULATIONS OF NONLINEAR VISCOUS FINGERING IN MIS- Center for Parallel Computations, COPPE / Federal University of Rio de PARALLEL PSEUDO-SPECTRAL SIMULATIONS OF NONLINEAR VISCOUS FINGERING IN MIS- CIBLE DISPLACEMENTS N. Mangiavacchi, A.L.G.A. Coutinho, N.F.F. Ebecken Center for Parallel Computations, COPPE / Federal University

More information

UNIVERSITY OF MARYLAND PRECONDITIONERS FOR THE DISCRETE STEADY-STATE NAVIER-STOKES EQUATIONS CS-TR #4164 / UMIACS TR # JULY 2000

UNIVERSITY OF MARYLAND PRECONDITIONERS FOR THE DISCRETE STEADY-STATE NAVIER-STOKES EQUATIONS CS-TR #4164 / UMIACS TR # JULY 2000 UNIVERSITY OF MARYLAND INSTITUTE FOR ADVANCED COMPUTER STUDIES DEPARTMENT OF COMPUTER SCIENCE PERFORMANCE AND ANALYSIS OF SADDLE POINT PRECONDITIONERS FOR THE DISCRETE STEADY-STATE NAVIER-STOKES EQUATIONS

More information

Basic Aspects of Discretization

Basic Aspects of Discretization Basic Aspects of Discretization Solution Methods Singularity Methods Panel method and VLM Simple, very powerful, can be used on PC Nonlinear flow effects were excluded Direct numerical Methods (Field Methods)

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

Adaptive algebraic multigrid methods in lattice computations

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

More information

9. Iterative Methods for Large Linear Systems

9. Iterative Methods for Large Linear Systems EE507 - Computational Techniques for EE Jitkomut Songsiri 9. Iterative Methods for Large Linear Systems introduction splitting method Jacobi method Gauss-Seidel method successive overrelaxation (SOR) 9-1

More information

Proceedings of Eight SIAM Conference on Parallel Processing for Scientific Computing, 10 pages, CD-ROM Format, Minneapolis, Minnesota, March 14-17,

Proceedings of Eight SIAM Conference on Parallel Processing for Scientific Computing, 10 pages, CD-ROM Format, Minneapolis, Minnesota, March 14-17, Three Dimensional Monte Carlo Device imulation with Parallel Multigrid olver Can K. andalc 1 C. K. Koc 1. M. Goodnick 2 Abstract We present the results in embedding a multigrid solver for Poisson's equation

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

Splitting methods in the design of coupled flow and mechanics simulators

Splitting methods in the design of coupled flow and mechanics simulators Splitting methods in the design of coupled flow and mechanics simulators Sílvia Barbeiro CMUC, Department of Mathematics, University of Coimbra PhD Program in Mathematics Coimbra, November 17, 2010 Sílvia

More information

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

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

More information