Solving the shallow-water equations by a pseudo-spectral method

Size: px
Start display at page:

Download "Solving the shallow-water equations by a pseudo-spectral method"

Transcription

1 Solving the shallow-water equations by a pseudo-spectral method Simon Chabot June 9th, 2015 Abstract In this short tutorial, you will use python to solve a non-linear system of equations using a pseudo-spectral method. The aim of this tutorial is that you use different tools provided by python libraries and get use to them. 1 Introduction to the set of equations The shallow water equations are a set of hyperbolic partial differential equations that describes the flow below a free surface, typically a water-wave, where the wave-length is much bigger than the water height. These equations are obtained from the Euler equations, that describes a ideal fluid 1. Let s consider an ideal and incompressible fluid. The fluid is bounded by a free surface and the seabed. We use a Cartesian coordinate system, such that the free surface y = 0 corresponds to the still water level. The horizontal independent variables are denoted by x = (x 1, x 2 ) and the upward vertical one by y. The free surface is given by y = η (x, t), and the bottom is defined by y = d (x, t). Finally, we denote by u the horizontal component of the fluid s velocity and by v the vertical one. These definitions are shown by the figure 1. Using these definitions, and taking the fluid density ρ = 1, the Euler s equations read : u + y v = 0 t u + (u ) u + (v y ) u = P (1) t v + (u ) v + (v y ) v = y P g 1 i.e. non-viscous 1 CC-by

2 Figure 1: domain definition where = ( x1, x2 ), and with the following boundary conditions 2 : v s = t η + u s η at y = η (x, t) (2) v b = t d + u b η at y = d (x, t) (3) These boundary conditions mean that the free surface and the seabed are impermeable. That is to say that material particles on the free surface (seabed) remain on the free surface (seabed). The difficulty in solving this problem is that you do not known where the free surface is. You have to solve a system, where the boundary is one of the unknown of the problem. You lake information 3. To close the problem, we can assume that the wave length is much bigger than the water height ; this is typically the case for tsunamis, roll-waves or flows in a canal. This implies that the movement of the flow is mainly horizontal, and therefore that you can average the equations (1) over the depth, from d to η to obtain two equations ; one for the water height h = η + d and one for the averaged horizontal velocity field ū. Where : ū (x, t) = 1 η(x,t) u (x, y, t) dy (4) η + d d(x,t) 2 ϕ s (x, t) ϕ (x, y = η, t) and ϕ b (x, t) ϕ (x, y = d, t) 3 five unknowns (the 3 components of the velocity, the pressure P, and the free surface η), and four equations. 2 CC-by

3 Then, neglecting the vertical component of the velocity v, you obtain the shallow water equations : t h + (hū) = 0 t ū + ( 1 + g (h d) ) (5) = 0 2ū2 Remark 1.1 The form (5) supposes that the flow is irrotational, i.e. ū = 0. If this assumption is false, the last equation becomes : ( t (hū) + hū ū + 1 ) 2 gh2 I = hg d 2 Three words on the pseudo-spectral method Let s take a generic PDE : t y + x f(y) = 0 y (x, t = 0) = y 0 (x) One can apply a spacial Fourier transform on this PDE. Then, in the Fourier space, it reads : t ŷ = ikf f (y)} (7) ŷ (k, t = 0) = ŷ 0 (k) where ˆϕ F ϕ} denotes the spatial Fourier transform of a quantity ϕ. Remark 2.1 We keep the notation F } when the treated term is non-linear and going back to the real space is needed for its computation. This method uses Fourier space to compute spatial derivative which become a simple product. The real space is used to compute the non-linear term. They cannot be computed in the Fourier space, because it would imply convolution operations which are to much expensive. Because the equation (7) tells us how varies ŷ in the time, ŷ can be numerically approximated by a Runge-Kutta method, for instance, at any time t. The solution in the real space is then recovered by applying the inverse Fourier transform F 1 }. 3 The python tasks Your task, should you choose to accept it, involves the completion of a python code that solves the shallow-water equations, with a moving seabed, using the pseudospectral method. You can start by downloading the code at this address : http: //huit.re/ljad-python-sw. You will find two files : (6) 3 CC-by

4 main.py : containing the code you will have to complete. conditions.py : containing the functions giving the initial condition and the seabed. The goal is to approximate the solution of the shallow-water equations, in 1D, by a spectral method : t h + x (hū) = 0 t ū + x ( 1 2ū2 + g (h d) ) = 0 (8) Here are your tasks : 1. You can start by having a look at the conditions.py file. You can launch it to see how the initial conditions are and how the seabed will evolve in time. You have nothing to change in this file for the moment. 2. Open the main.py. Basically, each time you see #XXX complete me at the end of a line, you have something to do. The first is at line 59. x = # XXX complete me You have to discretize the real space. The real space is periodic and must be zero-centered, its size is given by the variable length and you want N points. It is highly recommended to use the dedicated function linespace(start, stop, num=none, endpoint=false, retstep=false) for this purpose. Here some example of calls of this function : 0 >>> linspace (2.0, 3.0, num =5) array ([ 2., 2.25, 2.5, 2.75, 3. ]) 2 >>> linspace (2.0, 3.0, num =5, endpoint = False ) array ([ 2., 2.2, 2.4, 2.6, 2.8]) 4 >>> linspace (2.0, 3.0, num =5, retstep = True ) ( array ([ 2., 2.25, 2.5, 2.75, 3. ]), 0.25) 3. You now have to discretize the k vector of wavenumbers. The fundamental frequency is : k = 2π (9) L where L is the length of your domain. From k, we build the different harmonics as follow : p k if 0 p < N 2 k = 0 if p = N 2 = N Nyquist (10) (p N) k if p > N 2 Write the necessary python code to do this discretization (line 64). 4 CC-by

5 4. Complete, line 66, the function that compute the n th spatial derivative of a signal in the Fourier space. 66 def diff ( sig_hat, nth =1) : r """ compute the nth derivative of sig_ hat with respect to x, in Fourier 68 space """ 70 return # XXX complete me 5. Complete, line 72, the function yhat2hq(y_hat), that from the ŷ vector, in the Fourier space, returns h, u in the real space. Where the ŷ vector is built as follow : (ĥ ) ŷ = (11) û 6. Complete, line 79, the sw_rhs(y_hat) function that gives the right-hand-side member of the equation (8), in the Fourier space (of course). def sw_rhs (t, y_hat ): 80 r """ The RHS of Saint Venant equation 82 - y_ hat : the vector of dynamic variable, in Fourier space 84 Returns : - y_ hat_ t : the value of the time derivative of y_ hat 86 """ 88 # we recover h, u from y_ hat [0] and y_ hat [1] h, u = yhat2hu ( y_hat. reshape ((2, N))) 90 bottom = get_bottom (x, t=t) 92 h_ hat_ t = # XXX complete me u_ hat_ t = # XXX complete me 94 return array ([ h_hat_t, u_hat_t ]). flatten () 7. Have a look to the documentation of the ode object (here) and complete the last XXX complete me areas. 8. Cross the fingers, run the code, admire the result. 5 CC-by

6 4 More tasks if you are fast 1. Add an anti-aliasing treatment. Nonlinear computations come with aliasing errors. A zero-padding procedure should be added to avoid this phenomena. More information in [1] 2. Adapt the code to solve an other equation. For instance the Korteweg de Vries (KdV) equation : t η + c 0 x η + αη x η + β xxx η = 0 H (12) η(x, t = 0) = cosh 2 [ κ (x ct)] 2d where α = 2 3 g, β = d2 c 0, c d 6 0 = 3H gd, κ = d and c = c 0 ( 1 + H 2d). You can find at a proposal of solution. The main.py shows a solution of the different tasks that were proposed. An implementation of the anti-aliasing treatment by zero-padding is also suggested. Finally, the file kdv.py, based on the same code, solves the KdV equation. References [1] Holmås H., Clamond D. and Langtangen H.-P A pseudospectral Fourier method for a 1D incompressible two-fluid model. Int. J. Num. Meth. Fluids. 58, [2] Brice Eichwald, PhD thesis, Intégrateur exponentiel modifié pour la simulation des vagues non linéaires. University of Nice Sophia Antipolis [3] Simon Chabot, Master thesis, Modeling and numerical simulation of nonlinear water-waves. University of Nice Sophia Antipolis 6 CC-by

Homework 4A Due November 7th IN CLASS

Homework 4A Due November 7th IN CLASS CS207, Fall 2014 Systems Development for Computational Science Cris Cecka, Ray Jones Homework 4A Due November 7th IN CLASS Previously, we ve developed a quite robust Graph class to let us use Node and

More information

Computing Nearly Singular Solutions Using Pseudo-Spectral Methods

Computing Nearly Singular Solutions Using Pseudo-Spectral Methods Computing Nearly Singular Solutions Using Pseudo-Spectral Methods Thomas Y. Hou Ruo Li January 9, 2007 Abstract In this paper, we investigate the performance of pseudo-spectral methods in computing nearly

More information

Realtime Water Simulation on GPU. Nuttapong Chentanez NVIDIA Research

Realtime Water Simulation on GPU. Nuttapong Chentanez NVIDIA Research 1 Realtime Water Simulation on GPU Nuttapong Chentanez NVIDIA Research 2 3 Overview Approaches to realtime water simulation Hybrid shallow water solver + particles Hybrid 3D tall cell water solver + particles

More information

SPH: Towards the simulation of wave-body interactions in extreme seas

SPH: Towards the simulation of wave-body interactions in extreme seas SPH: Towards the simulation of wave-body interactions in extreme seas Guillaume Oger, Mathieu Doring, Bertrand Alessandrini, and Pierre Ferrant Fluid Mechanics Laboratory (CNRS UMR6598) Ecole Centrale

More information

CS205b/CME306. Lecture 9

CS205b/CME306. Lecture 9 CS205b/CME306 Lecture 9 1 Convection Supplementary Reading: Osher and Fedkiw, Sections 3.3 and 3.5; Leveque, Sections 6.7, 8.3, 10.2, 10.4. For a reference on Newton polynomial interpolation via divided

More information

Experimental Validation of the Computation Method for Strongly Nonlinear Wave-Body Interactions

Experimental Validation of the Computation Method for Strongly Nonlinear Wave-Body Interactions Experimental Validation of the Computation Method for Strongly Nonlinear Wave-Body Interactions by Changhong HU and Masashi KASHIWAGI Research Institute for Applied Mechanics, Kyushu University Kasuga

More information

21. Efficient and fast numerical methods to compute fluid flows in the geophysical β plane

21. Efficient and fast numerical methods to compute fluid flows in the geophysical β plane 12th International Conference on Domain Decomposition Methods Editors: Tony Chan, Takashi Kako, Hideo Kawarada, Olivier Pironneau, c 2001 DDM.org 21. Efficient and fast numerical methods to compute fluid

More information

Physics 235 Chapter 6. Chapter 6 Some Methods in the Calculus of Variations

Physics 235 Chapter 6. Chapter 6 Some Methods in the Calculus of Variations Chapter 6 Some Methods in the Calculus of Variations In this Chapter we focus on an important method of solving certain problems in Classical Mechanics. In many problems we need to determine how a system

More information

Nonlinear Potential Flow Solver Development in OpenFOAM

Nonlinear Potential Flow Solver Development in OpenFOAM Nonlinear Potential Flow Solver Development in OpenFOAM A. Mehmood Plymouth University, UK April 19,2016 A. Mehmood Table of Contents 1 Motivation 2 Solution Methodology Mathematical Formulation Sequence

More information

Realistic Animation of Fluids

Realistic Animation of Fluids Realistic Animation of Fluids p. 1/2 Realistic Animation of Fluids Nick Foster and Dimitri Metaxas Realistic Animation of Fluids p. 2/2 Overview Problem Statement Previous Work Navier-Stokes Equations

More information

Mathematics for chemical engineers

Mathematics for chemical engineers Mathematics for chemical engineers Drahoslava Janovská Department of mathematics Winter semester 2013-2014 Numerical solution of ordinary differential equations Initial value problem Outline 1 Introduction

More information

Towards Real Time Simulation of Ship-Ship Interaction

Towards Real Time Simulation of Ship-Ship Interaction Downloaded from orbit.dtu.dk on: Nov 12, 2018 Towards Real Time Simulation of Ship-Ship Interaction Lindberg, Ole; Bingham, Harry B.; Engsig-Karup, Allan Peter; Madsen, Per A. Published in: International

More information

Coastal impact of a tsunami Review of numerical models

Coastal impact of a tsunami Review of numerical models Coastal impact of a tsunami Review of numerical models Richard Marcer 2 Content Physics to simulate Different approaches of modelling 2D depth average Full 3D Navier-Stokes 3D model Key point : free surface

More information

Development of the Compliant Mooring Line Model for FLOW-3D

Development of the Compliant Mooring Line Model for FLOW-3D Flow Science Report 08-15 Development of the Compliant Mooring Line Model for FLOW-3D Gengsheng Wei Flow Science, Inc. October 2015 1. Introduction Mooring systems are common in offshore structures, ship

More information

NUMERICAL SIMULATION OF THE SHALLOW WATER EQUATIONS USING A TIME-CENTERED SPLIT-IMPLICIT METHOD

NUMERICAL SIMULATION OF THE SHALLOW WATER EQUATIONS USING A TIME-CENTERED SPLIT-IMPLICIT METHOD 18th Engineering Mechanics Division Conference (EMD007) NUMERICAL SIMULATION OF THE SHALLOW WATER EQUATIONS USING A TIME-CENTERED SPLIT-IMPLICIT METHOD Abstract S. Fu University of Texas at Austin, Austin,

More information

Journal of Nonlinear Mathematical Physics, Vol. 1, No. 1 (2009) 1 12 c B. Deconinck

Journal of Nonlinear Mathematical Physics, Vol. 1, No. 1 (2009) 1 12 c B. Deconinck Article Journal of Nonlinear Mathematical Physics, Vol. 1, No. 1 (2009) 1 12 c B. Deconinck RELATING THE BOTTOM PRESSURE AND THE SURFACE ELEVATION IN THE WATER WAVE PROBLEM B. DECONINCK Department of Applied

More information

DESIGN OF OPTIMAL TWO-PASS ZERO-PHASE RECURSIVE FILTERS WITH APPLICATION TO PROCESSING OF SEISMIC DATA

DESIGN OF OPTIMAL TWO-PASS ZERO-PHASE RECURSIVE FILTERS WITH APPLICATION TO PROCESSING OF SEISMIC DATA DESIGN OF OPTIMAL TWO-PASS ZERO-PHASE RECURSIVE FILTERS WITH APPLICATION TO PROCESSING OF SEISMIC DATA Tage Røsten # and Dirk-Jan van Manen # Statoil Research Centre, Trondheim, Norway WesternGeco Oslo

More information

Generation and propagation of solitary wave over a steep sloping beach

Generation and propagation of solitary wave over a steep sloping beach Generation and propagation of solitary wave over a steep sloping beach Zouhaier Hafsia (1), Mehdi Ben Haj (2), Hedi Lamloumi (3), Khlifa Maalel (4) and Ridha Zgolli (5) (1-5) ENIT. Laboratoire d Hydraulique

More information

CGT 581 G Fluids. Overview. Some terms. Some terms

CGT 581 G Fluids. Overview. Some terms. Some terms CGT 581 G Fluids Bedřich Beneš, Ph.D. Purdue University Department of Computer Graphics Technology Overview Some terms Incompressible Navier-Stokes Boundary conditions Lagrange vs. Euler Eulerian approaches

More information

Numerical Study of Nearly Singular Solutions of the 3-D Incompressible Euler Equations

Numerical Study of Nearly Singular Solutions of the 3-D Incompressible Euler Equations Numerical Study of Nearly Singular Solutions of the 3-D Incompressible Euler Equations Thomas Y. Hou Ruo Li August 7, 2006 Abstract In this paper, we perform a careful numerical study of nearly singular

More information

Direct numerical simulation. in an annular pipe. of turbulent flow. Paolo Luchini & Maurizio Quadrio

Direct numerical simulation. in an annular pipe. of turbulent flow. Paolo Luchini & Maurizio Quadrio P.Luchini & M.Quadrio SIMAI 2000 - Ischia - 9.6.2000 Direct numerical simulation of turbulent flow in an annular pipe Paolo Luchini & Maurizio Quadrio Dipartimento di Ingegneria Aerospaziale del Politecnico

More information

Lecture 1: Finite Volume WENO Schemes Chi-Wang Shu

Lecture 1: Finite Volume WENO Schemes Chi-Wang Shu Lecture 1: Finite Volume WENO Schemes Chi-Wang Shu Division of Applied Mathematics Brown University Outline of the First Lecture General description of finite volume schemes for conservation laws The WENO

More information

Navier-Stokes & Flow Simulation

Navier-Stokes & Flow Simulation Last Time? Navier-Stokes & Flow Simulation Optional Reading for Last Time: Spring-Mass Systems Numerical Integration (Euler, Midpoint, Runge-Kutta) Modeling string, hair, & cloth HW2: Cloth & Fluid Simulation

More information

Image Filtering, Warping and Sampling

Image Filtering, Warping and Sampling Image Filtering, Warping and Sampling Connelly Barnes CS 4810 University of Virginia Acknowledgement: slides by Jason Lawrence, Misha Kazhdan, Allison Klein, Tom Funkhouser, Adam Finkelstein and David

More information

On a Future Software Platform for Demanding Multi-Scale and Multi-Physics Problems

On a Future Software Platform for Demanding Multi-Scale and Multi-Physics Problems On a Future Software Platform for Demanding Multi-Scale and Multi-Physics Problems H. P. Langtangen X. Cai Simula Research Laboratory, Oslo Department of Informatics, Univ. of Oslo SIAM-CSE07, February

More information

The Level Set Method. Lecture Notes, MIT J / 2.097J / 6.339J Numerical Methods for Partial Differential Equations

The Level Set Method. Lecture Notes, MIT J / 2.097J / 6.339J Numerical Methods for Partial Differential Equations The Level Set Method Lecture Notes, MIT 16.920J / 2.097J / 6.339J Numerical Methods for Partial Differential Equations Per-Olof Persson persson@mit.edu March 7, 2005 1 Evolving Curves and Surfaces Evolving

More information

Shallow Water Simulations on Graphics Hardware

Shallow Water Simulations on Graphics Hardware Shallow Water Simulations on Graphics Hardware Ph.D. Thesis Presentation 2014-06-27 Martin Lilleeng Sætra Outline Introduction Parallel Computing and the GPU Simulating Shallow Water Flow Topics of Thesis

More information

Study on the Numerical Accuracy for the CFD

Study on the Numerical Accuracy for the CFD Study on the Numerical Accuracy for the CFD T.Yamanashi 1, H.Uchida, and M.Morita 1 Department of Mathematics, Master s Research Course of Faculty of Science, Tokyo University of Science,1-3 Kagurazaka,

More information

2.29 Numerical Marine Hydrodynamics Spring 2007

2.29 Numerical Marine Hydrodynamics Spring 2007 Numerical Marine Hydrodynamics Spring 2007 Course Staff: Instructor: Prof. Henrik Schmidt OCW Web Site: http://ocw.mit.edu/ocwweb/mechanical- Engineering/2-29Spring-2003/CourseHome/index.htm Units: (3-0-9)

More information

Navier-Stokes & Flow Simulation

Navier-Stokes & Flow Simulation Last Time? Navier-Stokes & Flow Simulation Pop Worksheet! Teams of 2. Hand in to Jeramey after we discuss. Sketch the first few frames of a 2D explicit Euler mass-spring simulation for a 2x3 cloth network

More information

A Toolbox of Level Set Methods

A Toolbox of Level Set Methods A Toolbox of Level Set Methods Ian Mitchell Department of Computer Science University of British Columbia http://www.cs.ubc.ca/~mitchell mitchell@cs.ubc.ca research supported by the Natural Science and

More information

Turbulence et Génération de Bruit Equipe de recherche du Centre Acoustique LMFA, UMR CNRS 5509, Ecole Centrale de Lyon Simulation Numérique en Aéroacoustique Institut Henri Poincaré - 16 novembre 2006

More information

Wave Uplift on Platforms or Docks in Variable Depth Jiin-Jen Lee and C.P. Lai"

Wave Uplift on Platforms or Docks in Variable Depth Jiin-Jen Lee and C.P. Lai CHAPTER 149 ABSTRACT Wave Uplift on Platforms or Docks in Variable Depth Jiin-Jen Lee and C.P. Lai" Wave uplift forces on two dimensional platforms or docks in a variable depth medium has been studied

More information

Parallel Adaptive Tsunami Modelling with Triangular Discontinuous Galerkin Schemes

Parallel Adaptive Tsunami Modelling with Triangular Discontinuous Galerkin Schemes Parallel Adaptive Tsunami Modelling with Triangular Discontinuous Galerkin Schemes Stefan Vater 1 Kaveh Rahnema 2 Jörn Behrens 1 Michael Bader 2 1 Universität Hamburg 2014 PDES Workshop 2 TU München Partial

More information

FEMLAB Exercise 1 for ChE366

FEMLAB Exercise 1 for ChE366 FEMLAB Exercise 1 for ChE366 Problem statement Consider a spherical particle of radius r s moving with constant velocity U in an infinitely long cylinder of radius R that contains a Newtonian fluid. Let

More information

ExactPack: A Master Code of Exact Solutions for Code Verification

ExactPack: A Master Code of Exact Solutions for Code Verification ExactPack: A Master Code of Exact Solutions for Code Verification Robert L. Singleton Jr. Los Alamos National Laboratory bobs1@lanl.gov Collaborators: Scott Doebling Daniel Israel James Kamm ASME V&V Symposium

More information

2.7 Cloth Animation. Jacobs University Visualization and Computer Graphics Lab : Advanced Graphics - Chapter 2 123

2.7 Cloth Animation. Jacobs University Visualization and Computer Graphics Lab : Advanced Graphics - Chapter 2 123 2.7 Cloth Animation 320491: Advanced Graphics - Chapter 2 123 Example: Cloth draping Image Michael Kass 320491: Advanced Graphics - Chapter 2 124 Cloth using mass-spring model Network of masses and springs

More information

Realistic Animation of Fluids

Realistic Animation of Fluids 1 Realistic Animation of Fluids Nick Foster and Dimitris Metaxas Presented by Alex Liberman April 19, 2005 2 Previous Work Used non physics-based methods (mostly in 2D) Hard to simulate effects that rely

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

Figure 2: Water Into Kerosene, Volume Fraction (Left) And Total Density Of Mixture (Right)

Figure 2: Water Into Kerosene, Volume Fraction (Left) And Total Density Of Mixture (Right) Jared Bottlinger MAE598 Project 3 11/16/17 Task 1 a) Figure 1: Volume Fraction Of Water At 0.4s Task 1 b) Figure 2: Water Into Kerosene, Volume Fraction (Left) And Total Density Of Mixture (Right) Task

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

Lecture 1.1 Introduction to Fluid Dynamics

Lecture 1.1 Introduction to Fluid Dynamics Lecture 1.1 Introduction to Fluid Dynamics 1 Introduction A thorough study of the laws of fluid mechanics is necessary to understand the fluid motion within the turbomachinery components. In this introductory

More information

A high order moving boundary treatment for compressible inviscid flows 1. Abstract

A high order moving boundary treatment for compressible inviscid flows 1. Abstract A high order moving boundary treatment for compressible inviscid flows Sirui Tan and Chi-Wang Shu Abstract We develop a high order numerical boundary condition for compressible inviscid flows involving

More information

Chapter 1 - Basic Equations

Chapter 1 - Basic Equations 2.20 Marine Hydrodynamics, Fall 2017 Lecture 2 Copyright c 2017 MIT - Department of Mechanical Engineering, All rights reserved. 2.20 Marine Hydrodynamics Lecture 2 Chapter 1 - Basic Equations 1.1 Description

More information

Navier-Stokes & Flow Simulation

Navier-Stokes & Flow Simulation Last Time? Navier-Stokes & Flow Simulation Implicit Surfaces Marching Cubes/Tetras Collision Detection & Response Conservative Bounding Regions backtracking fixing Today Flow Simulations in Graphics Flow

More information

Solution for Euler Equations Lagrangian and Eulerian Descriptions

Solution for Euler Equations Lagrangian and Eulerian Descriptions Solution for Euler Equations Lagrangian and Eulerian Descriptions Valdir Monteiro dos Santos Godoi valdir.msgodoi@gmail.com Abstract We find an exact solution for the system of Euler equations, supposing

More information

The Shallow Water Equations and CUDA

The Shallow Water Equations and CUDA The Shallow Water Equations and CUDA Alexander Pöppl December 9 th 2015 Tutorial: High Performance Computing - Algorithms and Applications, December 9 th 2015 1 Last Tutorial Discretized Heat Equation

More information

A spectral boundary integral method for inviscid water waves in a finite domain

A spectral boundary integral method for inviscid water waves in a finite domain INTERNATIONAL JOURNAL FOR NUMERICAL METHODS IN FLUIDS Int. J. Numer. Meth. Fluids 25; : 3 Published online in Wiley InterScience (www.interscience.wiley.com). DOI:.2/fld A spectral boundary integral method

More information

CHAPTER 1. Introduction

CHAPTER 1. Introduction ME 475: Computer-Aided Design of Structures 1-1 CHAPTER 1 Introduction 1.1 Analysis versus Design 1.2 Basic Steps in Analysis 1.3 What is the Finite Element Method? 1.4 Geometrical Representation, Discretization

More information

Analysis, extensions and applications of the Finite-Volume Particle Method (FVPM) PN-II-RU-TE Synthesis of the technical report -

Analysis, extensions and applications of the Finite-Volume Particle Method (FVPM) PN-II-RU-TE Synthesis of the technical report - Analysis, extensions and applications of the Finite-Volume Particle Method (FVPM) PN-II-RU-TE-2011-3-0256 - Synthesis of the technical report - Phase 1: Preparation phase Authors: Delia Teleaga, Eliza

More information

Computation of Velocity, Pressure and Temperature Distributions near a Stagnation Point in Planar Laminar Viscous Incompressible Flow

Computation of Velocity, Pressure and Temperature Distributions near a Stagnation Point in Planar Laminar Viscous Incompressible Flow Excerpt from the Proceedings of the COMSOL Conference 8 Boston Computation of Velocity, Pressure and Temperature Distributions near a Stagnation Point in Planar Laminar Viscous Incompressible Flow E. Kaufman

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

The Shallow Water Equations and CUDA

The Shallow Water Equations and CUDA The Shallow Water Equations and CUDA HPC - Algorithms and Applications Alexander Pöppl Technical University of Munich Chair of Scientific Computing January 11 th 2017 Last Tutorial Discretized Heat Equation

More information

Using efficient numerical methods in large-scale air pollution modelling

Using efficient numerical methods in large-scale air pollution modelling Using efficient numerical methods in large-scale air pollution modelling ZAHARI ZLATEV National Environmental Research Institute, Frederiksborgvej 399, P. O. Box 358, DK-4000 Roskilde, DENMARK Abstract:

More information

Numerical Solutions for 2D Depth-Averaged Shallow Water Equations

Numerical Solutions for 2D Depth-Averaged Shallow Water Equations International Mathematical Forum, Vol. 13, 2018, no. 2, 79-90 HIKARI Ltd, www.m-hikari.com https://doi.org/10.12988/imf.2018.712102 Numerical Solutions for 2D Depth-Averaged Shallow Water Equations Huda

More information

Optimised corrections for finite-difference modelling in two dimensions

Optimised corrections for finite-difference modelling in two dimensions Optimized corrections for 2D FD modelling Optimised corrections for finite-difference modelling in two dimensions Peter M. Manning and Gary F. Margrave ABSTRACT Finite-difference two-dimensional correction

More information

Mid-Year Report. Discontinuous Galerkin Euler Equation Solver. Friday, December 14, Andrey Andreyev. Advisor: Dr.

Mid-Year Report. Discontinuous Galerkin Euler Equation Solver. Friday, December 14, Andrey Andreyev. Advisor: Dr. Mid-Year Report Discontinuous Galerkin Euler Equation Solver Friday, December 14, 2012 Andrey Andreyev Advisor: Dr. James Baeder Abstract: The focus of this effort is to produce a two dimensional inviscid,

More information

MA 114 Worksheet #17: Average value of a function

MA 114 Worksheet #17: Average value of a function Spring 2019 MA 114 Worksheet 17 Thursday, 7 March 2019 MA 114 Worksheet #17: Average value of a function 1. Write down the equation for the average value of an integrable function f(x) on [a, b]. 2. Find

More information

BACK AND FORTH ERROR COMPENSATION AND CORRECTION METHODS FOR REMOVING ERRORS INDUCED BY UNEVEN GRADIENTS OF THE LEVEL SET FUNCTION

BACK AND FORTH ERROR COMPENSATION AND CORRECTION METHODS FOR REMOVING ERRORS INDUCED BY UNEVEN GRADIENTS OF THE LEVEL SET FUNCTION BACK AND FORTH ERROR COMPENSATION AND CORRECTION METHODS FOR REMOVING ERRORS INDUCED BY UNEVEN GRADIENTS OF THE LEVEL SET FUNCTION TODD F. DUPONT AND YINGJIE LIU Abstract. We propose a method that significantly

More information

High Order Fixed-Point Sweeping WENO Methods for Steady State of Hyperbolic Conservation Laws and Its Convergence Study

High Order Fixed-Point Sweeping WENO Methods for Steady State of Hyperbolic Conservation Laws and Its Convergence Study Commun. Comput. Phys. doi:.48/cicp.375.6a Vol., No. 4, pp. 835-869 October 6 High Order Fixed-Point Sweeping WENO Methods for Steady State of Hyperbolic Conservation Laws and Its Convergence Study Liang

More information

Corrected/Updated References

Corrected/Updated References K. Kashiyama, H. Ito, M. Behr and T. Tezduyar, "Massively Parallel Finite Element Strategies for Large-Scale Computation of Shallow Water Flows and Contaminant Transport", Extended Abstracts of the Second

More information

Unstructured Mesh Generation for Implicit Moving Geometries and Level Set Applications

Unstructured Mesh Generation for Implicit Moving Geometries and Level Set Applications Unstructured Mesh Generation for Implicit Moving Geometries and Level Set Applications Per-Olof Persson (persson@mit.edu) Department of Mathematics Massachusetts Institute of Technology http://www.mit.edu/

More information

The Shallow Water Equations and CUDA

The Shallow Water Equations and CUDA The Shallow Water Equations and CUDA Oliver Meister December 17 th 2014 Tutorial Parallel Programming and High Performance Computing, December 17 th 2014 1 Last Tutorial Discretized Heat Equation System

More information

(LSS Erlangen, Simon Bogner, Ulrich Rüde, Thomas Pohl, Nils Thürey in collaboration with many more

(LSS Erlangen, Simon Bogner, Ulrich Rüde, Thomas Pohl, Nils Thürey in collaboration with many more Parallel Free-Surface Extension of the Lattice-Boltzmann Method A Lattice-Boltzmann Approach for Simulation of Two-Phase Flows Stefan Donath (LSS Erlangen, stefan.donath@informatik.uni-erlangen.de) Simon

More information

Numerical Simulation of Coupled Fluid-Solid Systems by Fictitious Boundary and Grid Deformation Methods

Numerical Simulation of Coupled Fluid-Solid Systems by Fictitious Boundary and Grid Deformation Methods Numerical Simulation of Coupled Fluid-Solid Systems by Fictitious Boundary and Grid Deformation Methods Decheng Wan 1 and Stefan Turek 2 Institute of Applied Mathematics LS III, University of Dortmund,

More information

SPH Accuracy to Describe the Wave Impact on a Tall Structure (benchmark case 1)

SPH Accuracy to Describe the Wave Impact on a Tall Structure (benchmark case 1) SPH Accuracy to Describe the Wave Impact on a Tall Structure (benchmark case 1) M. GómezG mez-gesteira 1, A. J. C. Crespo 1, M. decastro 1 & R. A. Dalrymple 2 1 GRUPO DE FÍSICA DE LA ATMÓSFERA Y DEL OCÉANO,

More information

Image Sampling and Quantisation

Image Sampling and Quantisation Image Sampling and Quantisation Introduction to Signal and Image Processing Prof. Dr. Philippe Cattin MIAC, University of Basel 1 of 46 22.02.2016 09:17 Contents Contents 1 Motivation 2 Sampling Introduction

More information

3D Simulation of Dam-break effect on a Solid Wall using Smoothed Particle Hydrodynamic

3D Simulation of Dam-break effect on a Solid Wall using Smoothed Particle Hydrodynamic ISCS 2013 Selected Papers Dam-break effect on a Solid Wall 1 3D Simulation of Dam-break effect on a Solid Wall using Smoothed Particle Hydrodynamic Suprijadi a,b, F. Faizal b, C.F. Naa a and A.Trisnawan

More information

HPC Algorithms and Applications

HPC Algorithms and Applications HPC Algorithms and Applications Dwarf #5 Structured Grids Michael Bader Winter 2012/2013 Dwarf #5 Structured Grids, Winter 2012/2013 1 Dwarf #5 Structured Grids 1. dense linear algebra 2. sparse linear

More information

A laboratory-dualsphysics modelling approach to support landslide-tsunami hazard assessment

A laboratory-dualsphysics modelling approach to support landslide-tsunami hazard assessment A laboratory-dualsphysics modelling approach to support landslide-tsunami hazard assessment Lake Lucerne case, Switzerland, 2007 Dr. Valentin Heller (www.drvalentinheller.com) Geohazards and Earth Processes

More information

Image Sampling & Quantisation

Image Sampling & Quantisation Image Sampling & Quantisation Biomedical Image Analysis Prof. Dr. Philippe Cattin MIAC, University of Basel Contents 1 Motivation 2 Sampling Introduction and Motivation Sampling Example Quantisation Example

More information

FAST ALGORITHMS FOR CALCULATIONS OF VISCOUS INCOMPRESSIBLE FLOWS USING THE ARTIFICIAL COMPRESSIBILITY METHOD

FAST ALGORITHMS FOR CALCULATIONS OF VISCOUS INCOMPRESSIBLE FLOWS USING THE ARTIFICIAL COMPRESSIBILITY METHOD TASK QUARTERLY 12 No 3, 273 287 FAST ALGORITHMS FOR CALCULATIONS OF VISCOUS INCOMPRESSIBLE FLOWS USING THE ARTIFICIAL COMPRESSIBILITY METHOD ZBIGNIEW KOSMA Institute of Applied Mechanics, Technical University

More information

Solution for Euler Equations Lagrangian and Eulerian Descriptions

Solution for Euler Equations Lagrangian and Eulerian Descriptions Solution for Euler Equations Lagrangian and Eulerian Descriptions Valdir Monteiro dos Santos Godoi valdir.msgodoi@gmail.com Abstract We find an exact solution for the system of Euler equations, following

More information

Debojyoti Ghosh. Adviser: Dr. James Baeder Alfred Gessow Rotorcraft Center Department of Aerospace Engineering

Debojyoti Ghosh. Adviser: Dr. James Baeder Alfred Gessow Rotorcraft Center Department of Aerospace Engineering Debojyoti Ghosh Adviser: Dr. James Baeder Alfred Gessow Rotorcraft Center Department of Aerospace Engineering To study the Dynamic Stalling of rotor blade cross-sections Unsteady Aerodynamics: Time varying

More information

PORAT A COMPUTER SIMULATION OF THE PROPAGATION OF SEA WAVES

PORAT A COMPUTER SIMULATION OF THE PROPAGATION OF SEA WAVES PORAT A COMPUTER SIMULATION OF THE PROPAGATION OF SEA WAVES Marjan Sikora, M.Sc.E.E. Sv. Klare 14, HR-21000 Split, Croatia, E-mail: marjan.sikora@st.hinet.hr WITH COURTESY OF THE OWNER - OBALA D.D. SPLIT

More information

MODELING OF THREE-DIMENSIONAL PROPAGATION ON A COASTAL WEDGE WITH A SEDIMENT SUPPORTING SHEAR

MODELING OF THREE-DIMENSIONAL PROPAGATION ON A COASTAL WEDGE WITH A SEDIMENT SUPPORTING SHEAR MODELING OF THREE-DIMENSIONAL PROPAGATION ON A COASTAL WEDGE WITH A SEDIMENT SUPPORTING SHEAR Piotr Borejko Vienna University of Technology, Karlsplatz 13/E26/3, 14 Vienna, Austria Fax: + 43 1 588 1 21

More information

RELATING THE BOTTOM PRESSURE AND THE SURFACE ELEVATION IN THE WATER WAVE PROBLEM

RELATING THE BOTTOM PRESSURE AND THE SURFACE ELEVATION IN THE WATER WAVE PROBLEM Journal of Nonlinear Mathematical Physics ISSN: 1402-9251 (Print) 1776-0852 (Online) Journal homepage: http://www.tandfonline.com/loi/tnmp20 RELATING THE BOTTOM PRESSURE AND THE SURFACE ELEVATION IN THE

More information

ATM 298, Spring 2013 Lecture 4 Numerical Methods: Horizontal DiscreDzaDons April 10, Paul A. Ullrich (HH 251)

ATM 298, Spring 2013 Lecture 4 Numerical Methods: Horizontal DiscreDzaDons April 10, Paul A. Ullrich (HH 251) ATM 298, Spring 2013 Lecture 4 Numerical Methods: Horizontal DiscreDzaDons April 10, 2013 Paul A. Ullrich (HH 251) paullrich@ucdavis.edu Outline 1. Introduction / Motivation 2. Finite Difference Methods

More information

IMAGE ANALYSIS DEDICATED TO POLYMER INJECTION MOLDING

IMAGE ANALYSIS DEDICATED TO POLYMER INJECTION MOLDING Image Anal Stereol 2001;20:143-148 Original Research Paper IMAGE ANALYSIS DEDICATED TO POLYMER INJECTION MOLDING DAVID GARCIA 1, GUY COURBEBAISSE 2 AND MICHEL JOURLIN 3 1 European Polymer Institute (PEP),

More information

The initial-boundary problem for the Korteweg de Vries equation on the negative quarter-plane

The initial-boundary problem for the Korteweg de Vries equation on the negative quarter-plane T&T Proof 01PA078 26 November 2001 10.1098/rspa.2001.0868 The initial-boundary problem for the Korteweg de Vries equation on the negative quarter-plane By T. R. Marchant 1 and N. F. Smyth 2 1 School of

More information

The Use of Projection Operators with the Parareal Algorithm to Solve the Heat and the KdVB Equation

The Use of Projection Operators with the Parareal Algorithm to Solve the Heat and the KdVB Equation MATIMYÁS MATEMATIKA Journal of the Mathematical Society of the Philippines ISSN 0115-6926 Vol. 40 Nos. 1-2 (2017) pp. 41-56 The Use of Projection Operators with the Parareal Algorithm to Solve the Heat

More information

September 18, B Math Test Chapter 1 Name: x can be expressed as: {y y 0, y R}.

September 18, B Math Test Chapter 1 Name: x can be expressed as: {y y 0, y R}. September 8, 208 62B Math Test Chapter Name: Part : Objective Questions [ mark each, total 2 marks]. State whether each of the following statements is TRUE or FALSE a) The mapping rule (x, y) (-x, y) represents

More information

Modeling and simulation the incompressible flow through pipelines 3D solution for the Navier-Stokes equations

Modeling and simulation the incompressible flow through pipelines 3D solution for the Navier-Stokes equations Modeling and simulation the incompressible flow through pipelines 3D solution for the Navier-Stokes equations Daniela Tudorica 1 (1) Petroleum Gas University of Ploiesti, Department of Information Technology,

More information

Free-surface flow past arbitrary topography and an inverse approach for wave-free solutions

Free-surface flow past arbitrary topography and an inverse approach for wave-free solutions IMA Journal of Applied Mathematics (23) 78, 685 696 doi:.93/imamat/hxt5 Advance Access publication on April 23, 23 Free-surface flow past arbitrary topography and an inverse approach for wave-free solutions

More information

Towards real time simulation of ship-ship interaction - Part II: double body flow linearization and GPU implementation

Towards real time simulation of ship-ship interaction - Part II: double body flow linearization and GPU implementation Downloaded from orbit.dtu.dk on: Aug 21, 2018 Towards real time simulation of ship-ship interaction - Part II: double body flow linearization and GPU implementation Lindberg, Ole; Glimberg, Stefan Lemvig;

More information

Numerical Simulation of Tsunami Wave PropagationIn Indian Ocean. Title Second Line

Numerical Simulation of Tsunami Wave PropagationIn Indian Ocean. Title Second Line Journal of Computations & Modelling, vol. x, no. x, 2011, x-x ISSN: 1792-7625(print), 1792-7625 (online) c International Scientific Press, 2011 Numerical Simulation of Tsunami Wave PropagationIn Indian

More information

Common-angle processing using reflection angle computed by kinematic pre-stack time demigration

Common-angle processing using reflection angle computed by kinematic pre-stack time demigration Common-angle processing using reflection angle computed by kinematic pre-stack time demigration Didier Lecerf*, Philippe Herrmann, Gilles Lambaré, Jean-Paul Tourré and Sylvian Legleut, CGGVeritas Summary

More information

Shallow Water Equation simulation with Sparse Grid Combination Technique

Shallow Water Equation simulation with Sparse Grid Combination Technique GUIDED RESEARCH Shallow Water Equation simulation with Sparse Grid Combination Technique Author: Jeeta Ann Chacko Examiner: Prof. Dr. Hans-Joachim Bungartz Advisors: Ao Mo-Hellenbrand April 21, 2017 Fakultät

More information

Global Stokes Drift and Climate Wave Modeling

Global Stokes Drift and Climate Wave Modeling Global Stokes Drift and Climate Wave Modeling Adrean Webb University of Colorado, Boulder Department of Applied Mathematics February 20, 2012 In Collaboration with: Research funded by: Baylor Fox-Kemper,

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

CGWAVE Analysis SURFACE WATER MODELING SYSTEM. 1 Introduction

CGWAVE Analysis SURFACE WATER MODELING SYSTEM. 1 Introduction SURFACE WATER MODELING SYSTEM CGWAVE Analysis 1 Introduction This lesson will teach you how to prepare a mesh for analysis and run a solution for CGWAVE. You will start with the data file indiana.xyz which

More information

Final Report. Discontinuous Galerkin Compressible Euler Equation Solver. May 14, Andrey Andreyev. Adviser: Dr. James Baeder

Final Report. Discontinuous Galerkin Compressible Euler Equation Solver. May 14, Andrey Andreyev. Adviser: Dr. James Baeder Final Report Discontinuous Galerkin Compressible Euler Equation Solver May 14, 2013 Andrey Andreyev Adviser: Dr. James Baeder Abstract: In this work a Discontinuous Galerkin Method is developed for compressible

More information

Simulation in Computer Graphics. Particles. Matthias Teschner. Computer Science Department University of Freiburg

Simulation in Computer Graphics. Particles. Matthias Teschner. Computer Science Department University of Freiburg Simulation in Computer Graphics Particles Matthias Teschner Computer Science Department University of Freiburg Outline introduction particle motion finite differences system of first order ODEs second

More information

Downloaded 10/27/17 to Redistribution subject to SIAM license or copyright; see

Downloaded 10/27/17 to Redistribution subject to SIAM license or copyright; see SIAM J. SCI. COMPUT. Vol. 37, No. 3, pp. C354 C383 c 2015 Society for Industrial and Applied Mathematics EFFICIENT IMPLEMENTATION OF NONLINEAR COMPACT SCHEMES ON MASSIVELY PARALLEL PLATFORMS DEBOJYOTI

More information

Comparison of Some Evolutionary Algorithms for Approximate Solutions of Optimal Control Problems

Comparison of Some Evolutionary Algorithms for Approximate Solutions of Optimal Control Problems Australian Journal of Basic and Applied Sciences, 4(8): 3366-3382, 21 ISSN 1991-8178 Comparison of Some Evolutionary Algorithms for Approximate Solutions of Optimal Control Problems Akbar H. Borzabadi,

More information

Semi-automatic transition from simulation to one-shot optimization with equality constraints

Semi-automatic transition from simulation to one-shot optimization with equality constraints Semi-automatic transition from simulation to one-shot optimization with equality constraints Lisa Kusch, Tim Albring, Andrea Walther, Nicolas Gauger Chair for Scientific Computing, TU Kaiserslautern, www.scicomp.uni-kl.de

More information

Simulation of Freak Wave Impact Using the Higher Order Spectrum

Simulation of Freak Wave Impact Using the Higher Order Spectrum Simulation of Freak Wave Impact Using the Higher Order Spectrum The Naval Hydro Pack Hrvoje Jasak and Vuko Vukčević Faculty of Mechanical Engineering and Naval Architecture, Uni Zagreb, Croatia Wikki Ltd.

More information

INTERNATIONAL JOURNAL OF CIVIL AND STRUCTURAL ENGINEERING Volume 2, No 3, 2012

INTERNATIONAL JOURNAL OF CIVIL AND STRUCTURAL ENGINEERING Volume 2, No 3, 2012 INTERNATIONAL JOURNAL OF CIVIL AND STRUCTURAL ENGINEERING Volume 2, No 3, 2012 Copyright 2010 All rights reserved Integrated Publishing services Research article ISSN 0976 4399 Efficiency and performances

More information

Lattice Boltzmann with CUDA

Lattice Boltzmann with CUDA Lattice Boltzmann with CUDA Lan Shi, Li Yi & Liyuan Zhang Hauptseminar: Multicore Architectures and Programming Page 1 Outline Overview of LBM An usage of LBM Algorithm Implementation in CUDA and Optimization

More information

Non-Rigid Image Registration III

Non-Rigid Image Registration III Non-Rigid Image Registration III CS6240 Multimedia Analysis Leow Wee Kheng Department of Computer Science School of Computing National University of Singapore Leow Wee Kheng (CS6240) Non-Rigid Image Registration

More information