SELECTIVE ALGEBRAIC MULTIGRID IN FOAM-EXTEND

Size: px
Start display at page:

Download "SELECTIVE ALGEBRAIC MULTIGRID IN FOAM-EXTEND"

Transcription

1 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 Lučića 5, Zagreb, Croatia, tessa.uroic@fsb.hr Keywords: multigrid, linear solvers, implicitly coupled systems, foam-extend Introduction Discretisation of partial differential equations (PDEs) in the framework of the Finite Volume Method (FVM) typically produces very large sparse matrices with a small number of nonzero entries. Most recent algorithms employ implicit methods in which all equations are solved simultaneously in a single block matrix, including variable cross-coupling terms. In many cases, there exists a non-linear connection between variables, which is eliminated by linearising the equations in order to avoid high-cost non-linear solvers. Choice of an appropriate solver is strongly related to the discretisation method, i.e. matrix properties. As mentioned before, the matrix resulting from the FVM discretisation is sparse, the number of unknowns is the same as the number of equations, thus the matrix is square. Its structure depends on the mesh numbering. Consistent mesh numbering in foam-extend ensures that the matrix is banded, i.e. the non-zero coefficients are grouped around the diagonal in a narrow stripe. Most linear solvers have the optimal performance for certain types of matrices: diagonally dominant, symmetric and positive-definite. Simple iterative solvers such as Jacobi and Gauss Seidel [1] operate in a point-by-point manner and incrementally improve the solution. Thus, in an N-dimensional space of an N by N matrix, fixed-point methods visit each direction of the N-dimensional space separately. On the other hand, Krylov subspace methods [1], such as Generalised Minimal Residual (GMRES) and Conjugate Gradient (CG) methods and its variants, choose the solution direction by evaluating the residual and searching for its smallest components. These methods are fairly efficient when combined with matrix preconditioning [1]. The most powerful class of iterative linear solvers are the multigrid methods [2]. They were originally created for systems of discretised elliptic PDEs but were later expanded and have proven to be efficient for general types of PDEs. Multigrid methods exploit the fact that the beforementioned point-fixed methods tend to quickly reduce the high frequency solution errors, i.e. the errors whose direction corresponds to the largest eigenvalues of the matrix. However, the low frequency errors remain and this is why the performance (convergence) of the fixed-point methods deteriorates. To solve this issue, multigrid methods construct a hierarchy of grids by coarsening the initial grid. The low frequency errors on the finer grid become high frequency errors on the coarser grid and the fixed-point algorithms are able to efficiently reduce these errors. The correction obtained on the coarser grid is then transferred back to the finer grid. This procedure of fine-to-coarse and coarse-to-fine grid communication can be repeated multiple times in various directions which will be defined by the multigrid cycle type. Algebraic multigrid methods operate on matrix coefficients directly and do not need a computational grid. Multigrid is typically used as an extremely efficient preconditioner with the Krylov subspace methods. In this abstract, a newly implemented algebraic multigrid method in foam-extend will be presented. The method is based on the classical multigrid coarsening algorithm (SAMG) [3].

2 Classical SAMG algorithm The new algorithm relies on the existing AMG algorithm and its functionalities including multigrid cycles, smoothers and fine level solvers, with a new method for choosing the coarse level and new coarse-to-fine and fine-to-coarse communication. Construction of the coarse level matrix relies on choosing the representative equations based on the following criteria: 1. In a single matrix row (equation), coefficients with sign opposite to diagonal coefficient are labeled as negative connections. All such coefficients larger than a fraction of the strongest value are strong connections called influences of the equation. Coefficients in the corresponding column of the diagonal coefficient are called dependencies of the equation. 2. Equations with the largest number of dependencies will become coarse. Their strongly dependent neighbours will become fine. 3. There cannot exist two coarse equations that strongly influence one another. 4. Every fine equation must have at least one strong coarse neighbour. However, this rule may be disregarded if there exists an equation without strong connections. After choosing the equations which will remain on the coarse level, interpolation for coarse-to-fine communication must be explicitly calculated. A prolongation matrix for interpolating the solution correction from coarse to fine level is calculated using the equation which describes the algebraically smooth error: a ii e i + j N i a ij e j = 0. (1) where a ii e i = j C i a ij e j j F s i a ij e j j F w i a ij e j, (2) N i is the subset of all neighbours of i C i is the subset of strong coarse neighbours of i F w i F s i is the subset of strong fine neighbours of i is the subset of weak fine neighbours of i The approximation of equation 1 yields interpolation weights for contribution from a single coarse equation to the fine equation: 1 w = α a ii + a C j F w a ij, (3) ij i where α is the scaling factor taking into account negative connections which are not coarse: j C i a ij + j F w = s a ij i > 1 (4) j C i a ij The restriction matrix for transferring the residual from fine to coarse level is obtained as a transpose of prolongation matrix. The coarse level matrix is obtained as a triple product of restriction, fine level matrix and prolongation: A coarse = R A fine P. (5) 2

3 SAMG for block-matrices For scalar matrices, previously described approach can be used directly, while for block matrices arising from implicitly coupled equations, a primary matrix must be chosen, [4]. Interpolation formulas will be based on the primary matrix and the connectivity pattern of the primary variable. The first option is to choose the equations belonging to a single variable as the primary matrix. For example, in the case of implicitly coupled pressurevelocity solver [5], a logical choice for the primary matrix is the pressure equation which has favourable properties: it is elliptic, its matrix is symmetric and the sign of off-diagonal coefficients is opposite to the sign of diagonal coefficient. The coupling of the pressure and velocity is linear, thus the obtained interpolation formulas can be efficiently used for the momentum equation. The second option is to calculate the norm of each block coefficient and use the norm as a criterion in the coarsening procedure. The coarsening algorithm is applied on the chosen primary matrix. The definition of interpolation formulas for the variables of a point P k corresponds to the transfer of interpolation weights wk,l P, where l P k P to diagonal elements of W k,l. They are transferred to the w i,j with i P k and j P l such that i and j belong to the same unknown [4]. w P k,l 0 W k,l =..... (6) 0 wk,l P Another simplified method of choosing the coarse level matrix is the aggregation-based algebraic multigrid (AAMG), [6]. Instead of selecting certain equations for the coarse level, the fine level equations are joined to form aggregates (clusters). These aggregates are represented by a single equation on the coarse level. The interpolation operator does not have to be explicitly calculated as the values from the coarse level are directly copied (injected) for each member of the aggregate (with options of geometrical scaling). The coarse level matrix is formed by adding up the equations (additive correction, [7]). The implementation of this approach is straightforward but the convergence is limited by the incorrect interpolation formulas. In the next section, performance of the algorithm based on selection of coarse equations is compared to performance of the aggregation-based multigrid for the pressure-velocity block-coupled algorithm. Results The case chosen for examining the performance of SAMG is the 2D turbulent flow over a backward facing step, Fig. 1. The setup of the linear solver for the coupled velocity and pressure equation is shown in Tab. 1. First test case was run with the aggregative multigrid and the criterion for joining cells into aggregates was calculated using the pressure equation (component norm). The same norm (or primary matrix) was used for the selective multigrid. Selective multigrid was also tested with the Frobenius (two norm) which takes into account the momentum equation. For all cases, the minimal number of coarse level equations was 4, relative tolerance and ILUCp with fill in level 1 was used for smoothing the error. Figure 1: Pressure and velocity field for the backward facing step case. Different algorithms and norms have produced different coarse levels, which is illustated in Fig. 2. For SAMG, the cells are coloured by the spectrum (from blue to magenta) and the colour denotes the strength or 3

4 Table 1: Setup of AMG solver for the Up system Algorithm AAMG SAMG SAMG Cycle W-cycle W-cycle W-cycle Norm Component Component Frobenius Smoother ILUCp (fill in 1) ILUCp (fill in 1) ILUCp (fill in 1) Min. coarse equations Relative tolerance Number of coarsening levels Number of linear iterations Converged 111 s 50 s 117 s order of appearance of coarse equations. Blue cells have the strongest equation (they become coarse the first), while magenta is the weakest (they become coarse the last). This fact is very important because the order of appearance of equations will dictate the order of smoothing and will also affect the structure of the coarse level matrix. Figure 2: First coarsening level, from top to bottom: AAMG, SAMG with component norm, SAMG with Frobenius norm AAMG and SAMG have produced different number of coarsening levels: AAMG has 7 while SAMG has 5. The second and fifth level are shown in Figs. 3 and 4, respectively. Figure 3: Second coarsening level, from top to bottom: AAMG, SAMG with component norm, SAMG with Frobenius norm It is obvious that the two norms used with SAMG produce different coarse levels. In this case, the component norm, or the interpolation based on the pressure equation gave better convergence. The reason could be the interpolation formula itself or the efectiveness of the smoother on coarse level matrices with 4

5 Figure 4: Fifth coarsening level, from top to bottom: AAMG, SAMG with component norm, SAMG with Frobenius norm 20 Number of linear solver iterations AAMG (cluster) SAMG (two norm) SAMG (component norm) Residual 1e+00 1e-01 1e-02 1e-03 1e-04 1e-05 Backwardfacing step - pucoupledfoam - cluster U x U y U z p k ε 1e Outer iteration 1e Execution time 1e+00 1e-01 1e-02 Backwardfacing step - pucoupledfoam - SAMG - component norm U x U y U z p k ε 1e+00 1e-01 1e-02 Backwardfacing step - pucoupledfoam - SAMG - Frobenius norm U x U y U z p k ε Residual 1e-03 1e-04 Residual 1e-03 1e-04 1e-05 1e-05 1e-06 1e-06 1e Execution time 1e Execution time Figure 5: Number of linear iterations and convergence for all cases mentioned in Tab. 1. different structure. AAMG takes 870 linear iterations until convergence (tolerance is 10 6 in all cases) with time per iteration of 0.13 s. SAMG with component norm takes only 175 iterations and time per iteration is 0.29 s. SAMG with Frobenius norm takes 519 iterations or 0.22 s per iteration. Convergence and number of linear iterations are shown in Fig. 5. Conclusion 1. Selective algebraic multigrid (SAMG) converges faster than the agglomerative algebraic multigrid (AAMG) due to the better interpolation of algebraically smooth error. 2. Coarsening norm influences the choice and order of appearance of coarse equations. This has a direct 5

6 impact on the structure of coarse level matrix and performance of the smoother. 3. For coarsening and interpolation, choice of the block coefficient norm can influence the convergence of the linear solver. However, best practice was not established as some norms work better for certain cases and worse for other cases. SAMG algorithm is parallelised for both scalar and block matrices and more details on parallelisation and parallel performance will be given in the full paper. References [1] Y. Saad, Iterative methods for sparse linear systems. SIAM, [2] U. Trottenberg, C. Oosterlee, and A. Schüller, Multigrid. Elsevier, Academic Press, [3] K. Stueben, A review of algebraic multigrid, Journal of Computational and Applied Mathematics, vol. 128, pp , [4] T. Clees, AMG strategies for PDE systems with applications in industrial semiconductor simulation, PhD Thesis, University of Cologne, Germany, [5] M. Zedan and G. Schneider, A strongly implicit simultaneous variable solution procedure for velocity and pressure in fluid flow problems, in AIAA 18th Thermophysics Conference, Montreal, Canada, [6] M. Raw, A coupled algebraic multigrid method for the 3D Navier-Stokes Equations, Fast solvers for flow problems, vol. 49, pp , [7] B. Hutchinson, P. Galpin, and G. Raithby, Application of additive correction multigrid to the coupled fluid flow equations, Numerical heat transfer, vol. 13, pp , [8] S. Patankar and D. Spalding, A calculation procedure for heat, mass and momentum transfer in threedimensional parabolic flows, International journal of heat and mass transfer, vol. 15, pp ,

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

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

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

Handling Parallelisation in OpenFOAM

Handling Parallelisation in OpenFOAM Handling Parallelisation in OpenFOAM Hrvoje Jasak hrvoje.jasak@fsb.hr Faculty of Mechanical Engineering and Naval Architecture University of Zagreb, Croatia Handling Parallelisation in OpenFOAM p. 1 Parallelisation

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

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

AMS526: Numerical Analysis I (Numerical Linear Algebra)

AMS526: Numerical Analysis I (Numerical Linear Algebra) AMS526: Numerical Analysis I (Numerical Linear Algebra) Lecture 20: Sparse Linear Systems; Direct Methods vs. Iterative Methods Xiangmin Jiao SUNY Stony Brook Xiangmin Jiao Numerical Analysis I 1 / 26

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

Distributed NVAMG. Design and Implementation of a Scalable Algebraic Multigrid Framework for a Cluster of GPUs

Distributed NVAMG. Design and Implementation of a Scalable Algebraic Multigrid Framework for a Cluster of GPUs Distributed NVAMG Design and Implementation of a Scalable Algebraic Multigrid Framework for a Cluster of GPUs Istvan Reguly (istvan.reguly at oerc.ox.ac.uk) Oxford e-research Centre NVIDIA Summer Internship

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

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

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

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

Multigrid Methods for Markov Chains

Multigrid Methods for Markov Chains Multigrid Methods for Markov Chains Hans De Sterck Department of Applied Mathematics, University of Waterloo collaborators Killian Miller Department of Applied Mathematics, University of Waterloo, Canada

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

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

OpenFOAM: A C++ Library for Complex Physics Simulations

OpenFOAM: A C++ Library for Complex Physics Simulations OpenFOAM: A C++ Library for Complex Physics Simulations Hrvoje Jasak Aleksandar Jemcov and Željko Tuković h.jasak@wikki.co.uk Wikki Ltd, United Kingdom FSB, University of Zagreb, Croatia Development Department,

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

Algorithms, System and Data Centre Optimisation for Energy Efficient HPC

Algorithms, System and Data Centre Optimisation for Energy Efficient HPC 2015-09-14 Algorithms, System and Data Centre Optimisation for Energy Efficient HPC Vincent Heuveline URZ Computing Centre of Heidelberg University EMCL Engineering Mathematics and Computing Lab 1 Energy

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

Solution of 2D Euler Equations and Application to Airfoil Design

Solution of 2D Euler Equations and Application to Airfoil Design WDS'6 Proceedings of Contributed Papers, Part I, 47 52, 26. ISBN 8-86732-84-3 MATFYZPRESS Solution of 2D Euler Equations and Application to Airfoil Design J. Šimák Charles University, Faculty of Mathematics

More information

Fast Iterative Solvers for Markov Chains, with Application to Google's PageRank. Hans De Sterck

Fast Iterative Solvers for Markov Chains, with Application to Google's PageRank. Hans De Sterck Fast Iterative Solvers for Markov Chains, with Application to Google's PageRank Hans De Sterck Department of Applied Mathematics University of Waterloo, Ontario, Canada joint work with Steve McCormick,

More information

Second OpenFOAM Workshop: Welcome and Introduction

Second OpenFOAM Workshop: Welcome and Introduction Second OpenFOAM Workshop: Welcome and Introduction Hrvoje Jasak h.jasak@wikki.co.uk Wikki Ltd, United Kingdom and FSB, University of Zagreb, Croatia 7-9th June 2007 Second OpenFOAM Workshop:Welcome and

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

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

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

AN ALGEBRAIC MULTIGRID SOLUTION STRATEGY FOR EFFICIENT SOLUTION OF FREE-SURFACE FLOWS WILHELM J. VAN DEN BERGH

AN ALGEBRAIC MULTIGRID SOLUTION STRATEGY FOR EFFICIENT SOLUTION OF FREE-SURFACE FLOWS WILHELM J. VAN DEN BERGH DEPARTMENT OF MECHANICAL AND AERONAUTICAL ENGINEERING UNIVERSITY OF PRETORIA AN ALGEBRAIC MULTIGRID SOLUTION STRATEGY FOR EFFICIENT SOLUTION OF FREE-SURFACE FLOWS WILHELM J. VAN DEN BERGH SUPERVISED BY

More information

Lecture 15: More Iterative Ideas

Lecture 15: More Iterative Ideas Lecture 15: More Iterative Ideas David Bindel 15 Mar 2010 Logistics HW 2 due! Some notes on HW 2. Where we are / where we re going More iterative ideas. Intro to HW 3. More HW 2 notes See solution code!

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

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

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

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

Final drive lubrication modeling

Final drive lubrication modeling Final drive lubrication modeling E. Avdeev a,b 1, V. Ovchinnikov b a Samara University, b Laduga Automotive Engineering Abstract. In this paper we describe the method, which is the composition of finite

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

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

A High-Order Accurate Unstructured GMRES Solver for Poisson s Equation

A High-Order Accurate Unstructured GMRES Solver for Poisson s Equation A High-Order Accurate Unstructured GMRES Solver for Poisson s Equation Amir Nejat * and Carl Ollivier-Gooch Department of Mechanical Engineering, The University of British Columbia, BC V6T 1Z4, Canada

More information

c 2006 Society for Industrial and Applied Mathematics

c 2006 Society for Industrial and Applied Mathematics SIAM J. MATRIX ANAL. APPL. Vol. 27, No. 4, pp. 1019 1039 c 2006 Society for Industrial and Applied Mathematics REDUCING COMPLEXITY IN PARALLEL ALGEBRAIC MULTIGRID PRECONDITIONERS HANS DE STERCK, ULRIKE

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

ACCELERATING CFD AND RESERVOIR SIMULATIONS WITH ALGEBRAIC MULTI GRID Chris Gottbrath, Nov 2016

ACCELERATING CFD AND RESERVOIR SIMULATIONS WITH ALGEBRAIC MULTI GRID Chris Gottbrath, Nov 2016 ACCELERATING CFD AND RESERVOIR SIMULATIONS WITH ALGEBRAIC MULTI GRID Chris Gottbrath, Nov 2016 Challenges What is Algebraic Multi-Grid (AMG)? AGENDA Why use AMG? When to use AMG? NVIDIA AmgX Results 2

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

On Improving Computational Efficiency of Simplified Fluid Flow Models

On Improving Computational Efficiency of Simplified Fluid Flow Models 1447 A publication of CHEMICAL ENGINEERING TRANSACTIONS VOL. 70, 2018 Guest Editors: Timothy G. Walmsley, Petar S. Varbanov, Rongxin Su, Jiří J. Klemeš Copyright 2018, AIDIC Servizi S.r.l. ISBN 978-88-95608-67-9;

More information

PROJECT REPORT. Symbol based Multigrid method. Hreinn Juliusson, Johanna Brodin, Tianhao Zhang Project in Computational Science: Report

PROJECT REPORT. Symbol based Multigrid method. Hreinn Juliusson, Johanna Brodin, Tianhao Zhang Project in Computational Science: Report Symbol based Multigrid method Hreinn Juliusson, Johanna Brodin, Tianhao Zhang Project in Computational Science: Report February 20, 2018 PROJECT REPORT Department of Information Technology Abstract Discretization

More information

Space Filling Curves and Hierarchical Basis. Klaus Speer

Space Filling Curves and Hierarchical Basis. Klaus Speer Space Filling Curves and Hierarchical Basis Klaus Speer Abstract Real world phenomena can be best described using differential equations. After linearisation we have to deal with huge linear systems of

More information

All use is subject to licence. See For any commercial application, a separate license must be signed.

All use is subject to licence. See  For any commercial application, a separate license must be signed. HSL HSL MI20 PACKAGE SPECIFICATION HSL 2007 1 SUMMARY Given an n n sparse matrix A and an n vector z, HSL MI20 computes the vector x = Mz, where M is an algebraic multigrid (AMG) v-cycle preconditioner

More information

GPU-Accelerated Algebraic Multigrid for Commercial Applications. Joe Eaton, Ph.D. Manager, NVAMG CUDA Library NVIDIA

GPU-Accelerated Algebraic Multigrid for Commercial Applications. Joe Eaton, Ph.D. Manager, NVAMG CUDA Library NVIDIA GPU-Accelerated Algebraic Multigrid for Commercial Applications Joe Eaton, Ph.D. Manager, NVAMG CUDA Library NVIDIA ANSYS Fluent 2 Fluent control flow Accelerate this first Non-linear iterations Assemble

More information

Chapter 4. Matrix and Vector Operations

Chapter 4. Matrix and Vector Operations 1 Scope of the Chapter Chapter 4 This chapter provides procedures for matrix and vector operations. This chapter (and Chapters 5 and 6) can handle general matrices, matrices with special structure and

More information

Comparison of parallel preconditioners for a Newton-Krylov flow solver

Comparison of parallel preconditioners for a Newton-Krylov flow solver Comparison of parallel preconditioners for a Newton-Krylov flow solver Jason E. Hicken, Michal Osusky, and David W. Zingg 1Introduction Analysis of the results from the AIAA Drag Prediction workshops (Mavriplis

More information

Reducing Communication Costs Associated with Parallel Algebraic Multigrid

Reducing Communication Costs Associated with Parallel Algebraic Multigrid Reducing Communication Costs Associated with Parallel Algebraic Multigrid Amanda Bienz, Luke Olson (Advisor) University of Illinois at Urbana-Champaign Urbana, IL 11 I. PROBLEM AND MOTIVATION Algebraic

More information

Performance of Implicit Solver Strategies on GPUs

Performance of Implicit Solver Strategies on GPUs 9. LS-DYNA Forum, Bamberg 2010 IT / Performance Performance of Implicit Solver Strategies on GPUs Prof. Dr. Uli Göhner DYNAmore GmbH Stuttgart, Germany Abstract: The increasing power of GPUs can be used

More information

Memory Efficient Adaptive Mesh Generation and Implementation of Multigrid Algorithms Using Sierpinski Curves

Memory Efficient Adaptive Mesh Generation and Implementation of Multigrid Algorithms Using Sierpinski Curves Memory Efficient Adaptive Mesh Generation and Implementation of Multigrid Algorithms Using Sierpinski Curves Michael Bader TU München Stefanie Schraufstetter TU München Jörn Behrens AWI Bremerhaven Abstract

More information

FINITE ELEMENT SOLUTION OF NAVIER-STOKES EQUATIONS USING KRYLOV SUBSPACE METHODS

FINITE ELEMENT SOLUTION OF NAVIER-STOKES EQUATIONS USING KRYLOV SUBSPACE METHODS HEFAT2014 10 th International Conference on Heat Transfer, Fluid Mechanics and Thermodynamics 14 16 July 2014 Orlando, Florida FINITE ELEMENT SOLUTION OF NAVIER-STOKES EQUATIONS USING KRYLOV SUBSPACE METHODS

More information

Scalability of Elliptic Solvers in NWP. Weather and Climate- Prediction

Scalability of Elliptic Solvers in NWP. Weather and Climate- Prediction Background Scaling results Tensor product geometric multigrid Summary and Outlook 1/21 Scalability of Elliptic Solvers in Numerical Weather and Climate- Prediction Eike Hermann Müller, Robert Scheichl

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

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

FOR P3: A monolithic multigrid FEM solver for fluid structure interaction

FOR P3: A monolithic multigrid FEM solver for fluid structure interaction FOR 493 - P3: A monolithic multigrid FEM solver for fluid structure interaction Stefan Turek 1 Jaroslav Hron 1,2 Hilmar Wobker 1 Mudassar Razzaq 1 1 Institute of Applied Mathematics, TU Dortmund, Germany

More information

THE DEVELOPMENT OF THE POTENTIAL AND ACADMIC PROGRAMMES OF WROCLAW UNIVERISTY OF TECH- NOLOGY ITERATIVE LINEAR SOLVERS

THE DEVELOPMENT OF THE POTENTIAL AND ACADMIC PROGRAMMES OF WROCLAW UNIVERISTY OF TECH- NOLOGY ITERATIVE LINEAR SOLVERS ITERATIVE LIEAR SOLVERS. Objectives The goals of the laboratory workshop are as follows: to learn basic properties of iterative methods for solving linear least squares problems, to study the properties

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

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

Computational Fluid Dynamics - Incompressible Flows

Computational Fluid Dynamics - Incompressible Flows Computational Fluid Dynamics - Incompressible Flows March 25, 2008 Incompressible Flows Basis Functions Discrete Equations CFD - Incompressible Flows CFD is a Huge field Numerical Techniques for solving

More information

Structured-grid multigrid with Taylor-Hood finite elements

Structured-grid multigrid with Taylor-Hood finite elements Structured-grid multigrid with Taylor-Hood finite elements by c Lukas Spies A thesis submitted to the School of Graduate Studies in partial fulfillment of the requirements for the degree of Masters of

More information

Public Release: Native Overset Mesh in FOAM-Extend

Public Release: Native Overset Mesh in FOAM-Extend Public Release: Native Overset Mesh in FOAM-Extend Vuko Vukčević and Hrvoje Jasak Faculty of Mechanical Engineering and Naval Architecture, Uni Zagreb, Croatia Wikki Ltd. United Kingdom 5th OpenFOAM UK

More information

OpenFOAM: Open Platform for Complex Physics Simulations

OpenFOAM: Open Platform for Complex Physics Simulations OpenFOAM: Open Platform for Complex Physics Simulations Hrvoje Jasak h.jasak@wikki.co.uk, hrvoje.jasak@fsb.hr FSB, University of Zagreb, Croatia Wikki Ltd, United Kingdom 18th October 2007 OpenFOAM: Open

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

1 Exercise: 1-D heat conduction with finite elements

1 Exercise: 1-D heat conduction with finite elements 1 Exercise: 1-D heat conduction with finite elements Reading This finite element example is based on Hughes (2000, sec. 1.1-1.15. 1.1 Implementation of the 1-D heat equation example In the previous two

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

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

Higher Order Multigrid Algorithms for a 2D and 3D RANS-kω DG-Solver

Higher Order Multigrid Algorithms for a 2D and 3D RANS-kω DG-Solver www.dlr.de Folie 1 > HONOM 2013 > Marcel Wallraff, Tobias Leicht 21. 03. 2013 Higher Order Multigrid Algorithms for a 2D and 3D RANS-kω DG-Solver Marcel Wallraff, Tobias Leicht DLR Braunschweig (AS - C

More information

OpenFOAM + GPGPU. İbrahim Özküçük

OpenFOAM + GPGPU. İbrahim Özküçük OpenFOAM + GPGPU İbrahim Özküçük Outline GPGPU vs CPU GPGPU plugins for OpenFOAM Overview of Discretization CUDA for FOAM Link (cufflink) Cusp & Thrust Libraries How Cufflink Works Performance data of

More information

A FULLY COUPLED FINITE VOLUME SOLVER FOR THE SOLUTION OF INCOMPRESSIBLE FLOWS ON LOCALLY REFINED NON-MATCHING BLOCK-STRUCTURED GRIDS

A FULLY COUPLED FINITE VOLUME SOLVER FOR THE SOLUTION OF INCOMPRESSIBLE FLOWS ON LOCALLY REFINED NON-MATCHING BLOCK-STRUCTURED GRIDS VI International Conference on Adaptive Modeling and Simulation ADMOS 2013 J. P. Moitinho de Almeida, P. Díez, C. Tiago and N. Parés (Eds) A FULLY COUPLED FINITE VOLUME SOLVER FOR THE SOLUTION OF INCOMPRESSIBLE

More information

GPU PROGRESS AND DIRECTIONS IN APPLIED CFD

GPU PROGRESS AND DIRECTIONS IN APPLIED CFD Eleventh International Conference on CFD in the Minerals and Process Industries CSIRO, Melbourne, Australia 7-9 December 2015 GPU PROGRESS AND DIRECTIONS IN APPLIED CFD Stan POSEY 1*, Simon SEE 2, and

More information

Efficient multigrid solvers for strongly anisotropic PDEs in atmospheric modelling

Efficient multigrid solvers for strongly anisotropic PDEs in atmospheric modelling Iterative Solvers Numerical Results Conclusion and outlook 1/22 Efficient multigrid solvers for strongly anisotropic PDEs in atmospheric modelling Part II: GPU Implementation and Scaling on Titan Eike

More information

Construction and application of hierarchical matrix preconditioners

Construction and application of hierarchical matrix preconditioners University of Iowa Iowa Research Online Theses and Dissertations 2008 Construction and application of hierarchical matrix preconditioners Fang Yang University of Iowa Copyright 2008 Fang Yang This dissertation

More information

Accelerated ANSYS Fluent: Algebraic Multigrid on a GPU. Robert Strzodka NVAMG Project Lead

Accelerated ANSYS Fluent: Algebraic Multigrid on a GPU. Robert Strzodka NVAMG Project Lead Accelerated ANSYS Fluent: Algebraic Multigrid on a GPU Robert Strzodka NVAMG Project Lead A Parallel Success Story in Five Steps 2 Step 1: Understand Application ANSYS Fluent Computational Fluid Dynamics

More information

Adaptive Smoothed Aggregation (αsa) Multigrid

Adaptive Smoothed Aggregation (αsa) Multigrid SIAM REVIEW Vol. 47,No. 2,pp. 317 346 c 2005 Society for Industrial and Applied Mathematics Adaptive Smoothed Aggregation (αsa) Multigrid M. Brezina R. Falgout S. MacLachlan T. Manteuffel S. McCormick

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

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

(Sparse) Linear Solvers

(Sparse) Linear Solvers (Sparse) Linear Solvers Ax = B Why? Many geometry processing applications boil down to: solve one or more linear systems Parameterization Editing Reconstruction Fairing Morphing 2 Don t you just invert

More information

Algebraic Multigrid Methods Based on Generic Approximate Banded Inverse Matrix Techniques

Algebraic Multigrid Methods Based on Generic Approximate Banded Inverse Matrix Techniques Copyright 2014 Tech Science Press CMES, vol.100, no.4, pp.323-345, 2014 Algebraic Multigrid Methods Based on Generic Approximate Banded Inverse Matrix Techniques George A. Gravvanis 1, Christos K. Filelis-Papadopoulos

More information

Solver Settings. Introductory FLUENT Training ANSYS, Inc. All rights reserved. ANSYS, Inc. Proprietary

Solver Settings. Introductory FLUENT Training ANSYS, Inc. All rights reserved. ANSYS, Inc. Proprietary Solver Settings Introductory FLUENT Training 2006 ANSYS, Inc. All rights reserved. 2006 ANSYS, Inc. All rights reserved. 5-2 Outline Using the Solver Setting Solver Parameters Convergence Definition Monitoring

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

A NEW MIXED PRECONDITIONING METHOD BASED ON THE CLUSTERED ELEMENT -BY -ELEMENT PRECONDITIONERS

A NEW MIXED PRECONDITIONING METHOD BASED ON THE CLUSTERED ELEMENT -BY -ELEMENT PRECONDITIONERS Contemporary Mathematics Volume 157, 1994 A NEW MIXED PRECONDITIONING METHOD BASED ON THE CLUSTERED ELEMENT -BY -ELEMENT PRECONDITIONERS T.E. Tezduyar, M. Behr, S.K. Aliabadi, S. Mittal and S.E. Ray ABSTRACT.

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

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

An efficient method for graph Laplacian systems

An efficient method for graph Laplacian systems An efficient method for graph Laplacian systems Artem Napov and Yvan Notay Service de Métrologie Nucléaire Université Libre de Bruxelles (C.P. 165/84) 50, Av. F.D. Roosevelt, B-1050 Brussels, Belgium.

More information

An algebraic multi-grid implementation in FEniCS for solving 3d fracture problems using XFEM

An algebraic multi-grid implementation in FEniCS for solving 3d fracture problems using XFEM An algebraic multi-grid implementation in FEniCS for solving 3d fracture problems using XFEM Axel Gerstenberger, Garth N. Wells, Chris Richardson, David Bernstein, and Ray Tuminaro FEniCS 14, Paris, France

More information

This is an author-deposited version published in: Eprints ID: 16478

This is an author-deposited version published in:  Eprints ID: 16478 Open Archive TOULOUSE Archive Ouverte (OATAO) OATAO is an open access repository that collects the work of Toulouse researchers and makes it freely available over the web where possible. This is an author-deposited

More information

Multi-GPU Acceleration of Algebraic Multigrid Preconditioners

Multi-GPU Acceleration of Algebraic Multigrid Preconditioners Multi-GPU Acceleration of Algebraic Multigrid Preconditioners Christian Richter 1, Sebastian Schöps 2, and Markus Clemens 1 Abstract A multi-gpu implementation of Krylov subspace methods with an 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

Partial Differential Equations

Partial Differential Equations Simulation in Computer Graphics Partial Differential Equations Matthias Teschner Computer Science Department University of Freiburg Motivation various dynamic effects and physical processes are described

More information

S0432 NEW IDEAS FOR MASSIVELY PARALLEL PRECONDITIONERS

S0432 NEW IDEAS FOR MASSIVELY PARALLEL PRECONDITIONERS S0432 NEW IDEAS FOR MASSIVELY PARALLEL PRECONDITIONERS John R Appleyard Jeremy D Appleyard Polyhedron Software with acknowledgements to Mark A Wakefield Garf Bowen Schlumberger Outline of Talk Reservoir

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

(Sparse) Linear Solvers

(Sparse) Linear Solvers (Sparse) Linear Solvers Ax = B Why? Many geometry processing applications boil down to: solve one or more linear systems Parameterization Editing Reconstruction Fairing Morphing 1 Don t you just invert

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

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

On the regularizing power of multigrid-type algorithms

On the regularizing power of multigrid-type algorithms On the regularizing power of multigrid-type algorithms Marco Donatelli Dipartimento di Fisica e Matematica Università dell Insubria www.mat.unimi.it/user/donatel Outline 1 Restoration of blurred and noisy

More information

The 3D DSC in Fluid Simulation

The 3D DSC in Fluid Simulation The 3D DSC in Fluid Simulation Marek K. Misztal Informatics and Mathematical Modelling, Technical University of Denmark mkm@imm.dtu.dk DSC 2011 Workshop Kgs. Lyngby, 26th August 2011 Governing Equations

More information

Solving Partial Differential Equations on Overlapping Grids

Solving Partial Differential Equations on Overlapping Grids **FULL TITLE** ASP Conference Series, Vol. **VOLUME**, **YEAR OF PUBLICATION** **NAMES OF EDITORS** Solving Partial Differential Equations on Overlapping Grids William D. Henshaw Centre for Applied Scientific

More information

Development of an Integrated Computational Simulation Method for Fluid Driven Structure Movement and Acoustics

Development of an Integrated Computational Simulation Method for Fluid Driven Structure Movement and Acoustics Development of an Integrated Computational Simulation Method for Fluid Driven Structure Movement and Acoustics I. Pantle Fachgebiet Strömungsmaschinen Karlsruher Institut für Technologie KIT Motivation

More information

Reconstruction of Trees from Laser Scan Data and further Simulation Topics

Reconstruction of Trees from Laser Scan Data and further Simulation Topics Reconstruction of Trees from Laser Scan Data and further Simulation Topics Helmholtz-Research Center, Munich Daniel Ritter http://www10.informatik.uni-erlangen.de Overview 1. Introduction of the Chair

More information

Performance Studies for the Two-Dimensional Poisson Problem Discretized by Finite Differences

Performance Studies for the Two-Dimensional Poisson Problem Discretized by Finite Differences Performance Studies for the Two-Dimensional Poisson Problem Discretized by Finite Differences Jonas Schäfer Fachbereich für Mathematik und Naturwissenschaften, Universität Kassel Abstract In many areas,

More information