Phys 113 Final Project

Size: px
Start display at page:

Download "Phys 113 Final Project"

Transcription

1 Phys 113 Final Project LBM model for capillary fluid modelling Andrey Sushko Introduction Lattice Boltzmann Method (LMB) models have recently emerged as a highly effective means of modelling complex fluid mechanics problems, owing to its ability to handle complex boundary conditions, arbitrary local and global forces, and systems with multiphase flows. In the paper, we discuss the basic implementation of an LBM model from a physical and computational standpoint, demonstrate various capabilities of the resulting software, and evaluate the effectiveness of the model under various conditions. Physical foundations Fundamentally, LBM modelling relies on a representation of the fluid as a collection of fractious particles traveling with set velocities along lattice links and colliding at lattice sites. A common implementation in 2 dimensions is the D2Q9 lattice shown here. There are 9 represented velocities (including stationary) with particles located at the centre streaming to the lattice points shown after one time step. If the particles are allowed to stream without collisions, the quantity of fluid with velocity at will obey: located In order to model the interactions of particle flows within the fluid, we introduce a collision operator and set Taking the limit for small increments of time, we see that and, hence, Although difficult to solve, is approximated numerically using a simplified operator introduced by Bhatnagar, Gross, Krook, and Welander (the BGKW approximation) as follows:

2 Where is the collision frequency and is the local equilibrium distribution function. While the equilibrium distribution can be modified to account for any number of forces, we will rely primarily on the normalized Maxwell distribution. Recognizing that we need only calculate ( for a finite number of flow velocities site ), we write the distribution as ) and (due to the finite number of lattice links from each lattice where is the macroscopic fluid velocity and is the local fluid density given by. Taylor expanding gives ( ) for appropriate constant weighting factors streaming velocities. which are specific to the configuration of possible Making this approximation we get an easily computable expression for the quantity of fluid streaming along each lattice link: [ ] In order to incorporate arbitrary body forces on the fluid, we can modify the macroscopic fluid velocity formula or, equivalently add an extra term to the formula for as follows [ ] Where is the sound speed given by and is the applied force. With the above formula we can very easily add gravity to the simulation by creating a constant downward pointing force vector or, more interestingly, simulate cohesion between particles of the fluid by setting Where is the interaction strength (positive or negative), are a set of lattice-specific weighting factors similar to, and the operator is usually of the form For constants and determined by the specifics of the system being analyzed.

3 Implementation The code required to implement an LBM model as described above can be broken down in to the following steps: For each time-step { Calculate and update in place at each point Stream to new locations Handle boundary conditions Update density, flow velocity, and force vectors to permit us to update The actual code used can be found in the appendix. Boundaries Boundary conditions for the simulation can be handled in a variety of ways. One of the simplest boundary conditions is the bounceback condition in which incoming flows have the normal component of flow velocity inverted i.e., any fluid with velocity directed towards the boundary will be updated to have velocity directed away. This straightforward method can also be modified to simulate a sliding boundary by, for instance, subtracting some fluid from one diagonally incident flow and adding it to the An illustration of the simple bounce-back boundary condition at one node. other diagonally incident flow thus adding some momentum to the system. Using this condition on one boundary is a very easy way to create a lid-driven-cavity system. Since the fluid is treated as collections of particles, any number of reasonable boundary conditions may be implemented. Copying the distribution one lattice cell away from the boundary to the cells along the boundary, for instance, generates adiabatic boundaries. It is also very simple to inject or remove fluid from the system by just adding to or subtracting from at any given point. This may be useful in cases where we want to simulate an open boundary by simply deleting fluid streaming across it. Similarly, one can create periodic systems simply by adding outgoing flows from one boundary to incoming flows from another.

4 Test cases A good test of the various components of the fluid dynamics code is the lid-driven cavity system. In this system, a stationary fluid of uniform density is placed in a box with bounce-back boundaries on three walls and a modified sliding-wall bounce-back boundary condition on the fourth (in this case, the right edge). The lid speed is set so as to give a Reynolds number of 100. Macroscopic flow velocities for the fluid are shown soon after initialising the system and after the flow approximately equilibrates at a much later time. After 5,000 time-steps:

5 After 100,000 time-steps:

6 Plotting the vertical velocity through a horizontal line bisecting the box allows us to compare the results of this model against existing data. The plot below shows the velocity profile after 1000, 10,000, and 100,000 time-steps. As time increases the solution appears to approach the reported values. It is difficult to determine whether exact agreement will be achieved after enough time owing to the rather high runtime of such a simulation 1k 10k 100k Discussion By design, it is clear that the simulation has a finite maximum lattice speed. In D2Q9 the fluid streams no more than one lattice cell per time-step in each dimension. Hence, it is impossible for any signals to travel faster than i.e., the speed of sound in the simulated fluid. The formula for can, in fact, produce negative solutions if the macroscopic fluid velocity becomes close to. Since the model will propagate any local results across the lattice, an error at just one lattice cell can destabilise and often completely invalidate the entire simulation. In general, therefore, it is safest to keep flow velocities and external force corrections below at all points to avoid erratic results.

7 Machine precision We can use conservation of mass to estimate the magnitude of error incurred by having a finite machine precision. When dealing with, in the lid-driven cavity scenario above, and using C++ double precision variables for all relevant quantities, the total mass change was found to be less than per time-step. While this is fairly reasonable, simulations that require, for instance, substantially lower fluid densities may be best computed in non-dimensional form. Parallelisation Since LBM is an explicit method, the computations can be easily parallelised to improve runtime. In fact, the collision and streaming steps can be parallelised with essentially no non-parallelisable overhead and the boundary conditions, in general, require be computed in parallel. calculations and, if need be, can also Conclusion LBM modelling is a very capable tool due to the variety of complex interactions that may be studied using the method. It is very well suited to solving complex time-dependent systems such as the behaviour of capillary fluids. At the same time, the computational costs make it somewhat prohibitive to implement on a large lattice unless parallel computing resources are available. Similarly, systems that reach equilibrium slowly but still contain moderately high equilibrium velocities, such as the lid driven cavity, can end up becoming very costly to compute. Various methods exist to improve computational time such as the use of non-uniform lattices which sacrifice precision in regions where it is not required, or variable time-stepping for systems that settle down to lower velocity over time. References Junfeng Zhang, Lattice Boltzmann method for microfluidics: models and applications: Mohamad, A. A., Lattice Boltzmann Method: 5.pdf?auth66= _d10a02de05c8febc7f0fd0dffc409a6b&ext=.pdf Sukop, Michael C. and Or, Dani Lattice Boltzmann method for modeling liquid-vapor interface configurations in porous media CFD Online Wiki: Validation and test cases Lallemand, Pierre and Luo, Li-Shi Theory of the Lattice Boltzmann Method: Dispersion, Dissipation, Isotropy, Galilean Invariance, and Stability

8 Appendix Full code used for the simulation. Note: for conciseness the code for graphical output has been omitted here. void LBMrun(int n, int m, int time, int interval){ //D2Q9 Code //====================================================== // LBM -Advection-Diffusion D2Q9 //int n=100, m=100; double f[9][n][m], u[n][m], v[n][m], XForce[n][m], YForce[n][m]; double feq[9]; double rho[n][m]; double x[n], y[m]; double w[9] = {4./9, 1./9, 1./9, 1./9, 1./9, 1./36, 1./36, 1./36, 1./36; double g[9] = {0, 2., 2., 2., 2., 1., 1., 1., 1.; double cx[9] = {0, 1, 0, -1, 0, 1, -1, -1, 1; double cy[9] = {0, 0, 1, 0, -1, 1, 1, -1, -1; double G = 0.0; double Vdamp = 0.0; //Expt with damping macroscopic vel for stability double grav = 0.0; int i,j,k; double dt = 1.0; double dx = 1.0; double dy = dx; x[0] = 0.0; y[0] = 0.0; for (i = 1; i < n; i++){ x[i] = x[i-1] + dx; for (i = 1; i < m; i++){ y[i] = y[i-1] + dy; double u0 = 0.0; double alpha = 0.01; double Re = u0 * m/alpha; cout << Re << endl; double ck = dx/dt; double csq = ck*ck; double omega = 1.0/(2.*alpha/(csq*dt)+0.5); cout << omega <<endl; double rho0 = 5; int mstep = time; u[i][j] = 0.0; v[i][j] = 0.0; XForce[i][j] = 0.0; YForce[i][j] = 0.0; rho[i][j] = rho0; for (k = 0; k < 9; k++){ f[k][i][j] = w[k]*rho0;

9 for (int i = 0; i < n; i++){ u[i][m-1] = u0; for (int kk = 1; kk < mstep; kk++){ //collision double t1 = u[i][j]*u[i][j] + v[i][j]*v[i][j]; for (k = 0; k < 9; k++){ double t2 = u[i][j]*cx[k] + v[i][j]*cy[k]; double Fk = XForce[i][j]*cx[k] + YForce[i][j]*cy[k]; feq[k] = w[k]*rho[i][j]*( *t2/csq + 4.5*t2*t2/csq/csq - 1.5*t1/csq); f[k][i][j] = omega*feq[k] + (1.- omega)*f[k][i][j] + w[k]*dt*fk/(csq); //streaming for (int j = 0; j < m; j++){ for (int i = n-1; i > 0; i--){ f[1][i][j] = f[1][i-1][j]; for (int i = 0; i < n-1; i++){ f[3][i][j] = f[3][i+1][j]; for (int j = m-1; j > 0; j--){ for (int i = 0; i < n; i++){ f[2][i][j] = f[2][i][j-1]; for (int i = n-1; i > 0; i--){ f[5][i][j] = f[5][i-1][j-1]; for (int i = 0; i < n-1; i++){ f[6][i][j] = f[6][i+1][j-1]; for (int j = 0; j < m-1; j++){ for (int i = 0; i < n; i++){ f[4][i][j] = f[4][i][j+1]; for (int i = 0; i < n-1; i++){ f[7][i][j] = f[7][i+1][j+1]; for (int i = n-1; i > 0; i--){ f[8][i][j] = f[8][i-1][j+1]; // Bounce back boundary conditions f[1][0][j] = f[3][0][j];

10 f[5][0][j] = f[7][0][j]; f[8][0][j] = f[6][0][j]; f[3][n-1][j] = f[1][n-1][j]; f[7][n-1][j] = f[5][n-1][j]; f[6][n-1][j] = f[8][n-1][j]; f[2][i][0] = f[4][i][0]; f[5][i][0] = f[7][i][0]; f[6][i][0] = f[8][i][0]; for (i = 1; i < n-1; i++){ double rhon = f[0][i][m-1] + f[1][i][m-1] + f[3][i][m-1] + 2*(f[2][i][m-1] + f[6][i][m-1] + f[5][i][m-1]); f[4][i][m-1] = f[2][i][m-1]; f[7][i][m-1] = f[5][i][m-1] - rhon*u0/6; f[8][i][m-1] = f[6][i][m-1] + rhon*u0/6; double netdens = 0; for (int i = 0; i < n; i++){ for (int j = 0; j < m; j++){ double sum = 0; for (int k = 0; k < 9; k++){ sum += f[k][i][j]; rho[i][j] = sum; netdens += sum; cout << netdens << endl; rho[i][m-1] = f[0][i][m-1] + f[1][i][m-1] + f[3][i][m-1] + 2*(f[2][i][m-1] + f[6][i][m-1] + f[5][i][m-1]); for (int i = 0; i < n; i++){ for (int j = 0; j < m; j++){ if(rho[i][j] > 0){ double usum = 0; double vsum = 0; for (int k = 0; k < 9; k++){ usum += f[k][i][j]*cx[k]; vsum += f[k][i][j]*cy[k]; u[i][j] = usum/rho[i][j]; v[i][j] = vsum/rho[i][j]; else { u[i][j] = v[i][j] = 0; if(rho[i][j] > 0){ double fxsum = 0; double fysum = 0;

11 for (k = 0; k < 9; k++){ int i2 = i+(int)cx[k]; int j2 = j+(int)cy[k]; if(i2 > 0 && i2 <n && j2 > 0 && j2 < m){ fxsum += G*Psi(rho[i][j])*g[k]*Psi(rho[i+(int)cx[k]][j+(int)cy[k]])*cx[k]; fysum += G*Psi(rho[i][j])*g[k]*Psi(rho[i+(int)cx[k]][j+(int)cy[k]])*cy[k]; XForce[i][j] = (fxsum + grav - Vdamp*u[i][j]) * rho[i][j]; YForce[i][j] = (fysum - Vdamp*v[i][j]) * rho[i][j]; //u[i][j] += XForce[i][j]/rho[i][j]/omega; //v[i][j] += YForce[i][j]/rho[i][j]/omega; //alternatice method of implementing force double netke = 0; double netpe = 0; netke += 0.5*rho[i][j]*(u[i][j]*u[i][j] + v[i][j]*v[i][j]); netpe += rho[i][j]*(n-i)*grav; if(kk%interval == 0){ cout << kk << endl; cout << netdens << endl; cout << netpe << ", " << netke << ", " << netpe+netke <<endl; double dens = (rho[i][j] > 0? rho[i][j] : 0); display.drawcellat(i, j, dens, u[i][j], v[i][j]); for (i = 3; i < n; i+=5){ for (j = 3; j < m; j+=5){ display.drawcellat(i, j, -1., u[i][j], v[i][j]); ofstream outfile; outfile.open("lbmout.csv"); for (int j = 0; j < m; j++){ outfile << u[50][j] << endl; /* Other BCs // Left boundary condition, the temperature is given, tw

12 //f[1][0][j] = w[1]*tw + w[3]*tw - f[3][0][j]; //f[5][0][j] = w[5]*tw + w[7]*tw - f[7][0][j]; //f[8][0][j] = w[8]*tw + w[6]*tw - f[6][0][j]; f[8][0][j] = -f[6][0][j]; f[1][0][j] = -f[3][0][j]; f[5][0][j] = -f[7][0][j]; f[4][0][j] = -f[2][0][j]; f[0][0][j] = 0.0; // Right hand boundary condition, T=0. f[6][n-1][j] = -f[8][n-1][j]; f[3][n-1][j] = -f[1][n-1][j]; f[7][n-1][j] = -f[5][n-1][j]; f[2][n-1][j] = -f[4][n-1][j]; f[0][n-1][j] = 0.0; // Top boundary conditions, T=0.0 f[8][i][m-1] = -f[6][i][m-1]; f[7][i][m-1] = -f[5][i][m-1]; f[4][i][m-1] = -f[2][i][m-1]; f[1][i][m-1] = -f[3][i][m-1]; f[0][i][m-1] = 0.0; // Bottom boundary conditions, Adiabatic // f(1,i,0)=f(1,i,1) // f(2,i,0)=f(2,i,1) // f(3,i,0)=f(3,i,1) // f(4,i,0)=f(4,i,1) // f(5,i,0)=f(5,i,1) // f(6,i,0)=f(6,i,1) // f(7,i,0)=f(7,i,1) // f(8,i,0)=f(8,i,1) // T=0.0 f[2][i][0] = -f[4][i][0]; f[6][i][0] = -f[8][i][0]; f[5][i][0] = -f[7][i][0]; f[1][i][0] = -f[3][i][0]; f[0][i][0] = 0.0; */ /*/ Periodic boundary conditions f[1][0][j] = f[1][n-1][j]; f[5][0][j] = f[5][n-1][j]; f[8][0][j] = f[8][n-1][j]; f[3][n-1][j] = f[3][0][j]; f[7][n-1][j] = f[7][0][j]; f[6][n-1][j] = f[6][0][j]; f[2][i][0] = f[2][i][m-1]; f[5][i][0] = f[5][i][m-1]; f[6][i][0] = f[6][i][m-1];

13 */ f[4][i][m-1] = f[4][i][0]; f[7][i][m-1] = f[7][i][0]; f[8][i][m-1] = f[8][i][0]; static double Psi(double rho){ return 4*exp(-rho/200);

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

(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

Simulation of Liquid-Gas-Solid Flows with the Lattice Boltzmann Method

Simulation of Liquid-Gas-Solid Flows with the Lattice Boltzmann Method Simulation of Liquid-Gas-Solid Flows with the Lattice Boltzmann Method June 21, 2011 Introduction Free Surface LBM Liquid-Gas-Solid Flows Parallel Computing Examples and More References Fig. Simulation

More information

LATTICE-BOLTZMANN AND COMPUTATIONAL FLUID DYNAMICS

LATTICE-BOLTZMANN AND COMPUTATIONAL FLUID DYNAMICS LATTICE-BOLTZMANN AND COMPUTATIONAL FLUID DYNAMICS NAVIER-STOKES EQUATIONS u t + u u + 1 ρ p = Ԧg + ν u u=0 WHAT IS COMPUTATIONAL FLUID DYNAMICS? Branch of Fluid Dynamics which uses computer power to approximate

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

Webinar #3 Lattice Boltzmann method for CompBioMed (incl. Palabos)

Webinar #3 Lattice Boltzmann method for CompBioMed (incl. Palabos) Webinar series A Centre of Excellence in Computational Biomedicine Webinar #3 Lattice Boltzmann method for CompBioMed (incl. Palabos) 19 March 2018 The webinar will start at 12pm CET / 11am GMT Dr Jonas

More information

Adarsh Krishnamurthy (cs184-bb) Bela Stepanova (cs184-bs)

Adarsh Krishnamurthy (cs184-bb) Bela Stepanova (cs184-bs) OBJECTIVE FLUID SIMULATIONS Adarsh Krishnamurthy (cs184-bb) Bela Stepanova (cs184-bs) The basic objective of the project is the implementation of the paper Stable Fluids (Jos Stam, SIGGRAPH 99). The final

More information

Homogenization and numerical Upscaling. Unsaturated flow and two-phase flow

Homogenization and numerical Upscaling. Unsaturated flow and two-phase flow Homogenization and numerical Upscaling Unsaturated flow and two-phase flow Insa Neuweiler Institute of Hydromechanics, University of Stuttgart Outline Block 1: Introduction and Repetition Homogenization

More information

CUDA. Fluid simulation Lattice Boltzmann Models Cellular Automata

CUDA. Fluid simulation Lattice Boltzmann Models Cellular Automata CUDA Fluid simulation Lattice Boltzmann Models Cellular Automata Please excuse my layout of slides for the remaining part of the talk! Fluid Simulation Navier Stokes equations for incompressible fluids

More information

FOURTH ORDER COMPACT FORMULATION OF STEADY NAVIER-STOKES EQUATIONS ON NON-UNIFORM GRIDS

FOURTH ORDER COMPACT FORMULATION OF STEADY NAVIER-STOKES EQUATIONS ON NON-UNIFORM GRIDS International Journal of Mechanical Engineering and Technology (IJMET Volume 9 Issue 10 October 2018 pp. 179 189 Article ID: IJMET_09_10_11 Available online at http://www.iaeme.com/ijmet/issues.asp?jtypeijmet&vtype9&itype10

More information

Preliminary Spray Cooling Simulations Using a Full-Cone Water Spray

Preliminary Spray Cooling Simulations Using a Full-Cone Water Spray 39th Dayton-Cincinnati Aerospace Sciences Symposium Preliminary Spray Cooling Simulations Using a Full-Cone Water Spray Murat Dinc Prof. Donald D. Gray (advisor), Prof. John M. Kuhlman, Nicholas L. Hillen,

More information

Real-time Thermal Flow Predictions for Data Centers

Real-time Thermal Flow Predictions for Data Centers Real-time Thermal Flow Predictions for Data Centers Using the Lattice Boltzmann Method on Graphics Processing Units for Predicting Thermal Flow in Data Centers Johannes Sjölund Computer Science and Engineering,

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

Parallel Direct Simulation Monte Carlo Computation Using CUDA on GPUs

Parallel Direct Simulation Monte Carlo Computation Using CUDA on GPUs Parallel Direct Simulation Monte Carlo Computation Using CUDA on GPUs C.-C. Su a, C.-W. Hsieh b, M. R. Smith b, M. C. Jermy c and J.-S. Wu a a Department of Mechanical Engineering, National Chiao Tung

More information

The Jello Cube Assignment 1, CSCI 520. Jernej Barbic, USC

The Jello Cube Assignment 1, CSCI 520. Jernej Barbic, USC The Jello Cube Assignment 1, CSCI 520 Jernej Barbic, USC 1 The jello cube Undeformed cube Deformed cube The jello cube is elastic, Can be bent, stretched, squeezed,, Without external forces, it eventually

More information

Technical report: How to implement your DdQq dynamics with only q variables per node (instead of 2q)

Technical report: How to implement your DdQq dynamics with only q variables per node (instead of 2q) Technical report: How to implement your DdQq dynamics with only q variables per node (instead of 2q) Jonas Latt Tufts University Medford, USA jonas.latt@gmail.com June 2007 1 Overview Naive implementations

More information

PHYS 202 Notes, Week 8

PHYS 202 Notes, Week 8 PHYS 202 Notes, Week 8 Greg Christian March 8 & 10, 2016 Last updated: 03/10/2016 at 12:30:44 This week we learn about electromagnetic waves and optics. Electromagnetic Waves So far, we ve learned about

More information

Introduction to Computational Fluid Dynamics Mech 122 D. Fabris, K. Lynch, D. Rich

Introduction to Computational Fluid Dynamics Mech 122 D. Fabris, K. Lynch, D. Rich Introduction to Computational Fluid Dynamics Mech 122 D. Fabris, K. Lynch, D. Rich 1 Computational Fluid dynamics Computational fluid dynamics (CFD) is the analysis of systems involving fluid flow, heat

More information

APPROXIMATING THREE-DIMENSIONAL FLUID FLOW IN A MICROFLUIDIC DEVICE WITH A TWO-DIMENSIONAL, DEPTH-AVERAGED LATTICE BOLTZMANN METHOD ARTIN LALEIAN

APPROXIMATING THREE-DIMENSIONAL FLUID FLOW IN A MICROFLUIDIC DEVICE WITH A TWO-DIMENSIONAL, DEPTH-AVERAGED LATTICE BOLTZMANN METHOD ARTIN LALEIAN APPROXIMATING THREE-DIMENSIONAL FLUID FLOW IN A MICROFLUIDIC DEVICE WITH A TWO-DIMENSIONAL, DEPTH-AVERAGED LATTICE BOLTZMANN METHOD BY ARTIN LALEIAN THESIS Submitted in partial fulfillment of the requirements

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

Lattice Boltzmann Method: A New Alternative for Loss Estimation Juan C. Díaz Cruz* a, Sergio E. Rodríguez a, Sergio A. Ordóñez b, Felipe Muñoz a a

Lattice Boltzmann Method: A New Alternative for Loss Estimation Juan C. Díaz Cruz* a, Sergio E. Rodríguez a, Sergio A. Ordóñez b, Felipe Muñoz a a 799 VOL. 31, 2013 CHEMICAL ENGINEERING TRANSACTIONS A publication of The Italian Association of Chemical Engineering Online at: www.aidic.it/cet Guest Editors: Eddy De Rademaeker, Bruno Fabiano, Simberto

More information

COMPUTATIONAL FLUID DYNAMICS ANALYSIS OF ORIFICE PLATE METERING SITUATIONS UNDER ABNORMAL CONFIGURATIONS

COMPUTATIONAL FLUID DYNAMICS ANALYSIS OF ORIFICE PLATE METERING SITUATIONS UNDER ABNORMAL CONFIGURATIONS COMPUTATIONAL FLUID DYNAMICS ANALYSIS OF ORIFICE PLATE METERING SITUATIONS UNDER ABNORMAL CONFIGURATIONS Dr W. Malalasekera Version 3.0 August 2013 1 COMPUTATIONAL FLUID DYNAMICS ANALYSIS OF ORIFICE PLATE

More information

CE 530 Molecular Simulation

CE 530 Molecular Simulation 1 CE 530 Molecular Simulation Lecture 3 Common Elements of a Molecular Simulation David A. Kofke Department of Chemical Engineering SUNY Buffalo kofke@eng.buffalo.edu 2 Boundary Conditions Impractical

More information

Fluid Simulation. [Thürey 10] [Pfaff 10] [Chentanez 11]

Fluid Simulation. [Thürey 10] [Pfaff 10] [Chentanez 11] Fluid Simulation [Thürey 10] [Pfaff 10] [Chentanez 11] 1 Computational Fluid Dynamics 3 Graphics Why don t we just take existing models from CFD for Computer Graphics applications? 4 Graphics Why don t

More information

Auto Injector Syringe. A Fluent Dynamic Mesh 1DOF Tutorial

Auto Injector Syringe. A Fluent Dynamic Mesh 1DOF Tutorial Auto Injector Syringe A Fluent Dynamic Mesh 1DOF Tutorial 1 2015 ANSYS, Inc. June 26, 2015 Prerequisites This tutorial is written with the assumption that You have attended the Introduction to ANSYS Fluent

More information

Parallel lattice fluid simulations for transport phenomena in porous media

Parallel lattice fluid simulations for transport phenomena in porous media Parallel lattice fluid simulations for transport phenomena in porous media T. Watanabel, K. Kono2 & H, 0hashi3 ljapan Atomic Energy Research Institute, Japan. Fuji Research Institute Corporation, Japan.

More information

MONTEREY, CALIFORNIA DISSERTATION LATTICE BOLTZMANN METHODS FOR FLUID STRUCTURE INTERACTION. Stuart R. Blair. September Dissertation Supervisor:

MONTEREY, CALIFORNIA DISSERTATION LATTICE BOLTZMANN METHODS FOR FLUID STRUCTURE INTERACTION. Stuart R. Blair. September Dissertation Supervisor: MONTEREY, CALIFORNIA DISSERTATION LATTICE BOLTZMANN METHODS FOR FLUID STRUCTURE INTERACTION by Stuart R. Blair September 2012 Dissertation Supervisor: Young Kwon Approved for public release; distribution

More information

Understanding and Using MINC

Understanding and Using MINC Understanding and Using MINC Background In TOUGH2, the MINC (Multiple Interacting Continua) approach is used to model flow in fractured media. It is a generalization of the classical double-porosity concept

More information

Thompson/Ocean 420/Winter 2005 Internal Gravity Waves 1

Thompson/Ocean 420/Winter 2005 Internal Gravity Waves 1 Thompson/Ocean 420/Winter 2005 Internal Gravity Waves 1 II. Internal waves in continuous stratification The real ocean, of course, is continuously stratified. For continuous stratification, = (z), internal

More information

Particle Tracing Module

Particle Tracing Module Particle Tracing Module Particle Tracing Module Released with version 4.2a in October 2011 Add-on to COMSOL Multiphysics Combines with any COMSOL Multiphysics Module Particle Tracing Particle tracing

More information

CS 378: Computer Game Technology

CS 378: Computer Game Technology CS 378: Computer Game Technology Dynamic Path Planning, Flocking Spring 2012 University of Texas at Austin CS 378 Game Technology Don Fussell Dynamic Path Planning! What happens when the environment changes

More information

Simulation of moving Particles in 3D with the Lattice Boltzmann Method

Simulation of moving Particles in 3D with the Lattice Boltzmann Method Simulation of moving Particles in 3D with the Lattice Boltzmann Method, Nils Thürey, Christian Feichtinger, Hans-Joachim Schmid Chair for System Simulation University Erlangen/Nuremberg Chair for Particle

More information

The gas-kinetic methods have become popular for the simulation of compressible fluid flows in the last

The gas-kinetic methods have become popular for the simulation of compressible fluid flows in the last Parallel Implementation of Gas-Kinetic BGK Scheme on Unstructured Hybrid Grids Murat Ilgaz Defense Industries Research and Development Institute, Ankara, 626, Turkey and Ismail H. Tuncer Middle East Technical

More information

Shallow Water Equations

Shallow Water Equations SYRACUSE UNIVERSITY Shallow Water Equations PHY 307 Colin Richard Robinson 12/16/2011 Table of Contents Introduction... 3 Procedure... 3 Empirical Formulations... 3 The Bathtub Model... 5 Portals... 8

More information

Computational Fluid Dynamic Solver Based on Cellular Discrete-Event

Computational Fluid Dynamic Solver Based on Cellular Discrete-Event Computational Fluid Dynamic Solver Based on Cellular Discrete-Event Simulation Michael Van Schyndel, Gabriel Wainer, Mohammad Moallemi Dept. of Systems & Computer Engineering, Carleton University, Ottawa,

More information

CFD in COMSOL Multiphysics

CFD in COMSOL Multiphysics CFD in COMSOL Multiphysics Christian Wollblad Copyright 2017 COMSOL. Any of the images, text, and equations here may be copied and modified for your own internal use. All trademarks are the property of

More information

LATTICE-BOLTZMANN METHOD FOR THE SIMULATION OF LAMINAR MIXERS

LATTICE-BOLTZMANN METHOD FOR THE SIMULATION OF LAMINAR MIXERS 14 th European Conference on Mixing Warszawa, 10-13 September 2012 LATTICE-BOLTZMANN METHOD FOR THE SIMULATION OF LAMINAR MIXERS Felix Muggli a, Laurent Chatagny a, Jonas Lätt b a Sulzer Markets & Technology

More information

Chapter 6. Semi-Lagrangian Methods

Chapter 6. Semi-Lagrangian Methods Chapter 6. Semi-Lagrangian Methods References: Durran Chapter 6. Review article by Staniford and Cote (1991) MWR, 119, 2206-2223. 6.1. Introduction Semi-Lagrangian (S-L for short) methods, also called

More information

The jello cube. Undeformed cube. Deformed cube

The jello cube. Undeformed cube. Deformed cube The Jello Cube Assignment 1, CSCI 520 Jernej Barbic, USC Undeformed cube The jello cube Deformed cube The jello cube is elastic, Can be bent, stretched, squeezed,, Without external forces, it eventually

More information

A Particle Cellular Automata Model for Fluid Simulations

A Particle Cellular Automata Model for Fluid Simulations Annals of University of Craiova, Math. Comp. Sci. Ser. Volume 36(2), 2009, Pages 35 41 ISSN: 1223-6934 A Particle Cellular Automata Model for Fluid Simulations Costin-Radu Boldea Abstract. A new cellular-automaton

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

simulation framework for piecewise regular grids

simulation framework for piecewise regular grids WALBERLA, an ultra-scalable multiphysics simulation framework for piecewise regular grids ParCo 2015, Edinburgh September 3rd, 2015 Christian Godenschwager, Florian Schornbaum, Martin Bauer, Harald Köstler

More information

SolidWorks Flow Simulation 2014

SolidWorks Flow Simulation 2014 An Introduction to SolidWorks Flow Simulation 2014 John E. Matsson, Ph.D. SDC PUBLICATIONS Better Textbooks. Lower Prices. www.sdcpublications.com Powered by TCPDF (www.tcpdf.org) Visit the following websites

More information

Possibility of Implicit LES for Two-Dimensional Incompressible Lid-Driven Cavity Flow Based on COMSOL Multiphysics

Possibility of Implicit LES for Two-Dimensional Incompressible Lid-Driven Cavity Flow Based on COMSOL Multiphysics Possibility of Implicit LES for Two-Dimensional Incompressible Lid-Driven Cavity Flow Based on COMSOL Multiphysics Masanori Hashiguchi 1 1 Keisoku Engineering System Co., Ltd. 1-9-5 Uchikanda, Chiyoda-ku,

More information

Tutorial: Hydrodynamics of Bubble Column Reactors

Tutorial: Hydrodynamics of Bubble Column Reactors Tutorial: Introduction The purpose of this tutorial is to provide guidelines and recommendations for solving a gas-liquid bubble column problem using the multiphase mixture model, including advice on solver

More information

Sailfish: Lattice Boltzmann Fluid Simulations with GPUs and Python

Sailfish: Lattice Boltzmann Fluid Simulations with GPUs and Python Sailfish: Lattice Boltzmann Fluid Simulations with GPUs and Python Micha l Januszewski Institute of Physics University of Silesia in Katowice, Poland Google GTC 2012 M. Januszewski (IoP, US) Sailfish:

More information

Revision of the SolidWorks Variable Pressure Simulation Tutorial J.E. Akin, Rice University, Mechanical Engineering. Introduction

Revision of the SolidWorks Variable Pressure Simulation Tutorial J.E. Akin, Rice University, Mechanical Engineering. Introduction Revision of the SolidWorks Variable Pressure Simulation Tutorial J.E. Akin, Rice University, Mechanical Engineering Introduction A SolidWorks simulation tutorial is just intended to illustrate where to

More information

Development of an Incompressible SPH Method through SPARTACUS-2D

Development of an Incompressible SPH Method through SPARTACUS-2D Development of an Incompressible SPH Method through SPARTACUS-2D Eun-Sug Lee E.Lee-2@postgrad.manchester.ac.uk D. Laurence, C. Moulinec, P. Stansby, D. Violeau, Developing of truly incompressible method

More information

Computational Fluid Dynamics with the Lattice Boltzmann Method KTH SCI, Stockholm

Computational Fluid Dynamics with the Lattice Boltzmann Method KTH SCI, Stockholm Computational Fluid Dynamics with the Lattice Boltzmann Method KTH SCI, Stockholm March 17 March 21, 2014 Florian Schornbaum, Martin Bauer, Simon Bogner Chair for System Simulation Friedrich-Alexander-Universität

More information

Development of a Maxwell Equation Solver for Application to Two Fluid Plasma Models. C. Aberle, A. Hakim, and U. Shumlak

Development of a Maxwell Equation Solver for Application to Two Fluid Plasma Models. C. Aberle, A. Hakim, and U. Shumlak Development of a Maxwell Equation Solver for Application to Two Fluid Plasma Models C. Aberle, A. Hakim, and U. Shumlak Aerospace and Astronautics University of Washington, Seattle American Physical Society

More information

Using the Eulerian Multiphase Model for Granular Flow

Using the Eulerian Multiphase Model for Granular Flow Tutorial 21. Using the Eulerian Multiphase Model for Granular Flow Introduction Mixing tanks are used to maintain solid particles or droplets of heavy fluids in suspension. Mixing may be required to enhance

More information

Critical Phenomena, Divergences, and Critical Slowing Down

Critical Phenomena, Divergences, and Critical Slowing Down Critical Phenomena, Divergences, and Critical Slowing Down The Metropolis Monte Carlo method works very well in simulating the properties of the 2-D Ising model. However, close to the Curie temperature

More information

Free Surface Lattice-Boltzmann fluid simulations. with and without level sets.

Free Surface Lattice-Boltzmann fluid simulations. with and without level sets. ree Surface Lattice-Boltzmann fluid simulations with and without level sets Nils Thürey, Ulrich Rüde University of Erlangen-Nuremberg System Simulation roup Cauerstr. 6, 91054 Erlangen, ermany Email: Nils.Thuerey@cs.fau.de

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

A Contact Angle Model for the Parallel Free Surface Lattice Boltzmann Method in walberla Stefan Donath (stefan.donath@informatik.uni-erlangen.de) Computer Science 10 (System Simulation) University of Erlangen-Nuremberg

More information

SIMULATION OF FLOW FIELD AROUND AND INSIDE SCOUR PROTECTION WITH PHYSICAL AND REALISTIC PARTICLE CONFIGURATIONS

SIMULATION OF FLOW FIELD AROUND AND INSIDE SCOUR PROTECTION WITH PHYSICAL AND REALISTIC PARTICLE CONFIGURATIONS XIX International Conference on Water Resources CMWR 2012 University of Illinois at Urbana-Champaign June 17-22, 2012 SIMULATION OF FLOW FIELD AROUND AND INSIDE SCOUR PROTECTION WITH PHYSICAL AND REALISTIC

More information

CFD MODELING FOR PNEUMATIC CONVEYING

CFD MODELING FOR PNEUMATIC CONVEYING CFD MODELING FOR PNEUMATIC CONVEYING Arvind Kumar 1, D.R. Kaushal 2, Navneet Kumar 3 1 Associate Professor YMCAUST, Faridabad 2 Associate Professor, IIT, Delhi 3 Research Scholar IIT, Delhi e-mail: arvindeem@yahoo.co.in

More information

Express Introductory Training in ANSYS Fluent Workshop 02 Using the Discrete Phase Model (DPM)

Express Introductory Training in ANSYS Fluent Workshop 02 Using the Discrete Phase Model (DPM) Express Introductory Training in ANSYS Fluent Workshop 02 Using the Discrete Phase Model (DPM) Dimitrios Sofialidis Technical Manager, SimTec Ltd. Mechanical Engineer, PhD PRACE Autumn School 2013 - Industry

More information

A simple example. Assume we want to find the change in the rotation angles to get the end effector to G. Effect of changing s

A simple example. Assume we want to find the change in the rotation angles to get the end effector to G. Effect of changing s CENG 732 Computer Animation This week Inverse Kinematics (continued) Rigid Body Simulation Bodies in free fall Bodies in contact Spring 2006-2007 Week 5 Inverse Kinematics Physically Based Rigid Body Simulation

More information

A new Eulerian computational method for the propagation of short acoustic and electromagnetic pulses

A new Eulerian computational method for the propagation of short acoustic and electromagnetic pulses A new Eulerian computational method for the propagation of short acoustic and electromagnetic pulses J. Steinhoff, M. Fan & L. Wang. Abstract A new method is described to compute short acoustic or electromagnetic

More information

GALAXY ADVANCED ENGINEERING, INC. P.O. BOX 614 BURLINGAME, CALIFORNIA Tel: (650) Fax: (650)

GALAXY ADVANCED ENGINEERING, INC. P.O. BOX 614 BURLINGAME, CALIFORNIA Tel: (650) Fax: (650) GALAXY ADVANCED ENGINEERING, INC. P.O. BOX 614 BURLINGAME, CALIFORNIA 94011 Tel: (650) 740-3244 Fax: (650) 347-4234 E-mail: bahmanz@aol.com PUFF-TFT/PC A Material Response Computer Code for PC Computer

More information

Introducing a Cache-Oblivious Blocking Approach for the Lattice Boltzmann Method

Introducing a Cache-Oblivious Blocking Approach for the Lattice Boltzmann Method Introducing a Cache-Oblivious Blocking Approach for the Lattice Boltzmann Method G. Wellein, T. Zeiser, G. Hager HPC Services Regional Computing Center A. Nitsure, K. Iglberger, U. Rüde Chair for System

More information

Steady Flow: Lid-Driven Cavity Flow

Steady Flow: Lid-Driven Cavity Flow STAR-CCM+ User Guide Steady Flow: Lid-Driven Cavity Flow 2 Steady Flow: Lid-Driven Cavity Flow This tutorial demonstrates the performance of STAR-CCM+ in solving a traditional square lid-driven cavity

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

The Lattice Boltzmann Method used for fluid flow modeling in hydraulic components

The Lattice Boltzmann Method used for fluid flow modeling in hydraulic components The 15th Scandinavian International Conference on Fluid Power, SICFP 17, June 7-9, 2017, Linköping, Sweden The Lattice Boltzmann Method used for fluid flow modeling in hydraulic components Bernhard Manhartsgruber

More information

Computer Project 3. AA Computational Fluid Dyanmics University of Washington. Mishaal Aleem March 17, 2015

Computer Project 3. AA Computational Fluid Dyanmics University of Washington. Mishaal Aleem March 17, 2015 Computer Project 3 AA 543 - Computational Fluid Dyanmics University of Washington Mishaal Aleem March 17, 2015 Contents Introduction........................................... 1 3.1 Grid Generator.......................................

More information

A D3Q19 Lattice Boltzmann Solver on a GPU Using Constant-Time Circular Array Shifting

A D3Q19 Lattice Boltzmann Solver on a GPU Using Constant-Time Circular Array Shifting Int'l Conf. Par. and Dist. Proc. Tech. and Appl. PDPTA'18 383 A D3Q19 Lattice Boltzmann Solver on a GPU Using Constant-Time Circular Array Shifting Mohammadreza Khani and Tai-Hsien Wu Department of Electrical

More information

Improved bounce-back methods for no-slip walls in lattice-boltzmann schemes: Theory and simulations

Improved bounce-back methods for no-slip walls in lattice-boltzmann schemes: Theory and simulations PHYSICAL REVIEW E 67, 066703 2003 Improved bounce-back methods for no-slip walls in lattice-boltzmann schemes: Theory and simulations M. Rohde,* D. Kandhai, J. J. Derksen, and H. E. A. Van den Akker Kramers

More information

Jane Li. Assistant Professor Mechanical Engineering Department, Robotic Engineering Program Worcester Polytechnic Institute

Jane Li. Assistant Professor Mechanical Engineering Department, Robotic Engineering Program Worcester Polytechnic Institute Jane Li Assistant Professor Mechanical Engineering Department, Robotic Engineering Program Worcester Polytechnic Institute (3 pts) Compare the testing methods for testing path segment and finding first

More information

CS-184: Computer Graphics Lecture #21: Fluid Simulation II

CS-184: Computer Graphics Lecture #21: Fluid Simulation II CS-184: Computer Graphics Lecture #21: Fluid Simulation II Rahul Narain University of California, Berkeley Nov. 18 19, 2013 Grid-based fluid simulation Recap: Eulerian viewpoint Grid is fixed, fluid moves

More information

Fluid-structure Interaction by the mixed SPH-FE Method with Application to Aircraft Ditching

Fluid-structure Interaction by the mixed SPH-FE Method with Application to Aircraft Ditching Fluid-structure Interaction by the mixed SPH-FE Method with Application to Aircraft Ditching Paul Groenenboom ESI Group Delft, Netherlands Martin Siemann German Aerospace Center (DLR) Stuttgart, Germany

More information

The use of gas-kinetic schemes for the simulation of compressible flows become widespread in the two last

The use of gas-kinetic schemes for the simulation of compressible flows become widespread in the two last A Gas-Kinetic BGK Scheme for Parallel Solution of 3-D Viscous Flows on Unstructured Hybrid Grids Murat Ilgaz Defense Industries Research and Development Institute, Ankara, 626, Turkey and Ismail H. Tuncer

More information

Stream Function-Vorticity CFD Solver MAE 6263

Stream Function-Vorticity CFD Solver MAE 6263 Stream Function-Vorticity CFD Solver MAE 66 Charles O Neill April, 00 Abstract A finite difference CFD solver was developed for transient, two-dimensional Cartesian viscous flows. Flow parameters are solved

More information

An Introduction to SolidWorks Flow Simulation 2010

An Introduction to SolidWorks Flow Simulation 2010 An Introduction to SolidWorks Flow Simulation 2010 John E. Matsson, Ph.D. SDC PUBLICATIONS www.sdcpublications.com Schroff Development Corporation Chapter 2 Flat Plate Boundary Layer Objectives Creating

More information

FLUENT Secondary flow in a teacup Author: John M. Cimbala, Penn State University Latest revision: 26 January 2016

FLUENT Secondary flow in a teacup Author: John M. Cimbala, Penn State University Latest revision: 26 January 2016 FLUENT Secondary flow in a teacup Author: John M. Cimbala, Penn State University Latest revision: 26 January 2016 Note: These instructions are based on an older version of FLUENT, and some of the instructions

More information

Faculty of Mechanical and Manufacturing Engineering, University Tun Hussein Onn Malaysia (UTHM), Parit Raja, Batu Pahat, Johor, Malaysia

Faculty of Mechanical and Manufacturing Engineering, University Tun Hussein Onn Malaysia (UTHM), Parit Raja, Batu Pahat, Johor, Malaysia Applied Mechanics and Materials Vol. 393 (2013) pp 305-310 (2013) Trans Tech Publications, Switzerland doi:10.4028/www.scientific.net/amm.393.305 The Implementation of Cell-Centred Finite Volume Method

More information

Praktikum 2014 Parallele Programmierung Universität Hamburg Dept. Informatics / Scientific Computing. October 23, FluidSim.

Praktikum 2014 Parallele Programmierung Universität Hamburg Dept. Informatics / Scientific Computing. October 23, FluidSim. Praktikum 2014 Parallele Programmierung Universität Hamburg Dept. Informatics / Scientific Computing October 23, 2014 Paul Bienkowski Author 2bienkow@informatik.uni-hamburg.de Dr. Julian Kunkel Supervisor

More information

High Scalability of Lattice Boltzmann Simulations with Turbulence Models using Heterogeneous Clusters

High Scalability of Lattice Boltzmann Simulations with Turbulence Models using Heterogeneous Clusters SIAM PP 2014 High Scalability of Lattice Boltzmann Simulations with Turbulence Models using Heterogeneous Clusters C. Riesinger, A. Bakhtiari, M. Schreiber Technische Universität München February 20, 2014

More information

Introduction to C omputational F luid Dynamics. D. Murrin

Introduction to C omputational F luid Dynamics. D. Murrin Introduction to C omputational F luid Dynamics D. Murrin Computational fluid dynamics (CFD) is the science of predicting fluid flow, heat transfer, mass transfer, chemical reactions, and related phenomena

More information

IMPROVING THE NUMERICAL ACCURACY OF HYDROTHERMAL RESERVOIR SIMULATIONS USING THE CIP SCHEME WITH THIRD-ORDER ACCURACY

IMPROVING THE NUMERICAL ACCURACY OF HYDROTHERMAL RESERVOIR SIMULATIONS USING THE CIP SCHEME WITH THIRD-ORDER ACCURACY PROCEEDINGS, Thirty-Seventh Workshop on Geothermal Reservoir Engineering Stanford University, Stanford, California, January 30 - February 1, 2012 SGP-TR-194 IMPROVING THE NUMERICAL ACCURACY OF HYDROTHERMAL

More information

An Investigation into Iterative Methods for Solving Elliptic PDE s Andrew M Brown Computer Science/Maths Session (2000/2001)

An Investigation into Iterative Methods for Solving Elliptic PDE s Andrew M Brown Computer Science/Maths Session (2000/2001) An Investigation into Iterative Methods for Solving Elliptic PDE s Andrew M Brown Computer Science/Maths Session (000/001) Summary The objectives of this project were as follows: 1) Investigate iterative

More information

Citation for the original published paper (version of record):

Citation for the original published paper (version of record): http://www.diva-portal.org Postprint This is the accepted version of a paper published in Procedia Computer Science. This paper has been peer-reviewed but does not include the final publisher proof-corrections

More information

A Diagonal Split-cell Model for the High-order Symplectic FDTD Scheme

A Diagonal Split-cell Model for the High-order Symplectic FDTD Scheme PIERS ONLINE, VOL. 2, NO. 6, 2006 715 A Diagonal Split-cell Model for the High-order Symplectic FDTD Scheme Wei Sha, Xianliang Wu, and Mingsheng Chen Key Laboratory of Intelligent Computing & Signal Processing

More information

SPH: Why and what for?

SPH: Why and what for? SPH: Why and what for? 4 th SPHERIC training day David Le Touzé, Fluid Mechanics Laboratory, Ecole Centrale de Nantes / CNRS SPH What for and why? How it works? Why not for everything? Duality of SPH SPH

More information

Chapter 1. Linear Equations and Straight Lines. 2 of 71. Copyright 2014, 2010, 2007 Pearson Education, Inc.

Chapter 1. Linear Equations and Straight Lines. 2 of 71. Copyright 2014, 2010, 2007 Pearson Education, Inc. Chapter 1 Linear Equations and Straight Lines 2 of 71 Outline 1.1 Coordinate Systems and Graphs 1.4 The Slope of a Straight Line 1.3 The Intersection Point of a Pair of Lines 1.2 Linear Inequalities 1.5

More information

Large Eddy Simulations of a Stirred Tank Using the Lattice Boltzmann Method on a Nonuniform Grid

Large Eddy Simulations of a Stirred Tank Using the Lattice Boltzmann Method on a Nonuniform Grid Journal of Computational Physics 181, 675 704 (2002) doi:10.1006/jcph.2002.7151 Large Eddy Simulations of a Stirred Tank Using the Lattice Boltzmann Method on a Nonuniform Grid Zhenyu Lu, Ying Liao, Dongying

More information

TYPE 529: RADIANT SLAB

TYPE 529: RADIANT SLAB TYPE 529: RADIANT SLAB General Description This component is intended to model a radiant floor-heating slab, embedded in soil, and containing a number of fluid filled pipes. The heat transfer within the

More information

CHAPTER 5 STUDY OF THERMAL COMFORT IN A ROOM WITH INSECT PROOF SCREEN

CHAPTER 5 STUDY OF THERMAL COMFORT IN A ROOM WITH INSECT PROOF SCREEN 146 CHAPTER 5 STUDY OF THERMAL COMFORT IN A ROOM WITH INSECT PROOF SCREEN 5.1 INTRODUCTION In recent days, most of the buildings are equipped with insect proof screens to keep the insect not to enter inside

More information

Lagrangian and Eulerian Representations of Fluid Flow: Kinematics and the Equations of Motion

Lagrangian and Eulerian Representations of Fluid Flow: Kinematics and the Equations of Motion Lagrangian and Eulerian Representations of Fluid Flow: Kinematics and the Equations of Motion James F. Price Woods Hole Oceanographic Institution Woods Hole, MA, 02543 July 31, 2006 Summary: This essay

More information

Continuum-Microscopic Models

Continuum-Microscopic Models Scientific Computing and Numerical Analysis Seminar October 1, 2010 Outline Heterogeneous Multiscale Method Adaptive Mesh ad Algorithm Refinement Equation-Free Method Incorporates two scales (length, time

More information

Introduction to the immersed boundary method

Introduction to the immersed boundary method Introduction to the immersed boundary method Motivation. Hydrodynamics and boundary conditions The incompressible Navier-Stokes equations, ( ) u ρ + (u )u = p + ρν 2 u + f, () t are partial differential

More information

Engineering Effects of Boundary Conditions (Fixtures and Temperatures) J.E. Akin, Rice University, Mechanical Engineering

Engineering Effects of Boundary Conditions (Fixtures and Temperatures) J.E. Akin, Rice University, Mechanical Engineering Engineering Effects of Boundary Conditions (Fixtures and Temperatures) J.E. Akin, Rice University, Mechanical Engineering Here SolidWorks stress simulation tutorials will be re-visited to show how they

More information

Explicit and Implicit Coupling Strategies for Overset Grids. Jörg Brunswig, Manuel Manzke, Thomas Rung

Explicit and Implicit Coupling Strategies for Overset Grids. Jörg Brunswig, Manuel Manzke, Thomas Rung Explicit and Implicit Coupling Strategies for s Outline FreSCo+ Grid Coupling Interpolation Schemes Implementation Mass Conservation Examples Lid-driven Cavity Flow Cylinder in a Channel Oscillating Cylinder

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

HIGH PERFORMANCE COMPUTATION (HPC) FOR THE

HIGH PERFORMANCE COMPUTATION (HPC) FOR THE HIGH PERFORMANCE COMPUTATION (HPC) FOR THE DEVELOPMENT OF FLUIDIZED BED TECHNOLOGIES FOR BIOMASS GASIFICATION AND CO2 CAPTURE P. Fede, H. Neau, O. Simonin Université de Toulouse; INPT, UPS ; IMFT ; 31400

More information

Modeling of Laminar Flow Static Mixers

Modeling of Laminar Flow Static Mixers Modeling of Laminar Flow Static Mixers Nagi Elabbasi, Xiaohu Liu, Stuart Brown ( ) Mike Vidal, Matthew Pappalardo (Nordson EFD) COMSOL Conference 2012, Boston, MA Excerpt from the Proceedings of the 2012

More information

Offshore Platform Fluid Structure Interaction (FSI) Simulation

Offshore Platform Fluid Structure Interaction (FSI) Simulation Offshore Platform Fluid Structure Interaction (FSI) Simulation Ali Marzaban, CD-adapco Murthy Lakshmiraju, CD-adapco Nigel Richardson, CD-adapco Mike Henneke, CD-adapco Guangyu Wu, Chevron Pedro M. Vargas,

More information

Lagrangian methods and Smoothed Particle Hydrodynamics (SPH) Computation in Astrophysics Seminar (Spring 2006) L. J. Dursi

Lagrangian methods and Smoothed Particle Hydrodynamics (SPH) Computation in Astrophysics Seminar (Spring 2006) L. J. Dursi Lagrangian methods and Smoothed Particle Hydrodynamics (SPH) Eulerian Grid Methods The methods covered so far in this course use an Eulerian grid: Prescribed coordinates In `lab frame' Fluid elements flow

More information

On the thickness of discontinuities computed by THINC and RK schemes

On the thickness of discontinuities computed by THINC and RK schemes The 9th Computational Fluid Dynamics Symposium B7- On the thickness of discontinuities computed by THINC and RK schemes Taku Nonomura, ISAS, JAXA, Sagamihara, Kanagawa, Japan, E-mail:nonomura@flab.isas.jaxa.jp

More information

Collisions/Reflection

Collisions/Reflection Collisions/Reflection General Collisions The calculating whether or not two 2D objects collide is equivalent to calculating if the two shapes share a common area (intersect). For general polygons this

More information