Available online at ScienceDirect. Procedia Engineering 61 (2013 ) 94 99

Size: px
Start display at page:

Download "Available online at ScienceDirect. Procedia Engineering 61 (2013 ) 94 99"

Transcription

1 Available online at ScienceDirect Procedia Engineering 6 (203 ) Parallel Computational Fluid Dynamics Conference (ParCFD203) Simulations of three-dimensional cavity flows with multi relaxation time lattice Boltzmann method and graphic processing units Hung-Wen Chang a, Pei-Yao Hong a, Li-Song Lin a, Chao-An Lin a, a Department of Power Mechanical Engineering, National Tsing Hua University, Hsinchu 3003, TAIWAN Abstract Three-dimensional square cavity flows are simulated using multi-relaxation lattice Boltzmann method and graphic processing units. It was found that transition takes place between 700 < Re < Parallel computations are conducted on a single node multi graphic processing unit (GPU) system, consisting of three nvidia M2070 or GTX560 devices using OpenMP. Results show that the speedup performance is strongly dependent on problem size and the precision adopted. For single precision computation with grid density, about 59 times speedup can be obtained, while for double precision computation, this is slightly degraded to 2. Both are achieved with three Tesla M2070. c 203 The Authors. Published by Elsevier Ltd. Selection Open access and/or under peer-review CC BY-NC-ND under license. responsibility of the Hunan University and Selection National Supercomputing and peer-review Center under inresponsibility Changsha (NSCC). of the Hunan University and National Supercomputing Center in Changsha (NSCC) Keywords: multi relaxation time (MRT); lattice Boltzmann model; graphic processing unit (GPU); three dimensional lid-driven cavity flow; high Reynolds number flows.. Introduction Three-dimensional cavity flows were frequently investigated both by experiments and numerical simulations. For example, Iwatsu et al.[], Guj and Stella[2] and Mei et al.[3] adopted different numerical schemes to simulate cubic cavity flows, where steady solution was shown to exist at Reynolds number being Re = Using Chebyshevcollocation technique, Albensoeder and Kuhlmann[4] presented solutions for cavity flows at various aspect ratio at Reynolds number up to 000. Feldman et al.[5] also investigated numerically the critical Reynolds number for cubic cavity and showed that the oscillatory instability occurs at Re 94. This result was later on supported by a PIV measurement[6], which concluded that the critical Reynolds number locates in region 700 < Re < 970. On the other hand, lattice Boltzmann method (LBM)[7, 8, 9, 0] has been successfully applied to various hydrodynamic problems and the major advantage of the LBM is explicit formulation. Thus, the present study aims to examine the range of critical Reynolds number on a square cavity using multi-relaxation lattice Boltzmann model due to its enhanced stability at high Reynolds number flows. Also, as an explicit numerical scheme with intensive local computation, the LBM algorithm is very suitable for parallelization. This can be achieved using the Graphical Processing Unit (GPU) through the Compute Unified Device Architecture (CUDA). The computation platform is a single node multi-gpu system consisting of three nvidia M2070 devices with OpenMP framework and its performance relative to CPU will also be addressed. Corresponding author. Tel.: ; fax: address: calin@pme.nthu.edu.tw The Authors. Published by Elsevier Ltd. Open access under CC BY-NC-ND license. Selection and peer-review under responsibility of the Hunan University and National Supercomputing Center in Changsha (NSCC) doi:0.06/j.proeng

2 Hung-Wen Chang et al. / Procedia Engineering 6 ( 203 ) Multi Relaxation Time Lattice Boltzmann Model and Boundary conditions The multi relaxation time (MRT) lattice Boltzmann method [] can be expressed as collision and streaming steps, respectively: fi = f i( x, t) Mil S lj [m j ( x, t) m eq j ( x, t)], () f i ( x + e i t, t + t) = fi ( x, t) (2) where M is a matrix that transforms the distribution function f to the velocity moment, m=mf, and S is the relaxation matrix. These will be defined later. Based on the particle distribution functions, the macroscopic density and velocity can be obtained as: f i = ρ, f i e i = ρ u (3) i i For the present 3D applications, the D3Q9 multi relaxation time model is adopted. The transform matrix M of this model is given as[2], M = and the velocity moments are correspondingly defined as, m = (ρ, e,ε, j x, q x, j y, q y, j z, q z, 3p xx, 3π xx, p ww,π ww, p xy, p yz, p zx, m x, m y, m z ) T (5) As suggested in[2], the adopted equilibrium moments are, e eq = ρ + 9 ρ ( j2 x + j 2 y + j 2 z ), ε eq = ρ ( j2 x + j 2 y + j 2 z ) q eq x = 2 3 j x, q eq y = 2 3 j y, q eq z = 2 3 j z, (4) 3 xx = ρ [2 j2 x ( j 2 y + j 2 z )], ww = ρ ( j2 y j 2 z ), xy = ρ j x j y, 3π eq xx = π eq ww = 0, yz = ρ j y j z, m eq x = m eq y xz = ρ j x j z = m eq z = 0 (6)

3 96 Hung-Wen Chang et al. / Procedia Engineering 6 ( 203 ) CPU Thread 0 The plane of symmetry Lid velocity U_T = 0. hostmem = NX*NY*NZ*sizeof() malloc(f_h), malloc(u_h),..., malloc(rho_h) init(f_h, u_h,..., rho_h) h st Primary vortex CPU Thread 0 CPU Thread cudasetdevice(0) devicemem = NX*NY*(NZ/N)*sizeof() cudasetdevice() devicemem = NX*NY*(NZ/N)*sizeof() CPU Thread N- cudasetdevice(n-) devicemem = NX*NY*(NZ/N)*sizeof() K 2nd Primary vortex Collision<<<>>>() Streaming<<<>>>() Collision<<<>>>() P2P Memcpy P2P Memcpy Streaming<<<>>>() Collision<<<>>>() P2P Memcpy Streaming<<<>>>() Boundary<<<>>>() MacroCompute<<<>>>() Boundary<<<>>>() MacroCompute<<<>>>() Boundary<<<>>>() MacroCompute<<<>>>() Y X Z CPU Thread 0 Write data Post process free(f_h), free(u_h),..., free(rho_h) Fig.. Geometric setup of 3D cavity flow Fig. 2. The simulation procedure for multi-gpu implementation Here, the relaxation matrix S is a diagonal matrix, i.e., S = diag[0, s, s 2, 0, s 4, 0, s 4, 0, s 4, s 9, s 0, s 9, s 0, s 3, s 3, s 3, s 6, s 6, s 6 ] (7) where the kinematic viscosity is given by ν = 3 ( s 9 2 ) = 3 ( s 3 2 ) (8) The relaxation parameters for density and momentum are set equal to zero in order to conserve mass and momentum, and the rest of the relaxation parameters are chosen to be 0.7 to enhance stability at high Reynolds number. For the present lid driven cavity shown in Fig., two types of boundary conditions are adopted. The first one is used for the top lid boundary which moves at a constant velocity, while the second one is applied on the stationary boundary along the remaining five walls. Boundary conditions proposed in [3, 4, 5] are employed to determine the unknown particle density distribution functions along the boundary, which are expressed as a combination of the local known value and a corrector, f i ( x, t) = f ( x, e i, t) + ω i C e i Q (9) where Q is the force like corrector to enforce the required momentum. This resembles the modification of momentum due to the presence of a body force, though this only applies to the unknown particle density distribution functions along the boundary. On the other hand, the equilibrium distribution functions with a constant density are imposed along the top moving lid as suggested by Hou et al.[6]. 3. GPU Implementation The focus of the present study is the first step towards the multi graphic processing unit(gpu) computations. There are several possibilities to enable the multi-gpu computational capability, such as Message Passing Interface (MPI) or POSIX threads programming. Here, the Open Multiprocessing (OpenMP) is adopted for single node multi-gpu implementation consisting of three GPUS. There are two types of GPU adopted, i.e. nvidia Tesla M2070 and Geforce GTX560 Ti. Each Tela M2070 has 6G GDDR5 memory with 448 CUDA cores and Geforce GTX560 Ti has G GDDR5 memory with 384 CUDA cores. Fig. 2 shows the simulation procedure for current LBM computations. First, variables including microscopic distribution functions f and macroscopic quantities, such as density and velocities, are declared and initialized in the host end. A set of variables which will be used for computation on GPU are then allocated in the global memory by each device. Because of the presence of multiple GPUs, each device only needs to compute a portion of the original

4 Hung-Wen Chang et al. / Procedia Engineering 6 ( 203 ) U 28 3 V 28 3 U 60 3 V 60 3 Albensoeder and Kuhlmann (2005) Re=000 Re=700 Re= U / U 0 U X Fig. 3. Simulation comparison with Albensoeder et al.[4] at Re = 000, cubic cavity Time Step Fig. 4. Time evolutions of horizontal velocity at the monitor point, K= fluid domain. For example, when simulating a fluid problem with NX*NY*NZ problem size on N graphic cards, each device is responsible for only NX*NY*(NZ/N) grids. Therefore, required memory space for each device is reduced and larger fluid problems can be simulated. Under the OpenMP structure, each device is controlled by a corresponding thread when performing the kernel executions. For convenience, in current GPU implementations, each thread is responsible for the computational tasks on the single grid. Tasks for each kernel are described as follows: Collision step: In this step, processors will execute collision operator which is the right hand side of Eq. (). To perform the collision step, only local computations will take place and no interaction between grid appears. Distribution functions in the post collision state, which can be denoted as f, are stored in a temporary array for the usage of streaming step. Streaming step: In the streaming function, each post distribution function f will move to the neighbor grid by following its lattice velocity direction, i.e. in Eq. (2). Due to the requirement of information in the neighbor gird, data transfers between different device will take place. The memory copies between devices are performed by using the cudamemcpypeerasync() command. After the data transfers between graphic cards, the local propagation is then performed in separate device and communications between neighboring grid will show up. In each device, for grids belong to different thread blocks, it is unavoidable to access data through global memory, and the parallel performance will then be affected owing to the large latency of global memory. Boundary step: Boundary condition scheme is imposed in this function. For the five stationary walls, boundary condition proposed by Ho et al.[3] is adopted. While for the moving lid wall, the equilibrium boundary condition is used[6]. Macro-computing step: Density and velocities in each computational grid are calculated in this step. Those updated values will then be used for the next iteration. When maximum time step is reached, these macroscopic quantities will be transferred back to host memory and the whole simulation loop is closed. In this study, the number of threads in a block and the number of blocks in each device are chosen by following the principle that one thread is responsible for all computation executions in one grid, which makes the GPU implementation much straightforward and convenient. Additionally, single and double precision computations are adopted, where the latter is required for deep cavity flow[7].

5 98 Hung-Wen Chang et al. / Procedia Engineering 6 ( 203 ) Numerical results The geometric setup of three-dimensional cavity is shown in Fig.. Here, W is the width in the x direction, L is the length in the z direction and H is the depth in the y direction. The ratios between W and L and W and H are fixed to one. The cavity Reynolds number is defined as Re = U lid W/ν. Firstly, grid sensitivity test is conducted to ensure the simulation is grid independent. Cubic cavity flow at Reynolds number being 000 is simulated and the results are compared with the solutions presented by Albensoeder et al.[4]. As shown in Fig. 3, LBM solutions become grid independent with grid density 28 3 and 60 3, and the results are in good agreement with the benchmark solutions. Therefore, in the following simulations, grid density is adopted. One of the issue addressed in the present study is to explore the region of the critical Reynolds number where the first Hopf bifurcation takes place. This is achieved by monitoring the time history of the horizontal velocity components at the location (x,y,z)=(0.2,0.2,0.5). Fig. 4 shows the time evolutions of the horizontal velocity inside the cubic cavity. At Reynolds number 000 and 700, the velocity profiles remains unchanged as time proceeds, indicating that steady solutions have reached. When the Reynolds number increases to 2000, the time evolution pattern becomes periodic and the flow field is unsteady. 5. Parallel performance The performance of current GPU implementation is addressed here. Cubic cavity flow at Reynolds number being 00 is used as the test problem. Each examined case will run 5000 iterations and the required computational times are documented and used to investigate the performance. The speedup performance as well as the scalability of multi- GPU implementation are studied. Three different sets of grid density are selected, i.e. 96 3, 92 3, and The multi-gpu platform is made up of three M2070 or three GTX560 Ti graphics processing units. The compared CPU counterpart is the Intel Core-i7 990 processor. The CUDA program is compiled using nvcc 4.2 version, while the CPU program is compiled with the gcc and icc. Figs. 5 and 6 show the acceleration of computational time with different problem sizes with single and double precision, respectively. For single precision computation with 96 3 grid density, about 38 times speedups can be obtained using three GTX560 GPUS, and 35 times speedups are obtained with three M2070 devices. By increasing the problem sizes, the Tesla M2070 outperforms GTX560 due the larger on card memory size. For problem size equals to 240 3, this value is enhanced to 59 usimg three M2070 devices. On the other hand, double precision computation results show a slightly degraded performance compared with the single precision counterpart, and 2 times acceleration is achieved under the biggest examined problem size using M2070. It should be noted that more GTX560 devices are required to accommodate the memory requirements as the problem size increases. 6. Conclusion The multi-relaxation lattice Boltzmann model is adopted to simulate three-dimensional cubic cavity flows. It was found that transition takes place between 700 < Re < 2000, which is consistent with the results published by Liberzon et al.[6]. Also, the computations of the present study are conducted on a single node multi-gpu system, where three nvidia M2070 or GTX560 devices execute simultaneously using OpenMP. Results show that the speedup performance is strongly dependent on problem size and the precision adopted. For single precision computation with grid density, about 59 times speedup can be obtained, while for double precision computation, this is slightly degraded to 2. Both are achieved with three Tesla M2070. GTX560 s performance is compatible with Tesla M2070. It should be noted that more GTX560 devices are required to accommodate the memory requirements as the problem size increases. Acknowledgments The authors gratefully acknowledge the supports by the Taiwan National Science Council and Low carbon energy research center of National Tsing Hua University and the computational facilities provided by the Taiwan National Center for High-Performance Computing.

6 Hung-Wen Chang et al. / Procedia Engineering 6 ( 203 ) CPU(GCC) M2070 x 560Ti x CPU(ICC) M2070 x2 560Ti x2 5.2x M2070 x3 560Ti x CPU(GCC) M2070 x 560Ti x CPU(ICC) M2070 x2 M2070 x3 560Ti x2 560Ti x3 3.33x 3.8x Log 0 (Time) x 49.62x 49.92x 96.62x 02.53x 35.07x 38.04x 52.23x 50.97x 09.07x 0.86x 58.62x 54.74x 52.94x 08.04x 58.76x x Log 0 (Time) x 35.3x 39.67x 70.4x 77.77x 95.99x 99.47x 36.33x x 78.05x 07.4x 38.39x 77.23x.74x 00.57x Problem Size Problem Size Fig. 5. Parallel performance under different problem sizes: single precision Fig. 6. Parallel performance under different problem sizes: double precision References [] Iwatsu R., Ishii K., Kawamura T., Kuwahara K., Hyun J. M., Numerical simulation of three-dimensional flow structure in a driven cavity, Fluid Dyn. Res., 5, 73, (989). [2] Guj G., Stella F., A vorticity-velocity method for the numerical solution of 3D incompressible flows, J. Comput. Phys., 06, 286, (993). [3] Mei R., Shyy W., Yu D., Luo L. S., Lattice Boltzmann method for 3-D flows with curved boundary, J. Comput. Phys., 6, 680, (2000). [4] Albensoeder S., Kuhlmann H. C., Accurate three-dimensional lid-driven cavity flow, J. Comput. Phys., 206, 536, (2005). [5] Feldman Y., Gelfgat A. Yu., Oscillatory instability of a three-dimensional lid-driven flow in a cube, Phys. Fluids, 22, , (200). [6] Liberzon A., Feldman Yu., Gelfgat A. Yu., Experimental observation of the steady-oscillatory transition in a cubic lid-driven cavity, Phys. Fluids, 23, 08406, (20). [7] Yu D. Z., Mei R. W., Luo L. S., Shyy W., Viscous flow computations with the method of lattice Boltzmann equation, Prog Aeosp Sci., 39, 329 (2003). [8] Lin L. S., Chen Y. C., Lin C. A., Multi relaxation time lattice Boltzmann simulations of deep lid driven cavity flows at different aspect ratios, Computers & Fluids, 45, 233, (20). [9] Shih C. H., Wu C. L., Chang L. C., Lin C. A., Lattice Boltzmann simulations of incompressible liquid-gas systems on partial wetting surfaces. Philos, Trans R Soc A-Math Phys Eng Sci., 369, 250 (20). [0] Lin K. H., Liao, C. C., Lien, S. Y., Lin, C. A., Thermal lattice Boltzmann simulations of natural convection with complex geometry, Computers & Fluids, 69, 35 (202). [] Lallemand P., Luo L. S., Theory of the lattice Boltzmann method: dispersion, dissipation, isotropy, Galilean invariance, and stability, Physical Review E, 6, 6546, (2000). [2] d Humières D., Ginzburg I., Krafczyk M., Lallemand P., Luo L. S., Multiple-relaxation-time lattice Boltzmann models in three dimensions, Philosophical Transaction of the Royal Society of London Series A-Mathematical Physical and Engineering Sciences, 360, 437, (2002). [3] Ho C. F., Chang C., Lin K. H., Lin C. A., Consistent boundary conditions for 2D and 3D laminar Lattice Boltzmann Simulations, CMES- Computer Modeling in Engineering and Sciences, 44, 37, (2009). [4] Chang C., Liu C. H., Lin C. A., Boundary conditions for lattice Boltzmann simulations with complex geometry flows, Computers and Mathematics with applications, 58, 940, (2009). [5] Liu C. H., Lin K. H., Mai H. C., Lin C. A., 200, Thermal boundary conditions for thermal Lattice Boltzmann simulations, Computers and Mathematics with applications, 59, 278, (200). [6] Hou S., Zou Q., Chen S., Doolen G., Cogley A. C., Simulation of cavity flow by the lattice Boltzmann method, J. Comput. Phys., 8, 329, (995). [7] Lin L. S., Chang H. W., Lin C. A., Multi relaxation time lattice Boltzmann simulations of transition in deep 2D lid driven cavity using GPU, Computers & Fluids (202), doi:0.06/j.compfluid

Parallelism of MRT Lattice Boltzmann Method based on Multi-GPUs

Parallelism of MRT Lattice Boltzmann Method based on Multi-GPUs Parallelism of MRT Lattice Boltzmann Method based on Multi-GPUs 1 School of Information Engineering, China University of Geosciences (Beijing) Beijing, 100083, China E-mail: Yaolk1119@icloud.com Ailan

More information

COMPARISON OF CPU AND GPU IMPLEMENTATIONS OF THE LATTICE BOLTZMANN METHOD

COMPARISON OF CPU AND GPU IMPLEMENTATIONS OF THE LATTICE BOLTZMANN METHOD XVIII International Conference on Water Resources CMWR 2010 J. Carrera (Ed) c CIMNE, Barcelona, 2010 COMPARISON OF CPU AND GPU IMPLEMENTATIONS OF THE LATTICE BOLTZMANN METHOD James.E. McClure, Jan F. Prins

More information

Predictor-Corrector Finite-Difference Lattice Boltzmann Schemes

Predictor-Corrector Finite-Difference Lattice Boltzmann Schemes Applied Mathematical Sciences, Vol. 9, 2015, no. 84, 4191-4199 HIKARI Ltd, www.m-hikari.com http://dx.doi.org/10.12988/ams.2015.5138 Predictor-Corrector Finite-Difference Lattice Boltzmann Schemes G. V.

More information

Multiphase Flow Simulations in Inclined Tubes with Lattice Boltzmann Method on GPU

Multiphase Flow Simulations in Inclined Tubes with Lattice Boltzmann Method on GPU Multiphase Flow Simulations in Inclined Tubes with Lattice Boltzmann Method on GPU Khramtsov D.P., Nekrasov D.A., Pokusaev B.G. Department of Thermodynamics, Thermal Engineering and Energy Saving Technologies,

More information

Simulation of Lid-driven Cavity Flow by Parallel Implementation of Lattice Boltzmann Method on GPUs

Simulation of Lid-driven Cavity Flow by Parallel Implementation of Lattice Boltzmann Method on GPUs Simulation of Lid-driven Cavity Flow by Parallel Implementation of Lattice Boltzmann Method on GPUs S. Berat Çelik 1, Cüneyt Sert 2, Barbaros ÇETN 3 1,2 METU, Mechanical Engineering, Ankara, TURKEY 3 METU-NCC,

More information

External and Internal Incompressible Viscous Flows Computation using Taylor Series Expansion and Least Square based Lattice Boltzmann Method

External and Internal Incompressible Viscous Flows Computation using Taylor Series Expansion and Least Square based Lattice Boltzmann Method Available online at http://ijim.srbiau.ac.ir/ Int. J. Industrial Mathematics (ISSN 2008-5621) Vol. 10, No. 2, 2018 Article ID IJIM-00726, 8 pages Research Article External and Internal Incompressible Viscous

More information

The lattice Boltzmann equation (LBE) has become an alternative method for solving various fluid dynamic

The lattice Boltzmann equation (LBE) has become an alternative method for solving various fluid dynamic 36th AIAA Fluid Dynamics Conference and Exhibit 5-8 June 2006, San Francisco, California AIAA 2006-3904 Direct and Large-Eddy Simulation of Decaying and Forced Isotropic Turbulence Using Lattice Boltzmann

More information

LATTICE BOLTZMANN SIMULATION OF FLUID FLOW IN A LID DRIVEN CAVITY

LATTICE BOLTZMANN SIMULATION OF FLUID FLOW IN A LID DRIVEN CAVITY LATTICE BOLTZMANN SIMULATION OF FLUID FLOW IN A LID DRIVEN CAVITY M. Y. Gokhale, Ignatius Fernandes Maharashtra Institute of Technology, Pune 4 38, India University of Pune, India Email : mukundyg@yahoo.co.in,

More information

The Lattice Boltzmann Method for Laminar and Turbulent Channel Flows

The Lattice Boltzmann Method for Laminar and Turbulent Channel Flows The Lattice Boltzmann Method for Laminar and Turbulent Channel Flows Vanja Zecevic, Michael Kirkpatrick and Steven Armfield Department of Aerospace Mechanical & Mechatronic Engineering The University of

More information

DURING the past two decades, the standard lattice Boltzmann

DURING the past two decades, the standard lattice Boltzmann IAENG International Journal of Computer Science 44:4 IJCS_44_4_4 Scalable Parallel Algorithm of Finite Difference Lattice Boltzmann Method Lei Xu Anping Song Zhixiang Liu and Wu Zhang Abstract The lattice

More information

Computers and Mathematics with Applications

Computers and Mathematics with Applications Computers and Mathematics with Applications 67 (014) 445 451 Contents lists available at ScienceDirect Computers and Mathematics with Applications journal homepage: www.elsevier.com/locate/camwa GPU accelerated

More information

Lattice Boltzmann Method for Moving Boundaries

Lattice Boltzmann Method for Moving Boundaries Lattice Boltzmann Method for Moving Boundaries Hans Groot March 18, 2009 Outline 1 Introduction 2 Moving Boundary Conditions 3 Cylinder in Transient Couette Flow 4 Collision-Advection Process for Moving

More information

On pressure and velocity boundary conditions for the lattice Boltzmann BGK model

On pressure and velocity boundary conditions for the lattice Boltzmann BGK model On pressure and velocity boundary conditions for the lattice Boltzmann BGK model Qisu Zou Theoretical Division, Los Alamos National Lab, Los Alamos, New Mexico 7545 and Department of Mathematics, Kansas

More information

Lattice Boltzmann Method for Fluid Simulations

Lattice Boltzmann Method for Fluid Simulations 1 / 16 Lattice Boltzmann Method for Fluid Simulations Yuanxun Bill Bao & Justin Meskas Simon Fraser University April 7, 2011 2 / 16 Ludwig Boltzmann and His Kinetic Theory of Gases The Boltzmann Transport

More information

Research of Micro-Rectangular-Channel Flow Based on Lattice Boltzmann Method

Research of Micro-Rectangular-Channel Flow Based on Lattice Boltzmann Method Research Journal of Applied Sciences, Engineering and Technology 6(14): 50-55, 013 ISSN: 040-7459; e-issn: 040-7467 Maxwell Scientific Organization, 013 Submitted: November 08, 01 Accepted: December 8,

More information

Introduction to numerical computations on the GPU

Introduction to numerical computations on the GPU Introduction to numerical computations on the GPU Lucian Covaci http://lucian.covaci.org/cuda.pdf Tuesday 1 November 11 1 2 Outline: NVIDIA Tesla and Geforce video cards: architecture CUDA - C: programming

More information

Lattice Boltzmann Method Solver Documentation

Lattice Boltzmann Method Solver Documentation Lattice Boltzmann Method Solver Documentation Release 0.0.1 Sayop Kim May 03, 2016 Contents 1 Code Instruction 3 1.1 Quick instruction for running the simulation.............................. 3 2 Results

More information

Generalized Local Equilibrium in the Cascaded Lattice Boltzmann Method. Abstract

Generalized Local Equilibrium in the Cascaded Lattice Boltzmann Method. Abstract Accepted for publication on Physical Review E (R), code ERR1034 Generalized Local Equilibrium in the Cascaded Lattice Boltzmann Method Pietro Asinari Department of Energetics, Politecnico di Torino, Corso

More information

Alternative and Explicit Derivation of the Lattice Boltzmann Equation for the Unsteady Incompressible Navier-Stokes Equation

Alternative and Explicit Derivation of the Lattice Boltzmann Equation for the Unsteady Incompressible Navier-Stokes Equation ISSN (e): 2250 3005 Volume, 06 Issue, 12 December 2016 International Journal of Computational Engineering Research (IJCER) Alternative and Explicit Derivation of the Lattice Boltzmann Equation for the

More information

arxiv: v1 [hep-lat] 7 Oct 2010

arxiv: v1 [hep-lat] 7 Oct 2010 arxiv:.486v [hep-lat] 7 Oct 2 Nuno Cardoso CFTP, Instituto Superior Técnico E-mail: nunocardoso@cftp.ist.utl.pt Pedro Bicudo CFTP, Instituto Superior Técnico E-mail: bicudo@ist.utl.pt We discuss the CUDA

More information

Lattice Boltzmann Method for Fluid Simulations

Lattice Boltzmann Method for Fluid Simulations Lattice Boltzmann Method for Fluid Simulations Yuanxun Bill Bao & Justin Meskas April 14, 2011 1 Introduction In the last two decades, the Lattice Boltzmann method (LBM) has emerged as a promising tool

More information

Simulation of lid-driven cavity ows by parallel lattice Boltzmann method using multi-relaxation-time scheme

Simulation of lid-driven cavity ows by parallel lattice Boltzmann method using multi-relaxation-time scheme INTERNATIONAL JOURNAL FOR NUMERICAL METHODS IN FLUIDS Int. J. Numer. Meth. Fluids 2004; 46:921 937 Published online 27 September 2004 in Wiley InterScience (www.interscience.wiley.com). DOI: 10.1002/d.787

More information

Using LBM to Investigate the Effects of Solid-Porous Block in Channel

Using LBM to Investigate the Effects of Solid-Porous Block in Channel International Journal of Modern Physics and Applications Vol. 1, No. 3, 015, pp. 45-51 http://www.aiscience.org/journal/ijmpa Using LBM to Investigate the Effects of Solid-Porous Bloc in Channel Neda Janzadeh,

More information

The Lattice Boltzmann Simulation on Multi-GPU Systems

The Lattice Boltzmann Simulation on Multi-GPU Systems The Lattice Boltzmann Simulation on Multi-GPU Systems Thor Kristian Valderhaug Master of Science in Computer Science Submission date: June 2011 Supervisor: Anne Cathrine Elster, IDI Norwegian University

More information

Simulation of 2D non-isothermal flows in slits using lattice Boltzmann method

Simulation of 2D non-isothermal flows in slits using lattice Boltzmann method Simulation of 2D non-isothermal flows in slits using lattice Boltzmann method João Chambel Leitão Department of Mechanical Engineering, Instituto Superior Técnico, Lisboa, Portugal Abstract: The present

More information

A Momentum Exchange-based Immersed Boundary-Lattice. Boltzmann Method for Fluid Structure Interaction

A Momentum Exchange-based Immersed Boundary-Lattice. Boltzmann Method for Fluid Structure Interaction APCOM & ISCM -4 th December, 03, Singapore A Momentum Exchange-based Immersed Boundary-Lattice Boltzmann Method for Fluid Structure Interaction Jianfei Yang,,3, Zhengdao Wang,,3, and *Yuehong Qian,,3,4

More information

Coupling of Lattice Boltzmann Equation and Finite Volume Method to Simulate Heat Transfer in a Square Cavity

Coupling of Lattice Boltzmann Equation and Finite Volume Method to Simulate Heat Transfer in a Square Cavity Copyright 2009 Tech Science Press FDMP, vol.5, no.3, pp.283-295, 2009 Coupling of Lattice Boltzmann Equation and Finite Volume Method to Simulate Heat Transfer in a Square Cavity Ahmed Mezrhab 1 and Hassan

More information

A Framework for Hybrid Parallel Flow Simulations with a Trillion Cells in Complex Geometries

A Framework for Hybrid Parallel Flow Simulations with a Trillion Cells in Complex Geometries A Framework for Hybrid Parallel Flow Simulations with a Trillion Cells in Complex Geometries SC13, November 21 st 2013 Christian Godenschwager, Florian Schornbaum, Martin Bauer, Harald Köstler, Ulrich

More information

Available online at ScienceDirect. Procedia Engineering 90 (2014 )

Available online at   ScienceDirect. Procedia Engineering 90 (2014 ) Available online at www.sciencedirect.com ScienceDirect Procedia Engineering 9 (24 ) 55 556 th International Conference on Mechanical Engineering, ICME 23 Analysis of heat transfer and flow due to natural

More information

arxiv: v1 [physics.flu-dyn] 10 Aug 2015

arxiv: v1 [physics.flu-dyn] 10 Aug 2015 Slip velocity of lattice Boltzmann simulation using bounce-back boundary scheme Jianping Meng, Xiao-Jun Gu, and David R Emerson Scientific Computing Department, STFC Daresbury laboratory, arxiv:1508.009v1

More information

A CUDA Solver for Helmholtz Equation

A CUDA Solver for Helmholtz Equation Journal of Computational Information Systems 11: 24 (2015) 7805 7812 Available at http://www.jofcis.com A CUDA Solver for Helmholtz Equation Mingming REN 1,2,, Xiaoguang LIU 1,2, Gang WANG 1,2 1 College

More information

On Portability, Performance and Scalability of a MPI OpenCL Lattice Boltzmann Code

On Portability, Performance and Scalability of a MPI OpenCL Lattice Boltzmann Code On Portability, Performance and Scalability of a MPI OpenCL Lattice Boltzmann Code E Calore, S F Schifano, R Tripiccione Enrico Calore INFN Ferrara, Italy 7 th Workshop on UnConventional High Performance

More information

Lattice Boltzmann Modeling of Wave Propagation and Reflection in the Presence of Walls and Blocks

Lattice Boltzmann Modeling of Wave Propagation and Reflection in the Presence of Walls and Blocks Lattice Boltzmann Modeling of Wave Propagation and Reflection in the Presence of Walls and Blocs Maysam Saidi, Hassan Basirat Tabrizi, Member, IAENG, and Reza Sepahi Samian Abstract Lattice Boltzmann method

More information

Two-Dimensional Unsteady Flow in a Lid Driven Cavity with Constant Density and Viscosity ME 412 Project 5

Two-Dimensional Unsteady Flow in a Lid Driven Cavity with Constant Density and Viscosity ME 412 Project 5 Two-Dimensional Unsteady Flow in a Lid Driven Cavity with Constant Density and Viscosity ME 412 Project 5 Jingwei Zhu May 14, 2014 Instructor: Surya Pratap Vanka 1 Project Description The objective of

More information

Computers and Mathematics with Applications. Investigation of the LES WALE turbulence model within the lattice Boltzmann framework

Computers and Mathematics with Applications. Investigation of the LES WALE turbulence model within the lattice Boltzmann framework Computers and Mathematics with Applications 59 (2010) 2200 2214 Contents lists available at ScienceDirect Computers and Mathematics with Applications journal homepage: www.elsevier.com/locate/camwa Investigation

More information

Population annealing study of the frustrated Ising antiferromagnet on the stacked triangular lattice

Population annealing study of the frustrated Ising antiferromagnet on the stacked triangular lattice Population annealing study of the frustrated Ising antiferromagnet on the stacked triangular lattice Michal Borovský Department of Theoretical Physics and Astrophysics, University of P. J. Šafárik in Košice,

More information

Welcome to MCS 572. content and organization expectations of the course. definition and classification

Welcome to MCS 572. content and organization expectations of the course. definition and classification Welcome to MCS 572 1 About the Course content and organization expectations of the course 2 Supercomputing definition and classification 3 Measuring Performance speedup and efficiency Amdahl s Law Gustafson

More information

Lattice Boltzmann simulations on heterogeneous CPU-GPU clusters

Lattice Boltzmann simulations on heterogeneous CPU-GPU clusters Lattice Boltzmann simulations on heterogeneous CPU-GPU clusters H. Köstler 2nd International Symposium Computer Simulations on GPU Freudenstadt, 29.05.2013 1 Contents Motivation walberla software concepts

More information

Drag Force Simulations of Particle Agglomerates with the Lattice-Boltzmann Method

Drag Force Simulations of Particle Agglomerates with the Lattice-Boltzmann Method Drag Force Simulations of Particle Agglomerates with the Lattice-Boltzmann Method Christian Feichtinger, Nils Thuerey, Ulrich Ruede Christian Binder, Hans-Joachim Schmid, Wolfgang Peukert Friedrich-Alexander-Universität

More information

The Study of Natural Convection Heat Transfer in a Partially Porous Cavity Based on LBM

The Study of Natural Convection Heat Transfer in a Partially Porous Cavity Based on LBM Send Orders for Reprints to reprints@benthamscience.ae 88 The Open Fuels & Energy Science Journal, 014, 7, 88-93 Open Access The Study of Natural Convection Heat Transfer in a Partially Porous Cavity Based

More information

LATTICE BOLTZMANN MODELLING OF PULSATILE FLOW USING MOMENT BOUNDARY CONDITIONS

LATTICE BOLTZMANN MODELLING OF PULSATILE FLOW USING MOMENT BOUNDARY CONDITIONS 6th European Conference on Computational Mechanics (ECCM 6) 7th European Conference on Computational Fluid Dynamics (ECFD 7) 5 June 28, Glasgow, UK LATTICE BOLTZMANN MODELLING OF PULSATILE FLOW USING MOMENT

More information

Geometry modeling of open-cell foams for efficient fluid flow and heat transfer computations using modified Kelvin cells

Geometry modeling of open-cell foams for efficient fluid flow and heat transfer computations using modified Kelvin cells E. Werzner, M.A.A. Mendes, J. Storm, M. Laurinat, S. Ray, D. Trimis Chair of Gas and Heat Technology Institute of Thermal Engineering Gustav-Zeuner-Str. 7 09596 Freiberg Germany Geometry modeling of open-cell

More information

Assessment of the Accuracy of the Multiple-Relaxation-Time Lattice Boltzmann Method for the Simulation of Circulating Flows

Assessment of the Accuracy of the Multiple-Relaxation-Time Lattice Boltzmann Method for the Simulation of Circulating Flows Mathematical Modelling and Applications 2017; 25): 47-51 http://www.sciencepublishinggroup.com/j/mma doi: 10.11648/j.mma.20170205.11 ISSN: 2575-1786 Print); ISSN: 2575-1794 Online) Assessment of the Accuracy

More information

Analysis and boundary condition of the lattice Boltzmann BGK model with two velocity components

Analysis and boundary condition of the lattice Boltzmann BGK model with two velocity components Analysis and boundary condition of the lattice Boltzmann BGK model with two velocity components Xiaoyi He and Qisu Zou arxiv:comp-gas/9507002v1 22 Jul 1995 Abstract In this paper, we study the two dimensional

More information

FINITE-DIFFERENCE IMPLEMENTATION OF LATTICE BOLTZMANN METHOD FOR USE WITH NON-UNIFORM GRIDS

FINITE-DIFFERENCE IMPLEMENTATION OF LATTICE BOLTZMANN METHOD FOR USE WITH NON-UNIFORM GRIDS 7. ANKARA INTERNATIONAL AEROSPACE CONFERENCE AIAC-2013-143 11-13 September 2013 - METU, Ankara TURKEY FINITE-DIFFERENCE IMPLEMENTATION OF LATTICE BOLTZMANN METHOD FOR USE WITH NON-UNIFORM GRIDS Fatih ÇEVİK

More information

Level Set-based Topology Optimization Method for Viscous Flow Using Lattice Boltzmann Method

Level Set-based Topology Optimization Method for Viscous Flow Using Lattice Boltzmann Method 10 th World Congress on Structural and Multidisciplinary Optimization May 19-24, 2013, Orlando, Florida, USA Level Set-based Topology Optimization Method for Viscous Flow Using Lattice Boltzmann Method

More information

ZFS - Flow Solver AIA NVIDIA Workshop

ZFS - Flow Solver AIA NVIDIA Workshop ZFS - Flow Solver AIA NVIDIA Workshop Andreas Lintermann, Matthias Meinke, Wolfgang Schröder Institute of Aerodynamics and Chair of Fluid Mechanics RWTH Aachen University Outline Softwareproject ZFS (applications

More information

arxiv:comp-gas/ v1 28 Apr 1993

arxiv:comp-gas/ v1 28 Apr 1993 Lattice Boltzmann Thermohydrodynamics arxiv:comp-gas/9304006v1 28 Apr 1993 F. J. Alexander, S. Chen and J. D. Sterling Center for Nonlinear Studies and Theoretical Division Los Alamos National Laboratory

More information

Research on GPU-accelerated algorithm in 3D finite difference neutron diffusion calculation method

Research on GPU-accelerated algorithm in 3D finite difference neutron diffusion calculation method NUCLEAR SCIENCE AND TECHNIQUES 25, 0501 (14) Research on GPU-accelerated algorithm in 3D finite difference neutron diffusion calculation method XU Qi ( 徐琪 ), 1, YU Gang-Lin ( 余纲林 ), 1 WANG Kan ( 王侃 ),

More information

Study on lattice Boltzmann method/ large eddy simulation and its application at high Reynolds number flow

Study on lattice Boltzmann method/ large eddy simulation and its application at high Reynolds number flow Research Article Study on lattice Boltzmann method/ large eddy simulation and its application at high Reynolds number flow Advances in Mechanical Engineering 1 8 Ó The Author(s) 2015 DOI: 10.1177/1687814015573829

More information

Simulation of Rarefied Gas Flow in Slip and Transitional Regimes by the Lattice Boltzmann Method

Simulation of Rarefied Gas Flow in Slip and Transitional Regimes by the Lattice Boltzmann Method www.cfdl.issres.net Vol. 2 (2) June 2010 Simulation of Rarefied Gas Flow in Slip and Transitional Regimes by the Lattice Boltzmann Method N. Azwadi C. Sidik 1C, N.C. Horng 1, M.A. Mussa 2, and S. Abdullah

More information

Designing Correct Fluid Hydrodynamics on A Rectangular Grid using MRT Lattice Boltzmann Approach

Designing Correct Fluid Hydrodynamics on A Rectangular Grid using MRT Lattice Boltzmann Approach Computers & Fluids 00 04 3 Computers & Fluids Designing Correct Fluid Hydrodynamics on A Rectangular Grid using MRT Lattice Boltzmann Approach Yuan Zong a,b, Zhaoli Guo c, Lian-Ping Wang b,c, a State key

More information

Computer simulations of fluid dynamics. Lecture 11 LBM: Algorithm for BGK Maciej Matyka

Computer simulations of fluid dynamics. Lecture 11 LBM: Algorithm for BGK Maciej Matyka Computer simulations of fluid dynamics Lecture 11 LBM: Algorithm for BGK Maciej Matyka https://www.youtube.com/watch? v=vluyp_ydfjc https://youtu.be/cj52zpggka (789 citations) Lecture goal l l Give a complete

More information

Lattice Boltzmann Method

Lattice Boltzmann Method 3 Lattice Boltzmann Method 3.1 Introduction The lattice Boltzmann method is a discrete computational method based upon the lattice gas automata - a simplified, fictitious molecular model. It consists of

More information

Numerical Simulation of Viscous Fingering Phenomenon in Immiscible Displacement of Two Fluids in Porous Media Using Lattice Boltzmann Method

Numerical Simulation of Viscous Fingering Phenomenon in Immiscible Displacement of Two Fluids in Porous Media Using Lattice Boltzmann Method nd Micro and Nano Flows Conference West London, UK, 1- September 009 Numerical Simulation of Viscous Fingering Phenomenon in Immiscible Displacement of Two Fluids in Porous Media Using Lattice Boltzmann

More information

APPRAISAL OF FLOW SIMULATION BY THE LATTICE BOLTZMANN METHOD

APPRAISAL OF FLOW SIMULATION BY THE LATTICE BOLTZMANN METHOD APPRAISAL OF FLOW SIMULATION BY THE LATTICE BOLTZMANN METHOD Guillermo Izquierdo Bouldstridge Imperial College of London Department of Aeronautics Master s Thesis Supervisor: Dr. Joaquim Peiró September

More information

Available online at ScienceDirect. Procedia Engineering 90 (2014 )

Available online at   ScienceDirect. Procedia Engineering 90 (2014 ) Available online at www.sciencedirect.com ScienceDirect Procedia Engineering 9 (214 ) 599 64 1th International Conference on Mechanical Engineering, ICME 213 Validation criteria for DNS of turbulent heat

More information

Available online at ScienceDirect. Procedia Engineering 79 (2014 ) 49 54

Available online at  ScienceDirect. Procedia Engineering 79 (2014 ) 49 54 Available online at www.sciencedirect.com ScienceDirect Procedia Engineering 79 (2014 ) 49 54 37th National Conference on Theoretical and Applied Mechanics (37th NCTAM 2013) & The 1st International Conference

More information

Development of a Parallel, 3D, Lattice Boltzmann Method CFD Solver for Simulation of Turbulent Reactor Flow

Development of a Parallel, 3D, Lattice Boltzmann Method CFD Solver for Simulation of Turbulent Reactor Flow DOE-FIU SCIENCE & TECHNOLOGY WORKFORCE DEVELOPMENT PROGRAM STUDENT SUMMER INTERNSHIP TECHNICAL REPORT June 4, 2012 to August 10, 2012 Development of a Parallel, 3D, Lattice Boltzmann Method CFD Solver

More information

TR A Comparison of the Performance of SaP::GPU and Intel s Math Kernel Library (MKL) for Solving Dense Banded Linear Systems

TR A Comparison of the Performance of SaP::GPU and Intel s Math Kernel Library (MKL) for Solving Dense Banded Linear Systems TR-0-07 A Comparison of the Performance of ::GPU and Intel s Math Kernel Library (MKL) for Solving Dense Banded Linear Systems Ang Li, Omkar Deshmukh, Radu Serban, Dan Negrut May, 0 Abstract ::GPU is a

More information

Study on Non-Uniqueness of Taylor Vortex Flow Changing Inner Cylinder Acceleration Time

Study on Non-Uniqueness of Taylor Vortex Flow Changing Inner Cylinder Acceleration Time World Journal of Mechanics, 2018, 8, 301-310 http://www.scirp.org/journal/wjm ISSN Online: 2160-0503 ISSN Print: 2160-049X Study on Non-Uniqueness of Taylor Vortex Flow Changing Inner Cylinder Acceleration

More information

Explicit algebraic Reynolds stress models for internal flows

Explicit algebraic Reynolds stress models for internal flows 5. Double Circular Arc (DCA) cascade blade flow, problem statement The second test case deals with a DCA compressor cascade, which is considered a severe challenge for the CFD codes, due to the presence

More information

Numerical Simulation Of Pore Fluid Flow And Fine Sediment Infiltration Into The Riverbed

Numerical Simulation Of Pore Fluid Flow And Fine Sediment Infiltration Into The Riverbed City University of New York (CUNY) CUNY Academic Works International Conference on Hydroinformatics 8-1-2014 Numerical Simulation Of Pore Fluid Flow And Fine Sediment Infiltration Into The Riverbed Tobias

More information

Numerical Investigation of Fluid and Thermal Flow in a Differentially Heated Side Enclosure walls at Various Inclination Angles

Numerical Investigation of Fluid and Thermal Flow in a Differentially Heated Side Enclosure walls at Various Inclination Angles Numerical Investigation of Fluid and Thermal Flow in a Differentially Heated Side Enclosure walls at Various Inclination Angles O. A. SHAHRUL Faculty of Mechanical & Manufacturing Engineering Universiti

More information

Parallel Simulations of Self-propelled Microorganisms

Parallel Simulations of Self-propelled Microorganisms Parallel Simulations of Self-propelled Microorganisms K. Pickl a,b M. Hofmann c T. Preclik a H. Köstler a A.-S. Smith b,d U. Rüde a,b ParCo 2013, Munich a Lehrstuhl für Informatik 10 (Systemsimulation),

More information

11 Parallel programming models

11 Parallel programming models 237 // Program Design 10.3 Assessing parallel programs 11 Parallel programming models Many different models for expressing parallelism in programming languages Actor model Erlang Scala Coordination languages

More information

A one-point boundary condition for the lattice Boltzmann method

A one-point boundary condition for the lattice Boltzmann method manuscript A one-point boundary condition for the lattice Boltzmann method Michael Junk and Zhaoxia Yang FB Mathematik und Statistik, Universität Konstanz, Fach D194, 78457 Konstanz, Germany (Dated: September

More information

Lattice Boltzmann Simulation of One Particle Migrating in a Pulsating Flow in Microvessel

Lattice Boltzmann Simulation of One Particle Migrating in a Pulsating Flow in Microvessel Commun. Theor. Phys. 56 (2011) 756 760 Vol. 56, No. 4, October 15, 2011 Lattice Boltzmann Simulation of One Particle Migrating in a Pulsating Flow in Microvessel QIU Bing ( ), 1, TAN Hui-Li ( Û), 2 and

More information

The behaviour of high Reynolds flows in a driven cavity

The behaviour of high Reynolds flows in a driven cavity The behaviour of high Reynolds flows in a driven cavity Charles-Henri BRUNEAU and Mazen SAAD Mathématiques Appliquées de Bordeaux, Université Bordeaux 1 CNRS UMR 5466, INRIA team MC 351 cours de la Libération,

More information

Performance Evaluation of Scientific Applications on POWER8

Performance Evaluation of Scientific Applications on POWER8 Performance Evaluation of Scientific Applications on POWER8 2014 Nov 16 Andrew V. Adinetz 1, Paul F. Baumeister 1, Hans Böttiger 3, Thorsten Hater 1, Thilo Maurer 3, Dirk Pleiter 1, Wolfram Schenck 4,

More information

Direct Self-Consistent Field Computations on GPU Clusters

Direct Self-Consistent Field Computations on GPU Clusters Direct Self-Consistent Field Computations on GPU Clusters Guochun Shi, Volodymyr Kindratenko National Center for Supercomputing Applications University of Illinois at UrbanaChampaign Ivan Ufimtsev, Todd

More information

Application of the Lattice-Boltzmann method in flow acoustics

Application of the Lattice-Boltzmann method in flow acoustics Application of the Lattice-Boltzmann method in flow acoustics Andreas Wilde Fraunhofer Institut für Integrierte Schaltungen, Außenstelle EAS Zeunerstr. 38, 01069 Dresden Abstract The Lattice-Boltzmann

More information

Numerical Investigation on Shear Driven Cavity Flow by the Constrained Interpolated Profile Lattice Boltzmann Method

Numerical Investigation on Shear Driven Cavity Flow by the Constrained Interpolated Profile Lattice Boltzmann Method Numerical Investigation on Shear Driven Cavity Flow by the Constrained Interpolated Profile Lattice Boltzmann Method *C. S. NOR AZWADI, M. H. Al-MOLA and S. AGUS Department of Thermo-fluid Universiti Teknologi

More information

GPU acceleration of Newton s method for large systems of polynomial equations in double double and quad double arithmetic

GPU acceleration of Newton s method for large systems of polynomial equations in double double and quad double arithmetic GPU acceleration of Newton s method for large systems of polynomial equations in double double and quad double arithmetic Jan Verschelde joint work with Xiangcheng Yu University of Illinois at Chicago

More information

Advantages of a Finite Extensible Nonlinear Elastic Potential in Lattice Boltzmann Simulations

Advantages of a Finite Extensible Nonlinear Elastic Potential in Lattice Boltzmann Simulations The Hilltop Review Volume 7 Issue 1 Winter 2014 Article 10 December 2014 Advantages of a Finite Extensible Nonlinear Elastic Potential in Lattice Boltzmann Simulations Tai-Hsien Wu Western Michigan University

More information

V (r,t) = i ˆ u( x, y,z,t) + ˆ j v( x, y,z,t) + k ˆ w( x, y, z,t)

V (r,t) = i ˆ u( x, y,z,t) + ˆ j v( x, y,z,t) + k ˆ w( x, y, z,t) IV. DIFFERENTIAL RELATIONS FOR A FLUID PARTICLE This chapter presents the development and application of the basic differential equations of fluid motion. Simplifications in the general equations and common

More information

Simulation of T-junction using LBM and VOF ENERGY 224 Final Project Yifan Wang,

Simulation of T-junction using LBM and VOF ENERGY 224 Final Project Yifan Wang, Simulation of T-junction using LBM and VOF ENERGY 224 Final Project Yifan Wang, yfwang09@stanford.edu 1. Problem setting In this project, we present a benchmark simulation for segmented flows, which contain

More information

Gas Turbine Technologies Torino (Italy) 26 January 2006

Gas Turbine Technologies Torino (Italy) 26 January 2006 Pore Scale Mesoscopic Modeling of Reactive Mixtures in the Porous Media for SOFC Application: Physical Model, Numerical Code Development and Preliminary Validation Michele CALI, Pietro ASINARI Dipartimento

More information

The Analysis of Internal Flow Field in Oil-Gas Separator

The Analysis of Internal Flow Field in Oil-Gas Separator Available online at www.sciencedirect.com Procedia Engineering 15 (011) 4337 4341 Advanced in Control Engineering and Information Science The Analysis of Internal Flow Field in Oil-Gas Separator Wang Zhongyi

More information

68 Guo Wei-Bin et al Vol. 12 presented, and are thoroughly compared with other numerical data with respect to the Strouhal number, lift and drag coeff

68 Guo Wei-Bin et al Vol. 12 presented, and are thoroughly compared with other numerical data with respect to the Strouhal number, lift and drag coeff Vol 12 No 1, January 2003 cfl 2003 Chin. Phys. Soc. 1009-1963/2003/12(01)/0067-08 Chinese Physics and IOP Publishing Ltd Lattice-BGK simulation of a two-dimensional channel flow around a square cylinder

More information

Computation of Incompressible Flows: SIMPLE and related Algorithms

Computation of Incompressible Flows: SIMPLE and related Algorithms Computation of Incompressible Flows: SIMPLE and related Algorithms Milovan Perić CoMeT Continuum Mechanics Technologies GmbH milovan@continuummechanicstechnologies.de SIMPLE-Algorithm I - - - Consider

More information

Fluid Flow and Heat Transfer Characteristics in Helical Tubes Cooperating with Spiral Corrugation

Fluid Flow and Heat Transfer Characteristics in Helical Tubes Cooperating with Spiral Corrugation Available online at www.sciencedirect.com Energy Procedia 17 (2012 ) 791 800 2012 International Conference on Future Electrical Power and Energy Systems Fluid Flow and Heat Transfer Characteristics in

More information

SEMICLASSICAL LATTICE BOLTZMANN EQUATION HYDRODYNAMICS

SEMICLASSICAL LATTICE BOLTZMANN EQUATION HYDRODYNAMICS The Seventh Nobeyama Workshop on CFD: To the Memory of Prof. Kuwahara Sanjo Kaikan, the University of Tokyo, Japan, September. 23-24, 2009 SEMICLASSICAL LATTICE BOLTZMANN EQUATION HYDRODYNAMICS Jaw-Yen

More information

Logo. A Massively-Parallel Multicore Acceleration of a Point Contact Solid Mechanics Simulation DRAFT

Logo. A Massively-Parallel Multicore Acceleration of a Point Contact Solid Mechanics Simulation DRAFT Paper 1 Logo Civil-Comp Press, 2017 Proceedings of the Fifth International Conference on Parallel, Distributed, Grid and Cloud Computing for Engineering, P. Iványi, B.H.V Topping and G. Várady (Editors)

More information

Computers and Mathematics with Applications

Computers and Mathematics with Applications Computers and Mathematics with Applications 59 (2010 2194 2199 Contents lists available at ScienceDirect Computers and Mathematics with Applications journal homepage: www.elsevier.com/locate/camwa Toward

More information

Available online at ScienceDirect. Procedia Engineering 90 (2014 )

Available online at   ScienceDirect. Procedia Engineering 90 (2014 ) Available online at www.sciencedirect.com ScienceDirect Procedia Engineering 9 (4 ) 37 376 th International Conference on Mechanical Engineering, ICME 3 Free Convective Heat Transfer Flow of Temperature

More information

PREDICTION OF INTRINSIC PERMEABILITIES WITH LATTICE BOLTZMANN METHOD

PREDICTION OF INTRINSIC PERMEABILITIES WITH LATTICE BOLTZMANN METHOD PREDICTION OF INTRINSIC PERMEABILITIES WITH LATTICE BOLTZMANN METHOD Luís Orlando Emerich dos Santos emerich@lmpt.ufsc.br Carlos Enrique Pico Ortiz capico@lmpt.ufsc.br Henrique Cesar de Gaspari henrique@lmpt.ufsc.br

More information

Chapter 9: Differential Analysis

Chapter 9: Differential Analysis 9-1 Introduction 9-2 Conservation of Mass 9-3 The Stream Function 9-4 Conservation of Linear Momentum 9-5 Navier Stokes Equation 9-6 Differential Analysis Problems Recall 9-1 Introduction (1) Chap 5: Control

More information

SIMULATION OF MIXED CONVECTIVE HEAT TRANSFER USING LATTICE BOLTZMANN METHOD

SIMULATION OF MIXED CONVECTIVE HEAT TRANSFER USING LATTICE BOLTZMANN METHOD International Journal of Automotive and Mechanical Engineering (IJAME) ISSN: 2229-8649 (Print); ISSN: 2180-1606 (Online); Volume 2, pp. 130-143, July-December 2010 Universiti Malaysia Pahang DOI: http://dx.doi.org/10.15282/ijame.2.2010.3.0011

More information

Available online at ScienceDirect. Procedia Technology 23 (2016 ) 42 50

Available online at   ScienceDirect. Procedia Technology 23 (2016 ) 42 50 Available online at www.sciencedirect.com ScienceDirect Procedia Technology 23 (216 ) 42 5 3rd International Conference on Innovations in Automation and Mechatronics Engineering, ICIAME 216 On the stiffness

More information

Available online at ScienceDirect. Energy Procedia 78 (2015 ) th International Building Physics Conference, IBPC 2015

Available online at   ScienceDirect. Energy Procedia 78 (2015 ) th International Building Physics Conference, IBPC 2015 Available online at www.sciencedirect.com ScienceDirect Energy Procedia 78 (2015 ) 537 542 6th International Building Physics Conference, IBPC 2015 Characterization of fibrous insulating materials in their

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

Using OpenMP on a Hydrodynamic Lattice-Boltzmann Code

Using OpenMP on a Hydrodynamic Lattice-Boltzmann Code Using OpenMP on a Hydrodynamic Lattice-Boltzmann Code Gino Bella Nicola Rossi Salvatore Filippone Stefano Ubertini Università degli Studi di Roma Tor Vergata 1 Introduction The motion of a uid ow is governed

More information

NOVEL FINITE DIFFERENCE SCHEME FOR THE NUMERICAL SOLUTION OF TWO-DIMENSIONAL INCOMPRESSIBLE NAVIER-STOKES EQUATIONS

NOVEL FINITE DIFFERENCE SCHEME FOR THE NUMERICAL SOLUTION OF TWO-DIMENSIONAL INCOMPRESSIBLE NAVIER-STOKES EQUATIONS INTERNATIONAL JOURNAL OF NUMERICAL ANALYSIS AND MODELING Volume 7 Number Pages 3 39 c Institute for Scientific Computing and Information NOVEL FINITE DIFFERENCE SCHEME FOR THE NUMERICAL SOLUTION OF TWO-DIMENSIONAL

More information

Numerical Simulation of Flows about a Stationary and a Free-Falling Cylinder Using Immersed Boundary-Finite Difference Lattice Boltzmann Method

Numerical Simulation of Flows about a Stationary and a Free-Falling Cylinder Using Immersed Boundary-Finite Difference Lattice Boltzmann Method Numerical Simulation of Flows about a Stationary and a Free-Falling Cylinder Using Immersed Boundary-Finite Difference Lattice Boltzmann Method Roberto Rojas 1*, Kosuke Hayashi 1, Takeshi Seta and Akio

More information

arxiv: v1 [physics.comp-ph] 30 Oct 2017

arxiv: v1 [physics.comp-ph] 30 Oct 2017 An efficient GPU algorithm for tetrahedron-based Brillouin-zone integration Daniel Guterding 1, and Harald O. Jeschke 1 Lucht Probst Associates, Große Gallusstraße 9, 011 Frankfurt am Main, Germany, European

More information

Chapter 9: Differential Analysis of Fluid Flow

Chapter 9: Differential Analysis of Fluid Flow of Fluid Flow Objectives 1. Understand how the differential equations of mass and momentum conservation are derived. 2. Calculate the stream function and pressure field, and plot streamlines for a known

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

Corresponding Author (Received October 22, 2012; accepted May 1, 2013) ABSTRACT

Corresponding Author   (Received October 22, 2012; accepted May 1, 2013) ABSTRACT Journal of Applied Fluid Mechanics Vol. 7 No. 1 pp. 89-102 2014. Available online at www.jafmonline.net ISSN 1735-3572 EISSN 1735-3645. A Multi-Relaxation-Time Lattice Boltzmann Method on Non- Uniform

More information

A Generalized Lattice Boltzmann Method for Three-Dimensional Incompressible Fluid Flow Simulation

A Generalized Lattice Boltzmann Method for Three-Dimensional Incompressible Fluid Flow Simulation Journal of Applied Fluid Mechanics Vol. 2 No. 1 pp. 71-96 2009. Available online at www.jafmonline.net ISSN 1735-3645. A Generalized Lattice Boltzmann Method for Three-Dimensional Incompressible Fluid

More information