Numerical modeling of flood waves in a bumpy channel with the different boundary conditions

Size: px
Start display at page:

Download "Numerical modeling of flood waves in a bumpy channel with the different boundary conditions"

Transcription

1 Numerical modeling of flood waves in a bumpy channel with the different boundary conditions Sajedeh Farmani 1*, Gholamabbas Barani 2, Mahnaz Ghaeini-Hessaroeyeh 3, Rasoul Memarzadeh 4 1 Ph.D Candidate, Department of Civil Engineering, Faculty of Engineering, Shahid Bahonar University of Kerman, PO Box , Kerman, Iran sajedeh.farmani@eng.uk.ac.ir Telephone number: Mobile number: Professor, Department of Civil Engineering, Faculty of Engineering, Shahid Bahonar University of Kerman, PO Box , Kerman, Iran. gab@uk.ac.ir Telephone number: Mobile number: Assistant Professor, Department of Civil Engineering, Faculty of Engineering, Shahid Bahonar University of Kerman, PO Box , Kerman, Iran. mghaeini@uk.ac.ir 4 Ph.D of civil (hydraulic structurs) engineering, Department of Civil Engineering, Faculty of Engineering, Shahid Bahonar University of Kerman, PO Box , Kerman, Iran. Telephone number: Mobile number: rasoul.memarzadeh@eng.uk.ac.ir Mobile number:

2 Abstract In this paper, the Incompressible Smoothed Particle Hydrodynamics (ISPH) method is presented to simulate flood waves in uneven beds. The SPH method is a mesh free particle modeling approach that is capable of tracking the large deformation of free surfaces in an easy and accurate manner. Wave breaking is one of the phenomena that its free surface is complicated. Therefore, ISPH method is robust tool for the modeling of this kind of free surface. The basic equations are the incompressible mass conservation and Navier Stokes equations that are solved using a two-step fractional method. In the first step, these equations are solved to compute velocity components by omitting the pressure term and in the absence of incompressible condition. In the second step, the continuity constraint is satisfied and the Poisson equation is solved to calculate pressure terms. In the present model, a new technique is applied to allocate density of the particles for the calculations. By employing this technique, ISPH method is stabled. The validation by comparison with laboratory data is conducted for bumpy channel with various boundary conditions. The numerical results showed good agreement with available experimental data. Also relative error is calculated for two numerical cases. Key words: Flood waves, ISPH method, Wave breaking, Uneven bed, Fractional method 1. Introduction Flood waves is a complex phenomenon that occurs in free surface flows with large deformation. Dam break wave is one of this flow that can be caused losses and damages. Therefore prediction of the water level position, velocity and pressure are essential. These problems are difficult to simulate due to the existence of the arbitrarily moving surface boundary conditions and also because of the complex governing Navier Stokes Equations (NSEs) [1]. Also, the dam break problem has been the subject of many analytical, experimental, and numerical studies for hydraulics scientists and engineers [2,3,4].The marker and cell [5] and Volume Of Fluid (VOF), [6] methods are the most common methods for simulating such flows, in which the Navier Stokes equations are solved on a fixed Eulerian grid [7]. In MAC method marker particles were used to define the free surface while in VOF method the governing equations are solved for the volume fraction of the fluid. However, in spite of successful use of both methods for treating free surface flows, numerical diffusion due to solving NSEs on a fixed Eulerian grid arose, especially when the deformation of free surface is very large [8]. In the general area of computational mechanics there is a growing interest in developing so-called meshless/ meshfree methods 2

3 or particle methods as alternatives to traditional grid-based methods such as finite difference methods and finite element methods [9]. One of the oldest mesh-less methods is the Smoothed Particle Hydrodynamics (SPH) method. Smoothed particle method is originally used for astronomic problems. Recently, this method has been well studied and applied in computational fluid dynamics, specially for flows with complex free surface [10]. Furthermore, SPH method was used successfully to model the fixed-bed dam break flow on a dry-bed and wet-bed downstream channel [11, 12]. Ozbulut et al. [13] carried out a numerical investigation into the correction algorithms for SPH method in modelling violent free surface flows. SPH simulations of the incompressible flows can be carried out by two approaches: 1) approximately simulating incompressible flows with a small compressibility, or Weakly Compressible SPH (WCSPH); 2) simulating flows by enforcing incompressibility, or Incompressible SPH (ISPH). In WCSPH method, the flow is considered as slightly compressible, with a state equation for the pressure calculation [14, 15]. In ISPH method the pressure-velocity coupling is generally solved by the projection method [16, 17, 18, 19]. In this field, Xenakis et al. [20] improved the pressure predictions using an incompressible SPH scheme for free surface Newtonian flows. Nomeritae et al. [21] presented an explicit incompressible SPH algorithm for free surface flow and then compared this algorithm with weakly compressible scheme. This paper presents an incompressible 2D ISPH model to simulate flood waves in uneven bed and validated in Sections 5, for a rough bumpy channel with various boundary conditions. Furthermore the relative error are calculated in the different section. 2. Governing equations The Navier Stokes equations (mass and momentum conservation equations) are written in 2D Lagrangian form as [3]: 1 D. u 0 (1) Dt 3

4 Du Dt 1 2 p b u f (2) where is the flow density, u is the flow velocity, p is the pressure, is dynamic viscosity, fb represents the body force and t is time. Equation (1) is in the form of a compressible flow. Incompressibility is enforced in a correction step of the time integration by setting Dρ Dt = 0 at each particle. The motion of each particle is calculated by Dr/ Dt = u, with r being the position vector. These equations were solved by SPH method. 3. Numerical methodology 3.1. ISPH formulations In the SPH method the fluid domain is represented by nodal points that are scattered in space with no definable grid structure and move with the fluid. Each of these nodal points has information, such as density, pressure, velocity components, etc. [22]. The SPH formulation is obtained as a result of interpolation between a set of disordered points known as particles. The interpolation is based on the theory of integral interpolants that uses a kernel function to approximate delta function. The kernel approximation of f is written in the form [23]: f ( r) f ( r) W( r r, h) dr (3) 0 In the particle approximation, for any function of field variable: m n j f ( ri ) f ( r ) W ( r r, h) (4) j 1 j i j j that, is the support domain, m j and are the mass and density of particle j, mj j is the volume j element associated with particle j, W is interpolation kernel function (in this paper kernel based on the spline function is used [23]), r is the position vector, h is the smoothing distance which determines width of kernel and ultimately the resolution of the method and in this paper h 1.2 dr are used, where dr is 4

5 the initial particle spacing, and n is the total number of particles within the smoothing that affects particle i. For example density of a particle in the SPH approximation represented as: n m W ( r r, h) (5) i j i j j 1 The formulation of the gradient term has different forms depending on the derivation used [23]. The gradient of the pressure is expressed as: 1 P P ( ) ( ) j i Pi m j W 2 2 ij i j j i (6) where, P is pressure of the particles. Similarly, the divergence of a vector u at particle i can be expressed by: u u. u m ( ). W i j i i j 2 2 i ij j i j (7) The Laplacian for the pressure and viscosity term is formulated as the hybrid of a standard SPH first derivative coupled with a finite difference approximation for the first derivative [4]. Furthermore, it has been found that the resulting second derivative of the kernel is very sensitive to particle disorder and will easily lead to pressure instability and decoupling in the computation due to the co-location of the velocity and pressure [8]. These are represented by: 1 8 P ij rij. iwij.( P) i m 2 ρ (ρ ρ ) η j 2 2 j i j rij (8) 4 m ( ) r. W 2 j i j ij i ij ( u ) i (u ) i- u j j ( i j ) ( rij ) (9) in which, Pij Pi Pj, ij i j r r r, is the viscosity coefficient and is a small number introduced to keep the denominator no-zero during computational and usually equal to 0.1h. After employing the 5

6 SPH formulation equation (9) for the Laplacian of pressure, the corresponding coefficient matrix of linear equations is symmetric and positive definite and can be efficiently solved by available solvers Limitation of time step In the simulation of water flows, in which the fluid viscosity is not a control factor, the stability of the ISPH computation requires the following Courant condition to be observed: t 0.1 x (10) v max where v max denotes the maximum particle velocity in the computational domain. The factor 0.1 ensures that the particle moves only a small fraction of the particle spacing per time step [24] Boundary conditions Free surface boundary The ISPH model uses the particle density to judge the free surface and a zero pressure is given to these particles. The criterion is that there is no fluid particle existing in the outer region of the free surface, so the particle density on the surface should drop significantly [8]. Therefore a particle which satisfies the following equation was considered to be on the free surface: ( ) ( ) (11) * i 0 i In this equation β is the free surface parameter and [25]. In this paper 0.94 is used. The equation (11) is applied to the free surface particles, in order to move correctly, avoid instability in the computations and control over their incompressibility condition [1] Solid wall boundaries Solid walls are simulated by one line of particles. In order to satisfy the non-slip boundary condition, the velocities of wall particles are set to zero. For the balance of the pressure of inner fluid particles and prevent them from penetrating the solid walls, the pressure Poisson equation is solved for these wall particles and the Neumann boundary condition is imposed. Also, two lines of dummy particles places 6

7 outside of wall boundaries and their pressure is set to that of a wall particle in the normal direction of the solid walls. By imposing these conditions, the density of particles is computed accurately and wall particles are not considered as free surface particles [8]. 4. Solution algorithm At first, the initial conditions such as problem geometry, smoothing distance, number of particles, mass, dynamic viscosity, initial coordinate and their velocity, are defined. Then two steps fractional algorithm are applied. In the first step, the Navier Stokes equations are solved to compute velocity components without the pressure term and in the absence of incompressible condition. In the second step, the continuity constraint is satisfied and the resulting Poisson equation is solved to calculate pressure terms [8]. This algorithm can be summarized in five stages: - Calculate the density of the particles using the equation [8]: m W( r r, h) 0 i j j i j (12) - The prediction step: Compute temporary particle positions and velocities by considering the gravity and viscosity term in equation (2) [8]: 2 u * ( g u ) t (13) u u u (14) * t * * r rt u * t (15) where u t and r t are the particle velocity and position at time t; u * and * r are the temporary particle velocity and position, respectively and u * is changed in the particle velocity during the prediction step. In this step, due to omitting the pressure term, the fluid density is changed, and is computed again by equation 16. Therefore incompressibility is not still satisfied [8]. 7

8 m W( r r, h) * * * i j i j j (16) - The correction step; in this step the pressure term, is computed from Poisson equation (equation 19) by considering the continuity constraint and enforcing incompressibility with combining equations 17 and 18, [8]: *.( u **) 0 (17) t 1 u P t (18) ** t 1 * 1.( P ) ρ 0 * t 1 2 * 0 t (19) The Poisson equation produces a system of linear equation that is solved by iterative solvers. - New particle velocities are obtained from equations (19) and (20), [8]. u =u Δu (20) t 1 t ** -The new position of particles is computed by the equation (21), [8]. r r u u 2 t 1 t t 1 t t (21) 5. Numerical validations In this section, the numerical accuracy and applicability of the proposed ISPH method are examined by the laboratory measurements of dam-break flows in the bumpy channel Dry bed with open end Problem geometry and solution domain 8

9 In this case, the experimental data of Ozmen-Cagatay et al. [26] are used. Dimensions of the channel and reservoir are displayed in figure 1. All of the bed is dry before and after the obstacle and there is an open end boundary condition Qualitative description of the flow After lifting the gate, the water wave propagates over the bed. After about t= 0.9s, the flow water hits the obstacle. At t=1.36s, amount of water passes the bump while at t=2.8s, the wave reflection of the bump is clearly observed. The water flow and propagation of waves are shown in figure 2 for t=0.22s, t=0.5s, t=0.9s, t=1.36s, t=2.8s, t=3.3s, t=3.68s, t=4.74s, t=5.72s. The good agreement exists between the present model results and the experimental data Comparison of free surface profile with experimental data The free surface profiles are shown in figure 3 and the results of the present model is compared with experimental data of Ozmen-cagatay et al. [26]. Be noted that the space and the level of water are dimensionless and the time is multiplied by 0.5 ( g / h o ) and then the dimensionless time 0.5 T t ( g / ho ) is obtained ( g and ho are gravity acceleration and initial depth of water respectively). According to the figure 3, at T=15.16 and T=17.54 and on the top of the obstacle, the estimate of water level of numerical model is slightly higher than the experimental data of Ozmen-Cagatay et al. [26], but in both, the maximum of the water depth happened on the peak of the bump (bump is triangular obstacle that shown in figure 3). At T=20.67, from the first of the bed up to the end of the bump, the numerical model slightly overestimates the water level. From T=20.67 up to T=35.83, when the flow wave reaches the bump, a part of water is reflected and another part passes the bump. At T=23.05 before the obstacle, the free surface profile of the present model is higher than in the experimental data. At T=29.69 and T=35.83, the water level at the upstream of the bump is changeless in the numerical model. At the time progress (T>35.83), the water level is maximum at the top of the bump. At T=41.84 and T=49.99, the results of the present model are in good agreement with the experimental data. 9

10 Calculation of relative error By comparing the results of the numerical model with experimental data, relative error is calculated as follows: X Computational X Experimental Error(%) 100 (26) X Experimental The resulting is shown in table Water level variation over time The location of the stations P1, P2, P3, P4, P5 and P6 are shown in figure 4. Dimensionless level of water over time is compared with experimental data at these points. This comparison is displayed in figure 5. The plots are depicted for 9.5 second. After sudden removal the gate, a decline and rise in water level occur for P1 and p2 respectively up to T=5. From T=5 to T=40, the water level changes a little at these points. After the passing and reflection of water wave of the bump (T=40), the water level decline gradually at P1 and P2. When the wave front reaches the P3, the water level increases suddenly. The duration of the water level being constant (T=20-29) is shorter for P3 than those for P1 and P2. At P4, P5, P6, the water level grows without being constant. The free surface flow changes a little behind the negative wave. At this time, the flow transmute to the subcritical flow via hydraulic jump and then passes the bump. At this stage, the water levels remain constant in maximum values, because inflow and outflow are in balance. At T>40 the water level declines in downstream while negative wave moves to the upstream. In general, the good agreement exists between the present model results and the experimental data Calculation of relative error As for the section 5.1.6, the relative error is calculated using the equation 26. Therefore the resulting is shown in table Wet bed after obstacle with closed end 10

11 In this case, the experimental data of Soares Frazao et al. [27] are selected for comparison. Initial domain and dimensions are shown in figure 6. There is closed end boundary condition and the bed is dry before the bump and wet after it Qualitative description of the flow The flow is described at t=1.8s, t=3.0s, t=3.7s and t=8.4s and images are shown in figure 7. When the gate is opened, the flows move to the downstream. After the water reaches the obstacle, part of the wave crosses the bump, but another part is reflected and moves to the upstream. After crossing the bump, the flow reaches the pool of water. In this time (t=3.0s), a positive front wave is formed and travels to the upstream. Then this flow moves to the bed and reaches the bump and is reflected again (t=3.7). At t=8.4s the water on the bump is balanced Comparison of the free surface profile with the experimental data In this section, Comparison of the free surface profile with the experimental data are carried out. Then the results are shown in figure 8, at t=1.8s, t=3.0s, t=3.7s and t=8.4s. In these times, the present model reproduces good results Calculation of relative error The calculation of error is the same as sections and that are given in table Rectangular obstacle In this section, the liquid behavior, when it hits to the rectangular obstacle, is investigated and compared with the experimental data of Koshizuka et al. [28]. The initial geometry of this case is provided in figure 9. This figure illustrates the experimental data and the numerical results at t=0.1, 0.2, 0.3, 0.5 s. at t=0.5s, the results of the numerical model is slightly different with the experimental data. Because of air faze is neglected in the numerical model. The good agreement exist between the experimental data and the numerical results. 6. Discussions 11

12 In the previous sections, the flood waves in the channel with the different boundary conditions were investigated. Case one was a channel with dry bed and open end. Dam break problem was studied in this channel. Then the free surface profile was compared with the experimental data of Ozmen-Cagatay et al. [26]. The results of this model was in very good agreement with the experimental data. Also maximum of relative error was calculated for different dimensionless times and shown good accuracy for numerical model. The second case was channel with the closed end that the bed after the obstacle was considered wet. Then dam break waves were investigated for this case. This problem was compared with the experimental data of Soares Frazao et al. [27]. At the end of this part, maximum of relative error was computed for different times. By analysis of the results and maximum of error could be found that the results of the present model had good efficiency for modeling the interference of waves. In the third case, a channel with a rectangular obstacle was considered. For this example, the results of the present model are compared with the experimental data of Kushizuka et al. [21]. For this case, flow of dam break had acceptable accordance in comparison the experimental data. 7. Conclusion In this paper a numerical modelling of flood waves in a bumpy channel with the different boundary conditions is developed. An ISPH Method is presented to simulate flood waves in a bumpy channel with the different boundary conditions. SPH is a Lagrangian particle method which does not require a grid to simulate free surface flows. Wave breaking is one of the phenomena that its free surface is complicated. Therefore particle methods such as ISPH method is robust tool for the modelling of this kind of free surface. The method employs particles to discretize the Navier Stokes equations and the interactions among particles simulate the flows. Thus the advection terms in Navier-Stocks equations are calculated directly which this omit numerical diffusion errors. In the present model, a new technique is applied to allocate density of the particles for the calculations. By employing this technique, ISPH method is stabled. The numerical validation and verification are performed through experimental data to proving capability of the ISPH model to simulate flood waves interaction in uneven beds with various.boundary 12

13 conditions. Also the results shown that the free surface flows in the channels with the different boundary conditions are simulated using ISPH method with high accuracy. In other side, the computed relative error indicates this fact too. References [1] Ataie-Ashtiani, B., Shobeiry, G., Farhadi, L. Modified Incompressible SPH method for simulating free surface problems, Fluid Dynamic Research, 40, PP (2008). [2] Stoker, JJ. Water waves. Pure and applied mathematics 4. Interscience Publishers, New York. (1957) [3] Xia, J., Lin, B., Falconer, RA., Wang, G. Modelling dam-break flows over mobile beds using a 2D coupled approach. Adv Water Resour. 33(2), pp (2010). [4] Shakibaeinia, A., Jin, YC. A mesh-free particle model for simulation of mobile-bed dam break. Adv Water Resour. 34(6), (2011) [5] Harlow, F., Welch, J. Numerical calculation of time-dependent viscous incompressible flow of fluid with free surface, The physics of fluids, 8 (12), PP (1965). [6] Hirt, C.W., Nichols, B.D. Volume of Fluid (VOF) Method for the Dynamics of Free Boundaries, Journal of Computational Physics, 39, PP (1981). [7] Khanpour, M., Zarrati, A.R., Kolahdoozan, M., Numerical simulation of the ow under sluice gates by SPH model Sharif University of Technology, Scientia Iranica,Transactions A: Civil Engineering, 21 (5), pp (2014). [8] Shao, S., E. Lo E. Incompressible SPH method for simulating Newtonian and non-newtonian flows with a free surface, Advances in Water Resources, 26, PP (2003). [9] Fang, J., Parriaux, A., Rentschler, M., Ancey, Ch. Improved SPH method for simulating free surface flows of viscous fluids, Applied Numerical Mathematics, 59, pp. 251_271 (2009). [10] Wang, B.L., Liu, H. Application of SPH method on free surface flows on GPU, Journal of Hydrodynamics, 22(5), PP. 912_914 (2010). [11] Lee, E.S., Xu, C., Moulinec, R., Violeau, D., Laurence, D., Stansby, P. Comparisons of Weakly Compressible and Truly Incompressible Algorithms for the SPH Mesh Free Particle Method, Journal of Computational Physics, 227, PP (2008). [12] Khayyer, A., Gotoh, H. On particle-based simulation of a dam break over a wet bed, J Hydraul 595 Res,48(2), PP (2010). [13] Ozbulut, M. Yildiz, M. Goren, O. A numerical investigation into the correction algorithms for SPH method in modeling violent free surface flows, Journal of Mechanical Sciences, 79, PP (2014). [14] Monaghan, J.J. Simulating free surface flows with SPH, Journal of Computational Physics, 110, PP (1994). [15] Morris, J.P., Fox, P.J., Zhu, Y. Modeling low Reynolds number incompressible flows using SPH, Journal of Computational Physics, 136, PP (1997). [16] Chorin, A.J. Numerical solution of the Navier-Stokes equations, Mathematics of Computation, 22, PP (1968). [17] Cummins, S.J. Rudman, M. An SPH projection method, Journal of Computational Physics, 152, PP (1999). [18] Shao, S., Gotoh, H. Simulating coupled motion of progressive wave and floating curtain wall by SPH-LES model, Coastal Engineering Journal, 46, PP (2004). 13

14 [19] Hu, X.Y., Adams, N.A. An incompressible multi-phase SPH method, Journal of Computational Physics, 227, PP (2007). [20] Xenakis, A.M. Lind, S.J. Stansby, P.K. Rogers, B.D. An incompressible SPH scheme with improved pressure predictions for free-surface generalized Newtonian flows, Journal of Non-Newtonian Fluid Mechanics, 218, PP (2015). [21] Nomeritae, Daly, E. Grimaldi, S. Hong Bui, Ha. Explicite incompressible SPH algorithm for freesurface modeling: A comparison with weakly compressible schemes, Advances in Water Resources, 97, PP (2016). [22] Dalrymple, R.A., Rogers, B.D. Numerical modeling of water waves with the SPH method, Coastal Engineering Journal, 53, PP (2006). [23] Monaghan, J.J. Smoothed particle hydrodynamics, Annu RevAstron Astrophys, 30, PP (1992). [24] Shao, S. Incompressible SPH flow model for wave interactions with porous media, Coastal Engineering Journal, 57, PP (2010). [25] Koshizuka, S., Oka, Y., Moving-Particle Semi-Implicit Method for Fragmentation of Incompressible Fluid, Nuclear Science and Engineering, 123, PP (1996). [26] Ozmen-Cagatay, H., Kocaman, S., Guzel, H. Investigation of dam-break flood waves in a dry channel with a hump, Journal of Hydro-enviroment Research, PP (2014). [27] Soarez Frazao, S., de Bueger, C., Dourson, V., Zech, Y. Dam-break wave over a triangular bottom sill, International conference on fluvial hydraulics, PP (2002). [28] Koshizuka, S., Oka, Y., Tamako, H. A particle method for calculating splashing of incompressible viscous fluid, Int. Conf. Math. Comput. 2, PP (1995). The caption of Figures and tables: Figure 1. The initial geometry of the bumpy channel with dry bed [26] Figure 2. The free surface profiles and pressure field in the present model and the experimental Data of Ozmen- Cagatay et al. [26] at different times for bumpy channel with dry bed. Figure 3. Comparison of the free surface profile between the present model results and the experimental data of Ozmen-Cagatay et al. [26] at different dimensionless time T = (a) 15.16, (b) 17.54, (c) 20.67, (d) 23.05, (e) 29.69, (f) 35.83, (g) 41.84, (h) Figure 4. The location of measurement stations Figure 5. Comparison of the water level between the present model results and the experimental data of Ozmen-Cagatay et al. [26] for time evolution at dimensionless distance X = (a) - 0.6, (b) 0.6, (c) 3, (d) 6, (e) 7, (f) 8. Figure 6..Initial geometry of bumpy channel with wet bed after obstacle [27]. Figure 7. Free surface profile and comparison between the present model results and the experimental data of Soares Frazao et al. [27] at different times for channel with wet bed after the obstacle. 14

15 Figure 8.Comparison of water surface profiles between the present model results and the experimental data of Soares Frazao et al. [27] at different times. Figure 9. Free surface profile and comparison between the present model results and the experimental data of Kushizuka et al. [28] at different times for the channel with rectangular obstacle. Table 1. Maximum of Error calculating at the different dimensionless times shown in figure 3. Table 2. Maximum of Error calculating for points specified in figure 5. Table 3. Maximum of Error calculating at different times shown in figure8. Figure 1 15

16 16

17 Figure 2 17

18 Figure 3 Figure 4 18

19 Figure 5. Figure 6 19

20 Figure 7 20

21 Figure 8 21

22 Figure 9 T 0.5 t g h ) 0 ( / o Table 1 ( h/ h ) Experimental ( h/ h 0) Computational x / h Maximum of Error

23 Table 2. Points ( h/ h 0) Experimental ( h/ h 0) Computational 0.5 T t ( g / ho ) Maximum of Error P1 P2 P3 P4 P5 P Table 3. t(s) Z( m ) Experimental Z( m ) computational X(m) Maximum of Error Sajedeh Farmani received the B.Sc. degree in civil engineering from Bahonar university of Kerman, Iran, in Then, he continued his studies and researches in the fields of Hydraulic engineering. He received the M.Sc. degree in civil (hydraulic) engineering from Bahonar university of Kerman, Iran, in 2014 (with first rank). Now, she is Ph.D. student of civil engineering (hydraulic structures) in Bahonar university of Kerman, Iran. She published more than 6 papers in the international journals and conferences. Her research interests include numerical simulation, dam- break flow, SPH method, numerical modeling of tuned liquid dampers, FEM method in free surface flow and improvement of finite element method in modeling of fluid mechanics. Gholam-Abbas Barani Graduated from UC. Davis at California, USA, 1981 Field of interest is Water resource engineering at present time as civil engineering faculty of Shahid Bahonar University, Kerman since Present situation is professor. Academic activities: a) teaching hydraulics, advanced hydraulics, hydraulic structure and advanced groundwater for BS., MSc and PhD program. b) publishing about 53 papers at international and national journals, presenting and publishing more than 200 paper in national and international conferences. Mahnaz Ghaeini-Hessaroeyeh received her Ph.D. degree in Civil Engineering-Water Engineering of Amirkabir University of Technology in She works as an Assistant Professor in Civil Department of Shahid Bahonar University of Kerman from Jan until now. 23

24 Her research interests include computational fluid dynamics, sediment transport modeling, supercritical flow over hydraulic structures, dam-break flow over movable beds and numerical modeling of ground water flow. She has contributed/presented more than 75 papers in various journals and national and international conferences. Rasoul Memarzadeh received the B.Sc. degree in civil engineering from Vali-e-Asr university of Rafsanjan, Iran, in Then, he continued his studies and researches in the fields of Water and Hydraulic engineering. He received the M.Sc. degree in civil (hydraulic) engineering from the Khaje Nasirodin Toosi university of technology, Tehran, Iran, in 2012 (with first rank), and Ph.D. degree in civil (hydraulic structures) engineering from the Shahid Bahonar University of Kerman, Iran, in 2017 (with first rank), respectively. He published more than 15 papers in the international journals and conferences. His current research interests include hydraulic engineering, fluid mechanics, numerical simulation, computational fluid mechanics (CFD), meshless methods, SPH method, waves and currents, multi-phase flows and sediment transport. 24

A stable moving-particle semi-implicit method for free surface flows

A stable moving-particle semi-implicit method for free surface flows Fluid Dynamics Research 38 (2006) 241 256 A stable moving-particle semi-implicit method for free surface flows B. Ataie-Ashtiani, Leila Farhadi Department of Civil Engineering, Sharif University of Technology,

More information

Technical Report TR

Technical Report TR Technical Report TR-2015-09 Boundary condition enforcing methods for smoothed particle hydrodynamics Arman Pazouki 1, Baofang Song 2, Dan Negrut 1 1 University of Wisconsin-Madison, Madison, WI, 53706-1572,

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

Available online at ScienceDirect. Procedia Engineering 126 (2015 )

Available online at   ScienceDirect. Procedia Engineering 126 (2015 ) Available online at www.sciencedirect.com ScienceDirect Procedia Engineering 6 (05 ) 660 664 7th International Conference on Fluid Mechanics, ICFM7 Simulate wave body interaction based on the incompressible

More information

Realistic Animation of Fluids

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

More information

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

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

More information

Divergence-Free Smoothed Particle Hydrodynamics

Divergence-Free Smoothed Particle Hydrodynamics Copyright of figures and other materials in the paper belongs to original authors. Divergence-Free Smoothed Particle Hydrodynamics Bender et al. SCA 2015 Presented by MyungJin Choi 2016-11-26 1. Introduction

More information

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

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

More information

MODELLING THE FLOW AROUND AN ISLAND AND A HEADLAND: APPLICATION OF A TWO MIXING LENGTH MODEL WITH TELEMAC3D. Nicolas Chini 1 and Peter K.

MODELLING THE FLOW AROUND AN ISLAND AND A HEADLAND: APPLICATION OF A TWO MIXING LENGTH MODEL WITH TELEMAC3D. Nicolas Chini 1 and Peter K. MODELLING THE FLOW AROUND AN ISLAND AND A HEADLAND: APPLICATION OF A TWO MIXING LENGTH MODEL WITH TELEMAC3D Nicolas Chini 1 and Peter K. Stansby 2 Numerical modelling of the circulation around islands

More information

This is a repository copy of Incompressible SPH simulation of open channel flow over smooth bed.

This is a repository copy of Incompressible SPH simulation of open channel flow over smooth bed. This is a repository copy of Incompressible SPH simulation of open channel flow over smooth bed. White Rose Research Online URL for this paper: http://eprints.whiterose.ac.uk/90419/ Version: Accepted Version

More information

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

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

More information

Characteristic Aspects of SPH Solutions

Characteristic Aspects of SPH Solutions Characteristic Aspects of SPH Solutions for Free Surface Problems: Source and Possible Treatment of High Frequency Numerical Oscillations of Local Loads. A. Colagrossi*, D. Le Touzé & G.Colicchio* *INSEAN

More information

2D numerical simulation of ocean waves

2D numerical simulation of ocean waves 2D numerical simulation of ocean waves Qingjie. Du,*, Y.C. Dennis. Leung Department of Mechanical Engineering, The University of Hong Kong, Hong Kong, China * Corresponding author. Tel: +852 51743593,

More information

International Journal of Scientific & Engineering Research, Volume 5, Issue 1, january-2014 ISSN

International Journal of Scientific & Engineering Research, Volume 5, Issue 1, january-2014 ISSN International Journal of Scientific & Engineering Research, Volume 5, Issue, january-204 05 Simulation of Dam Break Using Modified Incompressile Smoothed articles Hydrodynamics (MM-I-SH) Dr.Mahmoud Reza

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

IMPROVED WALL BOUNDARY CONDITIONS WITH IMPLICITLY DEFINED WALLS FOR PARTICLE BASED FLUID SIMULATION

IMPROVED WALL BOUNDARY CONDITIONS WITH IMPLICITLY DEFINED WALLS FOR PARTICLE BASED FLUID SIMULATION 6th European Conference on Computational Mechanics (ECCM 6) 7th European Conference on Computational Fluid Dynamics (ECFD 7) 1115 June 2018, Glasgow, UK IMPROVED WALL BOUNDARY CONDITIONS WITH IMPLICITLY

More information

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

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

More information

NUMERICAL MODELING STUDY FOR FLOW PATTERN CHANGES INDUCED BY SINGLE GROYNE

NUMERICAL MODELING STUDY FOR FLOW PATTERN CHANGES INDUCED BY SINGLE GROYNE NUMERICAL MODELING STUDY FOR FLOW PATTERN CHANGES INDUCED BY SINGLE GROYNE Jungseok Ho 1, Hong Koo Yeo 2, Julie Coonrod 3, and Won-Sik Ahn 4 1 Research Assistant Professor, Dept. of Civil Engineering,

More information

Investigation of cross flow over a circular cylinder at low Re using the Immersed Boundary Method (IBM)

Investigation of cross flow over a circular cylinder at low Re using the Immersed Boundary Method (IBM) Computational Methods and Experimental Measurements XVII 235 Investigation of cross flow over a circular cylinder at low Re using the Immersed Boundary Method (IBM) K. Rehman Department of Mechanical Engineering,

More information

Navier-Stokes & Flow Simulation

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

More information

Numerical Simulation of Coastal Wave Processes with the Use of Smoothed Particle Hydrodynamics (SPH) Method

Numerical Simulation of Coastal Wave Processes with the Use of Smoothed Particle Hydrodynamics (SPH) Method Aristotle University of Thessaloniki Faculty of Engineering Department of Civil Engineering Division of Hydraulics and Environmental Engineering Laboratory of Maritime Engineering Christos V. Makris Dipl.

More information

Numerical simulations of dam-break floods with MPM

Numerical simulations of dam-break floods with MPM Available online at www.sciencedirect.com ScienceDirect Procedia Engineering 00 (206) 000 000 www.elsevier.com/locate/procedia st International Conference on the Material Point Method, MPM 207 Numerical

More information

Transfer and pouring processes of casting by smoothed particle. hydrodynamic method

Transfer and pouring processes of casting by smoothed particle. hydrodynamic method Transfer and pouring processes of casting by smoothed particle hydrodynamic method M. Kazama¹, K. Ogasawara¹, *T. Suwa¹, H. Ito 2, and Y. Maeda 2 1 Application development div., Next generation technical

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

Numerical Modeling Study for Fish Screen at River Intake Channel ; PH (505) ; FAX (505) ;

Numerical Modeling Study for Fish Screen at River Intake Channel ; PH (505) ; FAX (505) ; Numerical Modeling Study for Fish Screen at River Intake Channel Jungseok Ho 1, Leslie Hanna 2, Brent Mefford 3, and Julie Coonrod 4 1 Department of Civil Engineering, University of New Mexico, Albuquerque,

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

C. A. D. Fraga Filho 1,2, D. F. Pezzin 1 & J. T. A. Chacaltana 1. Abstract

C. A. D. Fraga Filho 1,2, D. F. Pezzin 1 & J. T. A. Chacaltana 1. Abstract Advanced Computational Methods and Experiments in Heat Transfer XIII 15 A numerical study of heat diffusion using the Lagrangian particle SPH method and the Eulerian Finite-Volume method: analysis of convergence,

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

Navier-Stokes & Flow Simulation

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

More information

Support for Multi physics in Chrono

Support for Multi physics in Chrono Support for Multi physics in Chrono The Story Ahead Overview of multi physics strategy in Chrono Summary of handling rigid/flexible body dynamics using Lagrangian approach Summary of handling fluid, and

More information

Acknowledgements. Prof. Dan Negrut Prof. Darryl Thelen Prof. Michael Zinn. SBEL Colleagues: Hammad Mazar, Toby Heyn, Manoj Kumar

Acknowledgements. Prof. Dan Negrut Prof. Darryl Thelen Prof. Michael Zinn. SBEL Colleagues: Hammad Mazar, Toby Heyn, Manoj Kumar Philipp Hahn Acknowledgements Prof. Dan Negrut Prof. Darryl Thelen Prof. Michael Zinn SBEL Colleagues: Hammad Mazar, Toby Heyn, Manoj Kumar 2 Outline Motivation Lumped Mass Model Model properties Simulation

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

A Hybrid Technique Using Particle and Boundary-Element Methods for Wave-Body Interaction Problems

A Hybrid Technique Using Particle and Boundary-Element Methods for Wave-Body Interaction Problems 9th International Conference on Numerical Ship Hydrodynamics Ann Arbor, Michigan, August 5-8, 27 A Hybrid Technique Using Particle and Boundary-Element Methods for Wave-Body Interaction Problems Makoto

More information

Thermal Coupling Method Between SPH Particles and Solid Elements in LS-DYNA

Thermal Coupling Method Between SPH Particles and Solid Elements in LS-DYNA Thermal Coupling Method Between SPH Particles and Solid Elements in LS-DYNA INTRODUCTION: Jingxiao Xu, Jason Wang LSTC Heat transfer is very important in many industrial and geophysical problems. Many

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

1.2 Numerical Solutions of Flow Problems

1.2 Numerical Solutions of Flow Problems 1.2 Numerical Solutions of Flow Problems DIFFERENTIAL EQUATIONS OF MOTION FOR A SIMPLIFIED FLOW PROBLEM Continuity equation for incompressible flow: 0 Momentum (Navier-Stokes) equations for a Newtonian

More information

Numerical Wave Tank Modeling of Hydrodynamics of Permeable Barriers

Numerical Wave Tank Modeling of Hydrodynamics of Permeable Barriers ICHE 2014, Hamburg - Lehfeldt & Kopmann (eds) - 2014 Bundesanstalt für Wasserbau ISBN 978-3-939230-32-8 Numerical Wave Tank Modeling of Hydrodynamics of Permeable Barriers K. Rajendra & R. Balaji Indian

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

Navier-Stokes & Flow Simulation

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

More information

Thermal Coupling Method Between SPH Particles and Solid Elements in LS-DYNA

Thermal Coupling Method Between SPH Particles and Solid Elements in LS-DYNA Thermal Coupling Method Between SPH Particles and Solid Elements in LS-DYNA Jingxiao Xu 1, Jason Wang 2 1 LSTC 2 LSTC 1 Abstract Smooth particles hydrodynamics is a meshfree, Lagrangian particle method

More information

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

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

More information

Application of Finite Volume Method for Structural Analysis

Application of Finite Volume Method for Structural Analysis Application of Finite Volume Method for Structural Analysis Saeed-Reza Sabbagh-Yazdi and Milad Bayatlou Associate Professor, Civil Engineering Department of KNToosi University of Technology, PostGraduate

More information

Isogeometric Analysis of Fluid-Structure Interaction

Isogeometric Analysis of Fluid-Structure Interaction Isogeometric Analysis of Fluid-Structure Interaction Y. Bazilevs, V.M. Calo, T.J.R. Hughes Institute for Computational Engineering and Sciences, The University of Texas at Austin, USA e-mail: {bazily,victor,hughes}@ices.utexas.edu

More information

Computer animation for fluid simulation of a high viscous fluid melting

Computer animation for fluid simulation of a high viscous fluid melting 2 nd WIETE Annual Conference on Engineering and Technology Education 2011 WIETE Pattaya, Thailand, 25-28 January 2011 Computer animation for fluid simulation of a high viscous fluid melting S. Lertkulvanich

More information

Smoothed particle simulation of gravity waves in a multifluid

Smoothed particle simulation of gravity waves in a multifluid Proceedings of the Institution of Civil Engineers Engineering and Computational Mechanics 166 March 213 Issue EM1 Pages 32 39 http://dx.doi.org/1.168/eacm.1.26 Paper 126 Received 11/5/21 Accepted 3/9/21

More information

Hydrodynamic modeling of flow around bridge piers

Hydrodynamic modeling of flow around bridge piers Hydrodynamic modeling of flow around bridge piers E. D. Farsirotou*, J. V. Soulis^, V. D. Dermissis* *Aristotle University of Thessaloniki, Civil Engineering Department, Division of Hydraulics and Environmental

More information

PARALLEL SIMULATION OF A FLUID FLOW BY MEANS OF THE SPH METHOD: OPENMP VS. MPI COMPARISON. Pawe l Wróblewski, Krzysztof Boryczko

PARALLEL SIMULATION OF A FLUID FLOW BY MEANS OF THE SPH METHOD: OPENMP VS. MPI COMPARISON. Pawe l Wróblewski, Krzysztof Boryczko Computing and Informatics, Vol. 28, 2009, 139 150 PARALLEL SIMULATION OF A FLUID FLOW BY MEANS OF THE SPH METHOD: OPENMP VS. MPI COMPARISON Pawe l Wróblewski, Krzysztof Boryczko Department of Computer

More information

Three Dimensional Numerical Simulation of Turbulent Flow Over Spillways

Three Dimensional Numerical Simulation of Turbulent Flow Over Spillways Three Dimensional Numerical Simulation of Turbulent Flow Over Spillways Latif Bouhadji ASL-AQFlow Inc., Sidney, British Columbia, Canada Email: lbouhadji@aslenv.com ABSTRACT Turbulent flows over a spillway

More information

Overview of Traditional Surface Tracking Methods

Overview of Traditional Surface Tracking Methods Liquid Simulation With Mesh-Based Surface Tracking Overview of Traditional Surface Tracking Methods Matthias Müller Introduction Research lead of NVIDIA PhysX team PhysX GPU acc. Game physics engine www.nvidia.com\physx

More information

Three-dimensional simulation of floating wave power device Xixi Pan 1, a, Shiming Wang 1, b, Yongcheng Liang 1, c

Three-dimensional simulation of floating wave power device Xixi Pan 1, a, Shiming Wang 1, b, Yongcheng Liang 1, c International Power, Electronics and Materials Engineering Conference (IPEMEC 2015) Three-dimensional simulation of floating wave power device Xixi Pan 1, a, Shiming Wang 1, b, Yongcheng Liang 1, c 1 Department

More information

Particle-based Fluid Simulation

Particle-based Fluid Simulation Simulation in Computer Graphics Particle-based Fluid Simulation Matthias Teschner Computer Science Department University of Freiburg Application (with Pixar) 10 million fluid + 4 million rigid particles,

More information

Interactive Fluid Simulation using Augmented Reality Interface

Interactive Fluid Simulation using Augmented Reality Interface Interactive Fluid Simulation using Augmented Reality Interface Makoto Fuisawa 1, Hirokazu Kato 1 1 Graduate School of Information Science, Nara Institute of Science and Technology, 8916-5 Takayama, Ikoma,

More information

Coastal impact of a tsunami Review of numerical models

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

More information

INVESTIGATION OF HYDRAULIC PERFORMANCE OF A FLAP TYPE CHECK VALVE USING CFD AND EXPERIMENTAL TECHNIQUE

INVESTIGATION OF HYDRAULIC PERFORMANCE OF A FLAP TYPE CHECK VALVE USING CFD AND EXPERIMENTAL TECHNIQUE International Journal of Mechanical Engineering and Technology (IJMET) Volume 10, Issue 1, January 2019, pp. 409 413, Article ID: IJMET_10_01_042 Available online at http://www.ia aeme.com/ijmet/issues.asp?jtype=ijmet&vtype=

More information

Example 13 - Shock Tube

Example 13 - Shock Tube Example 13 - Shock Tube Summary This famous experiment is interesting for observing the shock-wave propagation. Moreover, this case uses the representation of perfect gas and compares the different formulations:

More information

MODELLING WATER ENTRY OF A WEDGE BY MULTIPHASE SPH METHOD. Kai GONG, Benlong WANG and Hua LIU 1

MODELLING WATER ENTRY OF A WEDGE BY MULTIPHASE SPH METHOD. Kai GONG, Benlong WANG and Hua LIU 1 MODELLING WATER ENTRY OF A WEDGE BY MULTIPHASE SPH METHOD Kai GONG, Benlong WANG and Hua LIU The hydrodynamic problem of two-dimensional wedge entering water is studied based on SPH model. A nonreflection

More information

Interaction of Fluid Simulation Based on PhysX Physics Engine. Huibai Wang, Jianfei Wan, Fengquan Zhang

Interaction of Fluid Simulation Based on PhysX Physics Engine. Huibai Wang, Jianfei Wan, Fengquan Zhang 4th International Conference on Sensors, Measurement and Intelligent Materials (ICSMIM 2015) Interaction of Fluid Simulation Based on PhysX Physics Engine Huibai Wang, Jianfei Wan, Fengquan Zhang College

More information

Water. Notes. Free surface. Boundary conditions. This week: extend our 3D flow solver to full 3D water We need to add two things:

Water. Notes. Free surface. Boundary conditions. This week: extend our 3D flow solver to full 3D water We need to add two things: Notes Added a 2D cross-section viewer for assignment 6 Not great, but an alternative if the full 3d viewer isn t working for you Warning about the formulas in Fedkiw, Stam, and Jensen - maybe not right

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

Lax-Wendroff and McCormack Schemes for Numerical Simulation of Unsteady Gradually and Rapidly Varied Open Channel Flow

Lax-Wendroff and McCormack Schemes for Numerical Simulation of Unsteady Gradually and Rapidly Varied Open Channel Flow Archives of Hydro-Engineering and Environmental Mechanics Vol. 60 (2013), No. 1 4, pp. 51 62 DOI: 10.2478/heem-2013-0008 IBW PAN, ISSN 1231 3726 Lax-Wendroff and McCormack Schemes for Numerical Simulation

More information

A higher-order finite volume method with collocated grid arrangement for incompressible flows

A higher-order finite volume method with collocated grid arrangement for incompressible flows Computational Methods and Experimental Measurements XVII 109 A higher-order finite volume method with collocated grid arrangement for incompressible flows L. Ramirez 1, X. Nogueira 1, S. Khelladi 2, J.

More information

Smoke Simulation using Smoothed Particle Hydrodynamics (SPH) Shruti Jain MSc Computer Animation and Visual Eects Bournemouth University

Smoke Simulation using Smoothed Particle Hydrodynamics (SPH) Shruti Jain MSc Computer Animation and Visual Eects Bournemouth University Smoke Simulation using Smoothed Particle Hydrodynamics (SPH) Shruti Jain MSc Computer Animation and Visual Eects Bournemouth University 21st November 2014 1 Abstract This report is based on the implementation

More information

Tsunami coastal impact The use of VOF-URANS methods with examples

Tsunami coastal impact The use of VOF-URANS methods with examples Tsunami coastal impact The use of VOF-URANS methods with examples Richard MARCER 2 Content Coastal impact : physics to simulate EOLE CFD : a 3D Navier-Stokes code Focus on the VOF free surface method Examples

More information

Aurélien Thinat Stéphane Cordier 1, François Cany

Aurélien Thinat Stéphane Cordier 1, François Cany SimHydro 2012:New trends in simulation - Hydroinformatics and 3D modeling, 12-14 September 2012, Nice Aurélien Thinat, Stéphane Cordier, François Cany Application of OpenFOAM to the study of wave loads

More information

Smooth Particle Hydrodynamics for Surf Zone Waves

Smooth Particle Hydrodynamics for Surf Zone Waves Smooth Particle Hydrodynamics for Surf Zone Waves Robert A. Dalrymple Dept of Civil Engineering The Johns Hopkins University 3400 North Charles Street Baltimore, MD 21218 phone: (410) 516-7923 fax: (410)

More information

Realtime Water Simulation on GPU. Nuttapong Chentanez NVIDIA Research

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

More information

Interactive Fluid Simulation Using Augmented Reality Interface

Interactive Fluid Simulation Using Augmented Reality Interface Interactive Fluid Simulation Using Augmented Reality Interface Makoto Fuisawa and Hirokazu Kato Graduate School of Information Science, Nara Institute of Science and Technology, 8916-5 Takayama, Ikoma,

More information

Numerical study of composite structures subjected to slamming loads using Smoothed Particle Hydrodynamics (SPH)

Numerical study of composite structures subjected to slamming loads using Smoothed Particle Hydrodynamics (SPH) Proceedings of the 8th International Conference on Structural Dynamics, EURODYN 2011 Leuven, Belgium, 4-6 July 2011 G. De Roeck, G. Degrande, G. Lombaert, G. Müller (eds.) ISBN 978-90-760-1931-4 3077 Numerical

More information

Abstract SPH Simulations of Floating Bodies in Waves M. ORING, G. OGER, B. ALESSANRINI, P. FERRANT Fluid Mechanics Laboratory (CNRS UMR6598), Ecole Centrale de Nantes mathieu.doring@ec-nantes.fr Water

More information

Modeling Khowr-e Musa Multi-Branch Estuary Currents due to the Persian Gulf Tides Using NASIR Depth Average Flow Solver

Modeling Khowr-e Musa Multi-Branch Estuary Currents due to the Persian Gulf Tides Using NASIR Depth Average Flow Solver Journal of the Persian Gulf (Marine Science)/Vol.1/No.1/September 2010/6/45-50 Modeling Khowr-e Musa Multi-Branch Estuary Currents due to the Persian Gulf Tides Using NASIR Depth Average Flow Solver Sabbagh-Yazdi,

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

Multi-Resolution MPS Method for Free Surface Flows

Multi-Resolution MPS Method for Free Surface Flows International Journal of Computational Methods Vol. 13, No. 4 (2016) 1641018 (17 pages) c World Scientific Publishing Company DOI: 10.1142/S0219876216410188 Multi-Resolution MPS Method for Free Surface

More information

1.6 Smoothed particle hydrodynamics (SPH)

1.6 Smoothed particle hydrodynamics (SPH) 26 Smoothed Particle Hydrodynamics 1.6 Smoothed particle hydrodynamics (SPH) 1.6.1 The SPH method In the SPH method, the state of a system is represented by a set of particles, which possess individual

More information

Robust Simulation of Sparsely Sampled Thin Features in SPH-Based Free Surface Flows

Robust Simulation of Sparsely Sampled Thin Features in SPH-Based Free Surface Flows Copyright of figures and other materials in the paper belong to original authors. Robust Simulation of Sparsely Sampled Thin Features in SPH-Based Free Surface Flows Xiaowei He et al. ACM SIGGRAPH 2015

More information

Computational Fluid Dynamics using OpenCL a Practical Introduction

Computational Fluid Dynamics using OpenCL a Practical Introduction 19th International Congress on Modelling and Simulation, Perth, Australia, 12 16 December 2011 http://mssanz.org.au/modsim2011 Computational Fluid Dynamics using OpenCL a Practical Introduction T Bednarz

More information

A review on approaches to solving Poisson s equation in projection-based meshless methods for modelling strongly nonlinear water waves

A review on approaches to solving Poisson s equation in projection-based meshless methods for modelling strongly nonlinear water waves J. Ocean Eng. Mar. Energy (2016) 2:279 299 DOI 10.1007/s40722-016-0063-5 REVIEW ARTICLE A review on approaches to solving Poisson s equation in projection-based meshless methods for modelling strongly

More information

CS 231. Fluid simulation

CS 231. Fluid simulation CS 231 Fluid simulation Why Simulate Fluids? Feature film special effects Computer games Medicine (e.g. blood flow in heart) Because it s fun Fluid Simulation Called Computational Fluid Dynamics (CFD)

More information

Introducion to Hydrologic Engineering Centers River Analysis System (HEC- RAS) Neena Isaac Scientist D CWPRS, Pune -24

Introducion to Hydrologic Engineering Centers River Analysis System (HEC- RAS) Neena Isaac Scientist D CWPRS, Pune -24 Introducion to Hydrologic Engineering Centers River Analysis System (HEC- RAS) Neena Isaac Scientist D CWPRS, Pune -24 One dimensional river models (1-D models) Assumptions Flow is one dimensional Streamline

More information

Comparison of Central and Upwind Flux Averaging in Overlapping Finite Volume Methods for Simulation of Super-Critical Flow with Shock Waves

Comparison of Central and Upwind Flux Averaging in Overlapping Finite Volume Methods for Simulation of Super-Critical Flow with Shock Waves Proceedings of the 9th WSEAS International Conference on Applied Mathematics, Istanbul, Turkey, May 7, 6 (pp55665) Comparison of and Flux Averaging in Overlapping Finite Volume Methods for Simulation of

More information

GPU Simulations of Violent Flows with Smooth Particle Hydrodynamics (SPH) Method

GPU Simulations of Violent Flows with Smooth Particle Hydrodynamics (SPH) Method Available online at www.prace-ri.eu Partnership for Advanced Computing in Europe GPU Simulations of Violent Flows with Smooth Particle Hydrodynamics (SPH) Method T. Arslan a*, M. Özbulut b a Norwegian

More information

Module 1: Introduction to Finite Difference Method and Fundamentals of CFD Lecture 13: The Lecture deals with:

Module 1: Introduction to Finite Difference Method and Fundamentals of CFD Lecture 13: The Lecture deals with: The Lecture deals with: Some more Suggestions for Improvement of Discretization Schemes Some Non-Trivial Problems with Discretized Equations file:///d /chitra/nptel_phase2/mechanical/cfd/lecture13/13_1.htm[6/20/2012

More information

Investigating The Stability of The Balance-force Continuum Surface Force Model of Surface Tension In Interfacial Flow

Investigating The Stability of The Balance-force Continuum Surface Force Model of Surface Tension In Interfacial Flow Investigating The Stability of The Balance-force Continuum Surface Force Model of Surface Tension In Interfacial Flow Vinh The Nguyen University of Massachusetts Dartmouth Computational Science Training

More information

A brief description of the particle finite element method (PFEM2). Extensions to free surface

A brief description of the particle finite element method (PFEM2). Extensions to free surface A brief description of the particle finite element method (PFEM2). Extensions to free surface flows. Juan M. Gimenez, L.M. González, CIMEC Universidad Nacional del Litoral (UNL) Santa Fe, Argentina Universidad

More information

LS-DYNA 980 : Recent Developments, Application Areas and Validation Process of the Incompressible fluid solver (ICFD) in LS-DYNA.

LS-DYNA 980 : Recent Developments, Application Areas and Validation Process of the Incompressible fluid solver (ICFD) in LS-DYNA. 12 th International LS-DYNA Users Conference FSI/ALE(1) LS-DYNA 980 : Recent Developments, Application Areas and Validation Process of the Incompressible fluid solver (ICFD) in LS-DYNA Part 1 Facundo Del

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

ENERGY-224 Reservoir Simulation Project Report. Ala Alzayer

ENERGY-224 Reservoir Simulation Project Report. Ala Alzayer ENERGY-224 Reservoir Simulation Project Report Ala Alzayer Autumn Quarter December 3, 2014 Contents 1 Objective 2 2 Governing Equations 2 3 Methodolgy 3 3.1 BlockMesh.........................................

More information

Modelling of Impact on a Fuel Tank Using Smoothed Particle Hydrodynamics

Modelling of Impact on a Fuel Tank Using Smoothed Particle Hydrodynamics Modelling of Impact on a Fuel Tank Using Smoothed Particle Hydrodynamics R. Vignjevic a, T. De Vuyst a, J. Campbell a, N. Bourne b School of Engineering, Cranfield University, Bedfordshire, MK43 0AL, UK.

More information

A singular value decomposition based generalized finite difference method for fluid solid interaction problems

A singular value decomposition based generalized finite difference method for fluid solid interaction problems Fluid Structure Interaction V 25 A singular value decomposition based generalized finite difference method for fluid solid interaction problems P. Yu, K. S. Yeo, X. Y. Wang & S. J. Ang Department of Mechanical

More information

Effect of reservoir side slopes on dam-break flood waves

Effect of reservoir side slopes on dam-break flood waves Engineering Applications of Computational Fluid Mechanics ISSN: 1994-2060 (Print) 1997-003X (Online) Journal homepage: https://www.tandfonline.com/loi/tcfm20 Effect of reservoir side slopes on dam-break

More information

Numerical and experimental investigations into liquid sloshing in a rectangular tank

Numerical and experimental investigations into liquid sloshing in a rectangular tank The 2012 World Congress on Advances in Civil, Environmental, and Materials Research (ACEM 12) Seoul, Korea, August 26-30, 2012 Numerical and experimental investigations into liquid sloshing in a rectangular

More information

International Engineering Research Journal Numerical Modeling of Flow over Ogee Crested Spillway under Radial Gate

International Engineering Research Journal Numerical Modeling of Flow over Ogee Crested Spillway under Radial Gate Numerical Modeling of Flow over Ogee Crested Spillway under Radial Vishal Date 1, Tapobrata Dey 1 and Shashikant Joshi 2 1 Mechanical Engineering Dept., D Y Patil College of Engineering Akurdi, SPPU, Pune,

More information

DAM-BREAK FLOW IN A CHANNEL WITH A SUDDEN ENLARGEMENT

DAM-BREAK FLOW IN A CHANNEL WITH A SUDDEN ENLARGEMENT THEME C: Dam Break 221 DAM-BREAK FLOW IN A CHANNEL WITH A SUDDEN ENLARGEMENT Soares Frazão S. 1,2, Lories D. 1, Taminiau S. 1 and Zech Y. 1 1 Université catholique de Louvain, Civil Engineering Department

More information

CFD-1. Introduction: What is CFD? T. J. Craft. Msc CFD-1. CFD: Computational Fluid Dynamics

CFD-1. Introduction: What is CFD? T. J. Craft. Msc CFD-1. CFD: Computational Fluid Dynamics School of Mechanical Aerospace and Civil Engineering CFD-1 T. J. Craft George Begg Building, C41 Msc CFD-1 Reading: J. Ferziger, M. Peric, Computational Methods for Fluid Dynamics H.K. Versteeg, W. Malalasekara,

More information

Simulation of Transient and Three-Dimensional Coating Flows Using a Volume-of-Fluid Technique

Simulation of Transient and Three-Dimensional Coating Flows Using a Volume-of-Fluid Technique Simulation of Transient and Three-Dimensional Coating Flows Using a Volume-of-Fluid Technique C.W. Hirt and J.E. Richardson, Flow Science, Inc., 1257 40th, Los Alamos, NM 87544 and Ken S. Chen, Sandia

More information

2-D Tank Sloshing Using the Coupled Eulerian- LaGrangian (CEL) Capability of Abaqus/Explicit

2-D Tank Sloshing Using the Coupled Eulerian- LaGrangian (CEL) Capability of Abaqus/Explicit 2-D Tank Sloshing Using the Coupled Eulerian- LaGrangian (CEL) Capability of Abaqus/Explicit Jeff D. Tippmann, Sharat C. Prasad 2, and Parthiv N. Shah ATA Engineering, Inc. San Diego, CA 923 2 Dassault

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

A Direct Simulation-Based Study of Radiance in a Dynamic Ocean

A Direct Simulation-Based Study of Radiance in a Dynamic Ocean 1 DISTRIBUTION STATEMENT A. Approved for public release; distribution is unlimited. A Direct Simulation-Based Study of Radiance in a Dynamic Ocean LONG-TERM GOALS Dick K.P. Yue Center for Ocean Engineering

More information

Parallelization study of a VOF/Navier-Stokes model for 3D unstructured staggered meshes

Parallelization study of a VOF/Navier-Stokes model for 3D unstructured staggered meshes Parallelization study of a VOF/Navier-Stokes model for 3D unstructured staggered meshes L. Jofre, O. Lehmkuhl, R. Borrell, J. Castro and A. Oliva Corresponding author: cttc@cttc.upc.edu Centre Tecnològic

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

The viscous forces on the cylinder are proportional to the gradient of the velocity field at the

The viscous forces on the cylinder are proportional to the gradient of the velocity field at the Fluid Dynamics Models : Flow Past a Cylinder Flow Past a Cylinder Introduction The flow of fluid behind a blunt body such as an automobile is difficult to compute due to the unsteady flows. The wake behind

More information