Efficient FEM-multigrid solver for granular material

Size: px
Start display at page:

Download "Efficient FEM-multigrid solver for granular material"

Transcription

1 Efficient FEM-multigrid solver for granular material S. Mandal, A. Ouazzi, S. Turek Chair for Applied Mathematics and Numerics (LSIII), TU Dortmund STW user committee meeting Enschede, 25th September, 2014

2 Contents 1 Introduction 2 Mathematical formulation 3 Numerical Results 4 Conclusion and outlook

3 Contents 1 Introduction 2 Mathematical formulation 3 Numerical Results 4 Conclusion and outlook

4 Generalized Navier-Stokes equation Conservation of mass u = 0 in Conservation of momentum Dt = p + σ + f in along with some initial and boundary conditions ρ Du Flow Rheology σ = 2η(γ II, p) γ; where γ = 1 2 ( u + ut ), and 2γ II = γ : γ = γ 2 = tr[( γ) 2 ] Nonlinear and coupled equations

5 Miscellaneous models Fluid models η(γ II, p) = η 0, for Newtonian fluid = η 0 ( γ 2 + ɛ) m 2 1, for Power law fluid Granular materials η(γ II, p) = 2p sin φ 1, Schaeffer model γ = 2p(sin φ + b cos φ γ n ) 1, Schaeffer-Tardos model γ 2 = αp 2 γ + βdp, Poliquen model δ p ρ + γ d

6 Contents 1 Introduction 2 Mathematical formulation 3 Numerical Results 4 Conclusion and outlook

7 Bilinear Form Find (u, p) X M such that 2η(γ II, p)d(u) : D(v)dx+ (u. u)vdx + p div vdx = fvdx, v X; with q div udx = 0, q M Compact form Find (u, p) X M such that L(u, p)u, v + N(u)u, v + Bp, v = fvdx, v X; }{{} Au }{{} g q, B T u = 0, q M

8 Nonlinear discrete system FEM discretization We take X h X and M h M Find (ũ, p) X h M h such that ( ) (ũ ) ( ) A B g = B T 0 p 0 Nonlinear saddle point problem!

9 Newton solver Motivation Strongly coupled problem Solution x n+1 = (ũ, p), Residual equation R(x n ) x n+1 = x n + w n[ R(x n )] 1R(x n x ) Automatic damping control w n for each nonlinear step Quadratic convergence when iterative solutions are close to the actual one

10 Newton solver Jacobian with respect to the Diffusive term 2η(γ II (u l ), p l )D(u) : D(v)dx η(γ II (u l ), p l )[D(u l ) : D(u)][D(u l ) : D(v)]dx η(γ II (u l ), p l )[D(u l ) : D(v)]pdx = fvdx 2η(γ II (u l ), p l )D(u l ) : D(v)dx, v V Jacobian with respect to the Convective term (u l. u)vdx + (u. u l )vdx v X,

11 Newton solver Diffusive term 2η(γ II (u l ), p l )D(u) : D(v)dx L η(γ II (u l ), p l )[D(u l ) : D(u)][D(u l ) : D(v)]dx L η(γ II (u l ), p l )[D(u l ) : D(v)]pdx B = fvdx 2η(γ II (u l ), p l )D(u l ) : D(v)dx, v V Convective term (u l. u)vdx N + (u. u l )vdx N v X,

12 Linear system Final discrete problem Compute ũ and p by solving ( ) (ũ ) ( ) A B Resũ = B T 0 p Res p where Aũ = [(L + δ d L )(ũ l, p l ) + (N + δ c N )(ũ l )]ũ, B p = [B + δ p B (ũ l, p l )] p Unusual saddle point problem!

13 Linear solver Multigrid techniques Direct Gauss elimination as coarse-grid solver General VANKA smoother with block-diagonal preconditioner F-cycle multigrid Intergrid transfer and coarse grid correction based on the underlying mesh hierarchy and the finite elements

14 Contents 1 Introduction 2 Mathematical formulation 3 Numerical Results 4 Conclusion and outlook

15 Benchmark problem Figure : Geometry for the flow around cylinder configuration Figure : Computational mesh for the flow around cylinder configuration

16 Featflow Why Featflow Basic flow solver for incompressible fluids Supports higher order (space/time) FEM Use of unstructured meshes Dynamic adaptive grid formulation FEM based tools FEM characteristics Stable FE spaces for velocity/pressure and velocity/stress interpolation; e.g. Q2/P1 Special treatments of the convective term - EO FEM, TVD/FCT

17 Inner solver Solver Nonlinearity handled by Newton method Monolithic Multigrid techniques for the auxiliary linearized problem Vanishing shear rate taken care by the regularization parameter Appropriate module to ensure unique and positive pressure Advantages Inf-sup stable (LBB condition) for velocity and pressure Higher order is good for accuracy Discontinuous pressure is good for the solver

18 Results Shear-thinning fluid η(γ II, p) = η 0 ( γ 2 + ɛ) m 2 1, η 0 = 10 3, m = 1.5, ɛ = 0.1 MG Drag Lift Solver Statistics Level Ref 1 Feat2 Ref 1 Feat2 Ref 1 Feat /3 8/ /2 4/ /2 3/ /2 3/2 Efficient nonlinear and linear solver Ref 1 : Damanik et al. Monolithic Newton-multigrid solution techniques for incompressible nonlinear flow models, International Journal for Numerical Methods in Fluids, Volume 71, Issues 2, pages

19 Results Shear-thickening fluid η(γ II, p) = η 0 ( γ 2 + ɛ) m 2 1, η 0 = 10 3, m = 3.0, ɛ = 0.1 MG Drag Lift Solver Statistics Level Ref 1 Feat2 Ref 1 Feat2 Ref 1 Feat /2 6/ /2 3/ /2 3/ /1 3/1 Ref 1 : Damanik et al. Monolithic Newton-multigrid solution techniques for incompressible nonlinear flow models, International Journal for Numerical Methods in Fluids, Volume 71, Issues 2, pages

20 Results Test case η(γ II, p) = η 0 exp(p), η 0 = 10 3 Fluid Level Drag Lift Solver Statistics E E-02 5/3 Test case E E-02 3/ E E-02 3/ E E-02 2/1.5

21 Contents 1 Introduction 2 Mathematical formulation 3 Numerical Results 4 Conclusion and outlook

22 Conclusion Summary Newton solver for nonlinearity Multigrid techniques for the linearized problem Numerical examples 1 non-newtonian fluids including shear thinning and shear thickening fluid 2 Test case with pressure dependant viscosity Continuous Newton solver Nonlinear Continuous Linear Discrete Linear FEM discr MG Solution

23 Outlook Current work Benchmarking of Poliquen model Test with split-bottom geometry To incorporate Tardos model [ ρ Du = p + Dt Questions q(p, ρ) D 1 n ui ρ t + (ρu) = 0 q(p, ρ) u = D 1 p n ui How to fix the pressure range? 2D version of split-bottom geometry? ( D 1 n ui ) ] + ρg; n = 2, 3

24 THANK YOU!

Newton-Multigrid Least-Squares FEM for S-V-P Formulation of the Navier-Stokes Equations

Newton-Multigrid Least-Squares FEM for S-V-P Formulation of the Navier-Stokes Equations Newton-Multigrid Least-Squares FEM for S-V-P Formulation of the Navier-Stokes Equations A. Ouazzi, M. Nickaeen, S. Turek, and M. Waseem Institut für Angewandte Mathematik, LSIII, TU Dortmund, Vogelpothsweg

More information

Numerical Simulation of Powder Flow

Numerical Simulation of Powder Flow Numerical Simulation of Powder Flow Stefan Turek, Abderrahim Ouazzi Institut für Angewandte Mathematik, Univ. Dortmund http://www.mathematik.uni-dortmund.de/ls3 http://www.featflow.de Models for granular

More information

FEM techniques for nonlinear fluids

FEM techniques for nonlinear fluids FEM techniques for nonlinear fluids From non-isothermal, pressure and shear dependent viscosity models to viscoelastic flow A. Ouazzi, H. Damanik, S. Turek Institute of Applied Mathematics, LS III, TU

More information

Monolithic FEM multigrid techniques for the simulation of viscoelastic flow

Monolithic FEM multigrid techniques for the simulation of viscoelastic flow Monolithic FEM multigrid techniques for the simulation of viscoelastic flow A. Ouazzi, H. Damanik, S. Turek, J. Hron Institute of Applied Mathematics, LS III, TU Dortmund http://www.featflow.de European

More information

Numerical simulation of powder flow by Finite Element methods

Numerical simulation of powder flow by Finite Element methods Numerical simulation of powder flow by Finite Element methods S. Turek and A. Ouazzi Institute of Applied Mathematics, University of Dortmund, 44227 Dortmund, Germany Abstract In contrast to most fluids,

More information

A Multigrid LCR-FEM solver for viscoelastic fluids with application to problems with free surface

A Multigrid LCR-FEM solver for viscoelastic fluids with application to problems with free surface A Multigrid LCR-FEM solver for viscoelastic fluids with application to problems with free surface Damanik, H., Mierka, O., Ouazzi, A., Turek, S. (Lausanne, August 2013) Page 1 Motivation Polymer melts:

More information

Robust Monolithic - Multigrid FEM Solver for Three Fields Formulation Rising from non-newtonian Flow Problems

Robust Monolithic - Multigrid FEM Solver for Three Fields Formulation Rising from non-newtonian Flow Problems Robust Monolithic - Multigrid FEM Solver for Three Fields Formulation Rising from non-newtonian Flow Problems M. Aaqib Afaq Institute for Applied Mathematics and Numerics (LSIII) TU Dortmund 13 July 2017

More information

A note on accurate and efficient higher order Galerkin time stepping schemes for the nonstationary Stokes equations

A note on accurate and efficient higher order Galerkin time stepping schemes for the nonstationary Stokes equations A note on accurate and efficient higher order Galerkin time stepping schemes for the nonstationary Stokes equations S. Hussain, F. Schieweck, S. Turek Abstract In this note, we extend our recent work for

More information

A Space-Time Multigrid Solver Methodology for the Optimal Control of Time-Dependent Fluid Flow

A Space-Time Multigrid Solver Methodology for the Optimal Control of Time-Dependent Fluid Flow A Space-Time Multigrid Solver Methodology for the Optimal Control of Time-Dependent Fluid Flow Michael Köster, Michael Hinze, Stefan Turek Michael Köster Institute for Applied Mathematics TU Dortmund Trier,

More information

Monolithic Newton-multigrid solution techniques for incompressible nonlinear flow models

Monolithic Newton-multigrid solution techniques for incompressible nonlinear flow models Monolithic Newton-multigrid solution techniques for incompressible nonlinear flow models H. Damanik a,, J. Hron b, A. Ouazzi a, S. Turek a a Institut für Angewante Mathematik, TU Dortmund, Germany b Institute

More information

A monolithic FEM solver for fluid structure

A monolithic FEM solver for fluid structure A monolithic FEM solver for fluid structure interaction p. 1/1 A monolithic FEM solver for fluid structure interaction Stefan Turek, Jaroslav Hron jaroslav.hron@mathematik.uni-dortmund.de Department of

More information

FINITE ELEMENT APPROXIMATION OF STOKES-LIKE SYSTEMS WITH IMPLICIT CONSTITUTIVE RELATION

FINITE ELEMENT APPROXIMATION OF STOKES-LIKE SYSTEMS WITH IMPLICIT CONSTITUTIVE RELATION Proceedings of ALGORITMY pp. 9 3 FINITE ELEMENT APPROXIMATION OF STOKES-LIKE SYSTEMS WITH IMPLICIT CONSTITUTIVE RELATION JAN STEBEL Abstract. The paper deals with the numerical simulations of steady flows

More information

FEM-Level Set Techniques for Multiphase Flow --- Some recent results

FEM-Level Set Techniques for Multiphase Flow --- Some recent results FEM-Level Set Techniques for Multiphase Flow --- Some recent results ENUMATH09, Uppsala Stefan Turek, Otto Mierka, Dmitri Kuzmin, Shuren Hysing Institut für Angewandte Mathematik, TU Dortmund http://www.mathematik.tu-dortmund.de/ls3

More information

An Introduction to the Discontinuous Galerkin Method

An Introduction to the Discontinuous Galerkin Method An Introduction to the Discontinuous Galerkin Method Krzysztof J. Fidkowski Aerospace Computational Design Lab Massachusetts Institute of Technology March 16, 2005 Computational Prototyping Group Seminar

More information

An Efficient Low Memory Implicit DG Algorithm for Time Dependent Problems

An Efficient Low Memory Implicit DG Algorithm for Time Dependent Problems An Efficient Low Memory Implicit DG Algorithm for Time Dependent Problems P.-O. Persson and J. Peraire Massachusetts Institute of Technology 2006 AIAA Aerospace Sciences Meeting, Reno, Nevada January 9,

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

PALADINS: Scalable Time-Adaptive Algebraic Splitting and Preconditioners for the Navier-Stokes Equations

PALADINS: Scalable Time-Adaptive Algebraic Splitting and Preconditioners for the Navier-Stokes Equations 2013 SIAM Conference On Computational Science and Engineering Boston, 27 th February 2013 PALADINS: Scalable Time-Adaptive Algebraic Splitting and Preconditioners for the Navier-Stokes Equations U. Villa,

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

On a class of numerical schemes. for compressible flows

On a class of numerical schemes. for compressible flows On a class of numerical schemes for compressible flows R. Herbin, with T. Gallouët, J.-C. Latché L. Gastaldo, D. Grapsas, W. Kheriji, T.T. N Guyen, N. Therme, C. Zaza. Aix-Marseille Université I.R.S.N.

More information

Adaptive C1 Macroelements for Fourth Order and Divergence-Free Problems

Adaptive C1 Macroelements for Fourth Order and Divergence-Free Problems Adaptive C1 Macroelements for Fourth Order and Divergence-Free Problems Roy Stogner Computational Fluid Dynamics Lab Institute for Computational Engineering and Sciences University of Texas at Austin March

More information

Vector and scalar penalty-projection methods

Vector and scalar penalty-projection methods Numerical Flow Models for Controlled Fusion - April 2007 Vector and scalar penalty-projection methods for incompressible and variable density flows Philippe Angot Université de Provence, LATP - Marseille

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

Une méthode de pénalisation par face pour l approximation des équations de Navier-Stokes à nombre de Reynolds élevé

Une méthode de pénalisation par face pour l approximation des équations de Navier-Stokes à nombre de Reynolds élevé Une méthode de pénalisation par face pour l approximation des équations de Navier-Stokes à nombre de Reynolds élevé CMCS/IACS Ecole Polytechnique Federale de Lausanne Erik.Burman@epfl.ch Méthodes Numériques

More information

Space-time XFEM for two-phase mass transport

Space-time XFEM for two-phase mass transport Space-time XFEM for two-phase mass transport Space-time XFEM for two-phase mass transport Christoph Lehrenfeld joint work with Arnold Reusken EFEF, Prague, June 5-6th 2015 Christoph Lehrenfeld EFEF, Prague,

More information

Space-time Discontinuous Galerkin Methods for Compressible Flows

Space-time Discontinuous Galerkin Methods for Compressible Flows Space-time Discontinuous Galerkin Methods for Compressible Flows Jaap van der Vegt Numerical Analysis and Computational Mechanics Group Department of Applied Mathematics University of Twente Joint Work

More information

Algebraic flux correction and its application to convection-dominated flow. Matthias Möller

Algebraic flux correction and its application to convection-dominated flow. Matthias Möller Algebraic flux correction and its application to convection-dominated flow Matthias Möller matthias.moeller@math.uni-dortmund.de Institute of Applied Mathematics (LS III) University of Dortmund, Germany

More information

Efficient simulation techniques for incompressible two-phase flow

Efficient simulation techniques for incompressible two-phase flow 3D-Surface Engineering für Werkzeugsysteme der Blechformteilefertigung - Erzeugung, Modellierung, Bearbeitung - Efficient simulation techniques for incompressible two-phase flow O. Mierka, O. Ouazzi, T.

More information

FEniCS Course. Lecture 6: Incompressible Navier Stokes. Contributors Anders Logg André Massing

FEniCS Course. Lecture 6: Incompressible Navier Stokes. Contributors Anders Logg André Massing FEniCS Course Lecture 6: Incompressible Navier Stokes Contributors Anders Logg André Massing 1 / 11 The incompressible Navier Stokes equations u + u u ν u + p = f in Ω (0, T ] u = 0 in Ω (0, T ] u = g

More information

On special CFD techniques for the efficient solution of dynamic porous media problems

On special CFD techniques for the efficient solution of dynamic porous media problems Computational Mechanics manuscript No. (will be inserted by the editor) On special CFD techniques for the efficient solution of dynamic porous media problems S. Turek A. Obaid B. Markert Received: date

More information

Fast Iterative Solution of Saddle Point Problems

Fast Iterative Solution of Saddle Point Problems Michele Benzi Department of Mathematics and Computer Science Emory University Atlanta, GA Acknowledgments NSF (Computational Mathematics) Maxim Olshanskii (Mech-Math, Moscow State U.) Zhen Wang (PhD student,

More information

WELL POSEDNESS OF PROBLEMS I

WELL POSEDNESS OF PROBLEMS I Finite Element Method 85 WELL POSEDNESS OF PROBLEMS I Consider the following generic problem Lu = f, where L : X Y, u X, f Y and X, Y are two Banach spaces We say that the above problem is well-posed (according

More information

Past, present and space-time

Past, present and space-time Past, present and space-time Arnold Reusken Chair for Numerical Mathematics RWTH Aachen Utrecht, 12.11.2015 Reusken (RWTH Aachen) Past, present and space-time Utrecht, 12.11.2015 1 / 20 Outline Past. Past

More information

A Robust Preconditioned Iterative Method for the Navier-Stokes Equations with High Reynolds Numbers

A Robust Preconditioned Iterative Method for the Navier-Stokes Equations with High Reynolds Numbers Applied and Computational Mathematics 2017; 6(4): 202-207 http://www.sciencepublishinggroup.com/j/acm doi: 10.11648/j.acm.20170604.18 ISSN: 2328-5605 (Print); ISSN: 2328-5613 (Online) A Robust Preconditioned

More information

Implicit Solution of Viscous Aerodynamic Flows using the Discontinuous Galerkin Method

Implicit Solution of Viscous Aerodynamic Flows using the Discontinuous Galerkin Method Implicit Solution of Viscous Aerodynamic Flows using the Discontinuous Galerkin Method Per-Olof Persson and Jaime Peraire Massachusetts Institute of Technology 7th World Congress on Computational Mechanics

More information

Fast solvers for steady incompressible flow

Fast solvers for steady incompressible flow ICFD 25 p.1/21 Fast solvers for steady incompressible flow Andy Wathen Oxford University wathen@comlab.ox.ac.uk http://web.comlab.ox.ac.uk/~wathen/ Joint work with: Howard Elman (University of Maryland,

More information

ANALYSIS OF AUGMENTED LAGRANGIAN-BASED PRECONDITIONERS FOR THE STEADY INCOMPRESSIBLE NAVIER-STOKES EQUATIONS

ANALYSIS OF AUGMENTED LAGRANGIAN-BASED PRECONDITIONERS FOR THE STEADY INCOMPRESSIBLE NAVIER-STOKES EQUATIONS ANALYSIS OF AUGMENTED LAGRANGIAN-BASED PRECONDITIONERS FOR THE STEADY INCOMPRESSIBLE NAVIER-STOKES EQUATIONS MICHELE BENZI AND ZHEN WANG Abstract. We analyze a class of modified augmented Lagrangian-based

More information

Efficient Augmented Lagrangian-type Preconditioning for the Oseen Problem using Grad-Div Stabilization

Efficient Augmented Lagrangian-type Preconditioning for the Oseen Problem using Grad-Div Stabilization Efficient Augmented Lagrangian-type Preconditioning for the Oseen Problem using Grad-Div Stabilization Timo Heister, Texas A&M University 2013-02-28 SIAM CSE 2 Setting Stationary, incompressible flow problems

More information

HIGHER-ORDER LINEARLY IMPLICIT ONE-STEP METHODS FOR THREE-DIMENSIONAL INCOMPRESSIBLE NAVIER-STOKES EQUATIONS

HIGHER-ORDER LINEARLY IMPLICIT ONE-STEP METHODS FOR THREE-DIMENSIONAL INCOMPRESSIBLE NAVIER-STOKES EQUATIONS STUDIA UNIV. BABEŞ BOLYAI, MATHEMATICA, Volume LIII, Number 1, March 2008 HIGHER-ORDER LINEARLY IMPLICIT ONE-STEP METHODS FOR THREE-DIMENSIONAL INCOMPRESSIBLE NAVIER-STOKES EQUATIONS IOAN TELEAGA AND JENS

More information

An Overview of Fluid Animation. Christopher Batty March 11, 2014

An Overview of Fluid Animation. Christopher Batty March 11, 2014 An Overview of Fluid Animation Christopher Batty March 11, 2014 What distinguishes fluids? What distinguishes fluids? No preferred shape. Always flows when force is applied. Deforms to fit its container.

More information

Efficient BDF time discretization of the Navier Stokes equations with VMS LES modeling in a High Performance Computing framework

Efficient BDF time discretization of the Navier Stokes equations with VMS LES modeling in a High Performance Computing framework Introduction VS LES/BDF Implementation Results Conclusions Swiss Numerical Analysis Day 2015, Geneva, Switzerland, 17 April 2015. Efficient BDF time discretization of the Navier Stokes equations with VS

More information

Math background. Physics. Simulation. Related phenomena. Frontiers in graphics. Rigid fluids

Math background. Physics. Simulation. Related phenomena. Frontiers in graphics. Rigid fluids Fluid dynamics Math background Physics Simulation Related phenomena Frontiers in graphics Rigid fluids Fields Domain Ω R2 Scalar field f :Ω R Vector field f : Ω R2 Types of derivatives Derivatives measure

More information

Time-adaptive methods for the incompressible Navier-Stokes equations

Time-adaptive methods for the incompressible Navier-Stokes equations Time-adaptive methods for the incompressible Navier-Stokes equations Joachim Rang, Thorsten Grahs, Justin Wiegmann, 29.09.2016 Contents Introduction Diagonally implicit Runge Kutta methods Results with

More information

Isogeometric Analysis of the Navier Stokes Cahn Hilliard equations with application to incompressible two-phase flows

Isogeometric Analysis of the Navier Stokes Cahn Hilliard equations with application to incompressible two-phase flows Isogeometric Analysis of the Navier Stokes Cahn Hilliard equations with application to incompressible two-phase flows Babak S. Hosseini 1, Stefan Turek 1, Matthias Möller 2 1 TU Dortmund University, Institute

More information

Chapter 2. General concepts. 2.1 The Navier-Stokes equations

Chapter 2. General concepts. 2.1 The Navier-Stokes equations Chapter 2 General concepts 2.1 The Navier-Stokes equations The Navier-Stokes equations model the fluid mechanics. This set of differential equations describes the motion of a fluid. In the present work

More information

DELFT UNIVERSITY OF TECHNOLOGY

DELFT UNIVERSITY OF TECHNOLOGY DELFT UNIVERSITY OF TECHNOLOGY REPORT 13-07 On preconditioning incompressible non-newtonian flow problems Xin He, Maya Neytcheva and Cornelis Vuik ISSN 1389-6520 Reports of the Delft Institute of Applied

More information

Numerische Simulation zur Herstellung monodisperser Tropfen in pneumatischen Ziehdüsen

Numerische Simulation zur Herstellung monodisperser Tropfen in pneumatischen Ziehdüsen Numerische Simulation zur Herstellung monodisperser Tropfen in pneumatischen Ziehdüsen DFG SPP 1423 Prozess-Spray Prof. Dr. Stefan Turek, Dr. Institut für Angewandte Mathematik, LS III Technische Universität

More information

DG Methods for Aerodynamic Flows: Higher Order, Error Estimation and Adaptive Mesh Refinement

DG Methods for Aerodynamic Flows: Higher Order, Error Estimation and Adaptive Mesh Refinement HONOM 2011 in Trento DG Methods for Aerodynamic Flows: Higher Order, Error Estimation and Adaptive Mesh Refinement Institute of Aerodynamics and Flow Technology DLR Braunschweig 11. April 2011 1 / 35 Research

More information

Algebraic Multigrid Methods for the Oseen Problem

Algebraic Multigrid Methods for the Oseen Problem Algebraic Multigrid Methods for the Oseen Problem Markus Wabro Joint work with: Walter Zulehner, Linz www.numa.uni-linz.ac.at This work has been supported by the Austrian Science Foundation Fonds zur Förderung

More information

Deformation of bovine eye fluid structure interaction between viscoelastic vitreous, non-linear elastic lens and sclera

Deformation of bovine eye fluid structure interaction between viscoelastic vitreous, non-linear elastic lens and sclera Karel October Tůma 24, Simulation 2018 of a bovine eye 1/19 Deformation of bovine eye fluid structure interaction between viscoelastic vitreous, non-linear elastic lens and sclera Karel Tůma 1 joint work

More information

Numerical methods for the Navier- Stokes equations

Numerical methods for the Navier- Stokes equations Numerical methods for the Navier- Stokes equations Hans Petter Langtangen 1,2 1 Center for Biomedical Computing, Simula Research Laboratory 2 Department of Informatics, University of Oslo Dec 6, 2012 Note:

More information

Fluid Animation. Christopher Batty November 17, 2011

Fluid Animation. Christopher Batty November 17, 2011 Fluid Animation Christopher Batty November 17, 2011 What distinguishes fluids? What distinguishes fluids? No preferred shape Always flows when force is applied Deforms to fit its container Internal forces

More information

Block-Structured Adaptive Mesh Refinement

Block-Structured Adaptive Mesh Refinement Block-Structured Adaptive Mesh Refinement Lecture 2 Incompressible Navier-Stokes Equations Fractional Step Scheme 1-D AMR for classical PDE s hyperbolic elliptic parabolic Accuracy considerations Bell

More information

A Numerical Investigation of Velocity-Pressure Reduced Order Models for Incompressible Flows

A Numerical Investigation of Velocity-Pressure Reduced Order Models for Incompressible Flows A Numerical Investigation of Velocity-Pressure educed Order Models for Incompressible Flows Alfonso Caiazzo a, Traian Iliescu b,1, Volker John a,c,, Swetlana Schyschlowa a a Weierstrass Institute for Applied

More information

Mathematical Theory of Non-Newtonian Fluid

Mathematical Theory of Non-Newtonian Fluid Mathematical Theory of Non-Newtonian Fluid 1. Derivation of the Incompressible Fluid Dynamics 2. Existence of Non-Newtonian Flow and its Dynamics 3. Existence in the Domain with Boundary Hyeong Ohk Bae

More information

Game Physics. Game and Media Technology Master Program - Utrecht University. Dr. Nicolas Pronost

Game Physics. Game and Media Technology Master Program - Utrecht University. Dr. Nicolas Pronost Game and Media Technology Master Program - Utrecht University Dr. Nicolas Pronost Soft body physics Soft bodies In reality, objects are not purely rigid for some it is a good approximation but if you hit

More information

A High-Order Discontinuous Galerkin Method for the Unsteady Incompressible Navier-Stokes Equations

A High-Order Discontinuous Galerkin Method for the Unsteady Incompressible Navier-Stokes Equations A High-Order Discontinuous Galerkin Method for the Unsteady Incompressible Navier-Stokes Equations Khosro Shahbazi 1, Paul F. Fischer 2 and C. Ross Ethier 1 1 University of Toronto and 2 Argonne National

More information

7.4 The Saddle Point Stokes Problem

7.4 The Saddle Point Stokes Problem 346 CHAPTER 7. APPLIED FOURIER ANALYSIS 7.4 The Saddle Point Stokes Problem So far the matrix C has been diagonal no trouble to invert. This section jumps to a fluid flow problem that is still linear (simpler

More information

Weierstrass Institute for Applied Analysis and Stochastics, Mohrenstr. 39, Berlin, Germany,

Weierstrass Institute for Applied Analysis and Stochastics, Mohrenstr. 39, Berlin, Germany, Volker John On the numerical simulation of population balance systems Weierstrass Institute for Applied Analysis and Stochastics, Mohrenstr. 39, 10117 Berlin, Germany, Free University of Berlin, Department

More information

Indefinite and physics-based preconditioning

Indefinite and physics-based preconditioning Indefinite and physics-based preconditioning Jed Brown VAW, ETH Zürich 2009-01-29 Newton iteration Standard form of a nonlinear system F (u) 0 Iteration Solve: Update: J(ũ)u F (ũ) ũ + ũ + u Example (p-bratu)

More information

Research Article Evaluation of the Capability of the Multigrid Method in Speeding Up the Convergence of Iterative Methods

Research Article Evaluation of the Capability of the Multigrid Method in Speeding Up the Convergence of Iterative Methods International Scholarly Research Network ISRN Computational Mathematics Volume 212, Article ID 172687, 5 pages doi:1.542/212/172687 Research Article Evaluation of the Capability of the Multigrid Method

More information

PDE Solvers for Fluid Flow

PDE Solvers for Fluid Flow PDE Solvers for Fluid Flow issues and algorithms for the Streaming Supercomputer Eran Guendelman February 5, 2002 Topics Equations for incompressible fluid flow 3 model PDEs: Hyperbolic, Elliptic, Parabolic

More information

Multilevel Preconditioning of Graph-Laplacians: Polynomial Approximation of the Pivot Blocks Inverses

Multilevel Preconditioning of Graph-Laplacians: Polynomial Approximation of the Pivot Blocks Inverses Multilevel Preconditioning of Graph-Laplacians: Polynomial Approximation of the Pivot Blocks Inverses P. Boyanova 1, I. Georgiev 34, S. Margenov, L. Zikatanov 5 1 Uppsala University, Box 337, 751 05 Uppsala,

More information

Numerical Heat and Mass Transfer

Numerical Heat and Mass Transfer Master Degree in Mechanical Engineering Numerical Heat and Mass Transfer 15-Convective Heat Transfer Fausto Arpino f.arpino@unicas.it Introduction In conduction problems the convection entered the analysis

More information

FAST SOLVERS AND EFFICIENT NUMERICAL CFD TECHNIQUES FOR DYNAMIC POROUS MEDIA PROBLEMS

FAST SOLVERS AND EFFICIENT NUMERICAL CFD TECHNIQUES FOR DYNAMIC POROUS MEDIA PROBLEMS V International Conference on Computational Methods for Coupled Problems in Science and Engineering COUPLED PROBLEMS 23 S. Idelsohn, M. Papadrakakis and B. Schrefler (Eds) FAST SOLVERS AND EFFICIENT NUMERICAL

More information

Control of Interface Evolution in Multi-Phase Fluid Flows

Control of Interface Evolution in Multi-Phase Fluid Flows Control of Interface Evolution in Multi-Phase Fluid Flows Markus Klein Department of Mathematics University of Tübingen Workshop on Numerical Methods for Optimal Control and Inverse Problems Garching,

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

Courant Institute of Mathematical Sciences, New York University, New York, NY 10012,

Courant Institute of Mathematical Sciences, New York University, New York, NY 10012, EFFICIENT VARIABLE-COEFFICIENT FINITE-VOLUME STOKES SOLVERS MINGCHAO CAI, ANDY NONAKA, JOHN B. BELL, BOYCE E. GRIFFITH, AND ALEKSANDAR DONEV Abstract. We investigate several robust preconditioners for

More information

c 2011 Society for Industrial and Applied Mathematics

c 2011 Society for Industrial and Applied Mathematics SIAM J. SCI. COMPUT. Vol. 33, No. 5, pp. 2761 2784 c 2011 Society for Industrial and Applied Mathematics ANALYSIS OF AUGMENTED LAGRANGIAN-BASED PRECONDITIONERS FOR THE STEADY INCOMPRESSIBLE NAVIER STOKES

More information

Finite Elements for Magnetohydrodynamics and its Optimal Control

Finite Elements for Magnetohydrodynamics and its Optimal Control Finite Elements for Magnetohydrodynamics and its Karl Kunisch Marco Discacciati (RICAM) FEM Symposium Chemnitz September 25 27, 2006 Overview 1 2 3 What is Magnetohydrodynamics? Magnetohydrodynamics (MHD)

More information

Divergence Formulation of Source Term

Divergence Formulation of Source Term Preprint accepted for publication in Journal of Computational Physics, 2012 http://dx.doi.org/10.1016/j.jcp.2012.05.032 Divergence Formulation of Source Term Hiroaki Nishikawa National Institute of Aerospace,

More information

A Mixed Finite Element Formulation for Solving Phase Change Problems with Convection

A Mixed Finite Element Formulation for Solving Phase Change Problems with Convection A Mixed Finite Element Formulation for Solving Phase Change Problems with Convection Youssef Belhamadia 1, Abdoulaye S. Kane 2, and André Fortin 3 1 University of Alberta, Campus Saint-Jean and Department

More information

Is My CFD Mesh Adequate? A Quantitative Answer

Is My CFD Mesh Adequate? A Quantitative Answer Is My CFD Mesh Adequate? A Quantitative Answer Krzysztof J. Fidkowski Gas Dynamics Research Colloqium Aerospace Engineering Department University of Michigan January 26, 2011 K.J. Fidkowski (UM) GDRC 2011

More information

Variable Exponents Spaces and Their Applications to Fluid Dynamics

Variable Exponents Spaces and Their Applications to Fluid Dynamics Variable Exponents Spaces and Their Applications to Fluid Dynamics Martin Rapp TU Darmstadt November 7, 213 Martin Rapp (TU Darmstadt) Variable Exponent Spaces November 7, 213 1 / 14 Overview 1 Variable

More information

Multigrid solvers for equations arising in implicit MHD simulations

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

More information

Solving PDEs with freefem++

Solving PDEs with freefem++ Solving PDEs with freefem++ Tutorials at Basque Center BCA Olivier Pironneau 1 with Frederic Hecht, LJLL-University of Paris VI 1 March 13, 2011 Do not forget That everything about freefem++ is at www.freefem.org

More information

Relative entropies, suitable weak solutions, and weak-strong uniqueness for the compressible Navier-Stokes system

Relative entropies, suitable weak solutions, and weak-strong uniqueness for the compressible Navier-Stokes system Relative entropies, suitable weak solutions, and weak-strong uniqueness for the compressible Navier-Stokes system Institute of Mathematics, Academy of Sciences of the Czech Republic, Prague joint work

More information

Some remarks on grad-div stabilization of incompressible flow simulations

Some remarks on grad-div stabilization of incompressible flow simulations Some remarks on grad-div stabilization of incompressible flow simulations Gert Lube Institute for Numerical and Applied Mathematics Georg-August-University Göttingen M. Stynes Workshop Numerical Analysis

More information

Multigrid Methods for Saddle Point Problems

Multigrid Methods for Saddle Point Problems Multigrid Methods for Saddle Point Problems Susanne C. Brenner Department of Mathematics and Center for Computation & Technology Louisiana State University Advances in Mathematics of Finite Elements (In

More information

Proposal for numerical benchmarking of fluid-structure interaction between an elastic object and laminar incompressible flow

Proposal for numerical benchmarking of fluid-structure interaction between an elastic object and laminar incompressible flow Proposal for numerical benchmarking of fluid-structure interaction between an elastic object and laminar incompressible flow Stefan Turek and Jaroslav Hron Institute for Applied Mathematics and Numerics,

More information

Soft Bodies. Good approximation for hard ones. approximation breaks when objects break, or deform. Generalization: soft (deformable) bodies

Soft Bodies. Good approximation for hard ones. approximation breaks when objects break, or deform. Generalization: soft (deformable) bodies Soft-Body Physics Soft Bodies Realistic objects are not purely rigid. Good approximation for hard ones. approximation breaks when objects break, or deform. Generalization: soft (deformable) bodies Deformed

More information

FEniCS Course. Lecture 0: Introduction to FEM. Contributors Anders Logg, Kent-Andre Mardal

FEniCS Course. Lecture 0: Introduction to FEM. Contributors Anders Logg, Kent-Andre Mardal FEniCS Course Lecture 0: Introduction to FEM Contributors Anders Logg, Kent-Andre Mardal 1 / 46 What is FEM? The finite element method is a framework and a recipe for discretization of mathematical problems

More information

TAU Solver Improvement [Implicit methods]

TAU Solver Improvement [Implicit methods] TAU Solver Improvement [Implicit methods] Richard Dwight Megadesign 23-24 May 2007 Folie 1 > Vortrag > Autor Outline Motivation (convergence acceleration to steady state, fast unsteady) Implicit methods

More information

Newton s Method and Efficient, Robust Variants

Newton s Method and Efficient, Robust Variants Newton s Method and Efficient, Robust Variants Philipp Birken University of Kassel (SFB/TRR 30) Soon: University of Lund October 7th 2013 Efficient solution of large systems of non-linear PDEs in science

More information

ALGEBRAIC FLUX CORRECTION FOR FINITE ELEMENT DISCRETIZATIONS OF COUPLED SYSTEMS

ALGEBRAIC FLUX CORRECTION FOR FINITE ELEMENT DISCRETIZATIONS OF COUPLED SYSTEMS Int. Conf. on Computational Methods for Coupled Problems in Science and Engineering COUPLED PROBLEMS 2007 M. Papadrakakis, E. Oñate and B. Schrefler (Eds) c CIMNE, Barcelona, 2007 ALGEBRAIC FLUX CORRECTION

More information

Algebraic Flux Correction III

Algebraic Flux Correction III Algebraic Flux Correction III Incompressible Flow Problems Stefan Turek and Dmitri Kuzmin Abstract This chapter illustrates the use of algebraic flux correction in the context of finite element methods

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

A high-order discontinuous Galerkin solver for 3D aerodynamic turbulent flows

A high-order discontinuous Galerkin solver for 3D aerodynamic turbulent flows A high-order discontinuous Galerkin solver for 3D aerodynamic turbulent flows F. Bassi, A. Crivellini, D. A. Di Pietro, S. Rebay Dipartimento di Ingegneria Industriale, Università di Bergamo CERMICS-ENPC

More information

Tectonic evolution at mid-ocean ridges: geodynamics and numerical modeling. Second HPC-GA Workshop

Tectonic evolution at mid-ocean ridges: geodynamics and numerical modeling. Second HPC-GA Workshop .. Tectonic evolution at mid-ocean ridges: geodynamics and numerical modeling. Second HPC-GA Workshop Marco Cuffaro, Edie Miglio, Mattia Penati, Marco Viganò Politecnico di Milano - MOX, Dipartimento di

More information

Robert Shuttleworth Doctor of Philosophy, 2007

Robert Shuttleworth Doctor of Philosophy, 2007 ABSTRACT Title of dissertation: BLOCK PRECONDITIONERS FOR THE NAVIER-STOKES EQUATIONS Robert Shuttleworth Doctor of Philosophy, 2007 Dissertation directed by: Professor Howard Elman Computer Science Department

More information

AMG for a Peta-scale Navier Stokes Code

AMG for a Peta-scale Navier Stokes Code AMG for a Peta-scale Navier Stokes Code James Lottes Argonne National Laboratory October 18, 2007 The Challenge Develop an AMG iterative method to solve Poisson 2 u = f discretized on highly irregular

More information

Computational Fluid Dynamics-1(CFDI)

Computational Fluid Dynamics-1(CFDI) بسمه تعالی درس دینامیک سیالات محاسباتی 1 دوره کارشناسی ارشد دانشکده مهندسی مکانیک دانشگاه صنعتی خواجه نصیر الدین طوسی Computational Fluid Dynamics-1(CFDI) Course outlines: Part I A brief introduction to

More information

1. Introduction. Consider the Navier Stokes equations ηu t ν 2 u + (u grad) u + grad p = f div u = 0 (1.1)

1. Introduction. Consider the Navier Stokes equations ηu t ν 2 u + (u grad) u + grad p = f div u = 0 (1.1) University of Maryland Department of Computer Science TR-C4930 University of Maryland Institute for Advanced Computer Studies TR-009-0 BOUNDARY CONDITIONS IN APPROXIMATE COMMUTATOR PRECONDITIONERS FOR

More information

Numerical simulation of laminar incompressible fluid-structure interaction for elastic material with point constraints

Numerical simulation of laminar incompressible fluid-structure interaction for elastic material with point constraints Numerical simulation of laminar incompressible fluid-structure interaction for elastic material with point constraints M. Razzaq 1, J. Hron 2 and S. Turek 3 1 Institute of Applied Mathematics, TU Dortmund,

More information

Calculation of Sound Fields in Flowing Media Using CAPA and Diffpack

Calculation of Sound Fields in Flowing Media Using CAPA and Diffpack Calculation of Sound Fields in Flowing Media Using CAPA and Diffpack H. Landes 1, M. Kaltenbacher 2, W. Rathmann 3, F. Vogel 3 1 WisSoft, 2 Univ. Erlangen 3 inutech GmbH Outline Introduction Sound in Flowing

More information

The incompressible Navier-Stokes equations in vacuum

The incompressible Navier-Stokes equations in vacuum The incompressible, Université Paris-Est Créteil Piotr Bogus law Mucha, Warsaw University Journées Jeunes EDPistes 218, Institut Elie Cartan, Université de Lorraine March 23th, 218 Incompressible Navier-Stokes

More information

Scientific Computing I

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

More information

Chapter 2: Fluid Dynamics Review

Chapter 2: Fluid Dynamics Review 7 Chapter 2: Fluid Dynamics Review This chapter serves as a short review of basic fluid mechanics. We derive the relevant transport equations (or conservation equations), state Newton s viscosity law leading

More information

A Domain Decomposition Method for Quasilinear Elliptic PDEs Using Mortar Finite Elements

A Domain Decomposition Method for Quasilinear Elliptic PDEs Using Mortar Finite Elements W I S S E N T E C H N I K L E I D E N S C H A F T A Domain Decomposition Method for Quasilinear Elliptic PDEs Using Mortar Finite Elements Matthias Gsell and Olaf Steinbach Institute of Computational Mathematics

More information

Minimal stabilization techniques for incompressible flows

Minimal stabilization techniques for incompressible flows Minimal stabilization tecniques for incompressible flows G. Lube 1, L. Röe 1 and T. Knopp 2 1 Numerical and Applied Matematics Georg-August-University of Göttingen D-37083 Göttingen, Germany 2 German Aerospace

More information

Transport equation cavitation models in an unstructured flow solver. Kilian Claramunt, Charles Hirsch

Transport equation cavitation models in an unstructured flow solver. Kilian Claramunt, Charles Hirsch Transport equation cavitation models in an unstructured flow solver Kilian Claramunt, Charles Hirsch SHF Conference on hydraulic machines and cavitation / air in water pipes June 5-6, 2013, Grenoble, France

More information