Comparison between incompressible SPH solvers

Size: px
Start display at page:

Download "Comparison between incompressible SPH solvers"

Transcription

1 st International Conference on Control Systems and Computer Science Comparison between incompressible SPH solvers Claudiu Baronea, Adrian Cojocaru, Mihai Francu, Anca Morar, Victor Asavei Computer Science and Engineering Department University POLITEHNICA of Bucharest Bucharest, Romania Abstract In this paper, we present two high performing and efficient Smoothed Particle Hydrodynamics (SPH) methods used to physically simulate incompressible fluids: Implicit Incompressible SPH (IISPH) and Divergence-Free SPH (DFSPH). At the moment, the most stable SPH methods employ correctors that reduce the error of the fluid particles to achieve very low levels of compressibility. We analyze the performance of the correctors used for the methods previously mentioned. We also compare IISPH against DFSPH to study several characteristics such as the stability of the particles, the compressibility levels of the fluid achieved during the simulations, the execution speed of each corrector, the maximum possible increase of the time steps, etc. Keywords SPH, corrector, incompressibility, fluids, stability, time step I. INTRODUCTION The Smoothed Particle Hydrodynamics (SPH) method was developed by Monaghan and Gingold and Lucy in 1977 for astrophysics studies [5]. However, over the years, SPH has often been used to study and simulate other fields such as volcanology, oceanography, fluid dynamics, etc. SPH is based on the Navier-Stokes equations which best describe incompressible, isothermal fluids: the continuity equation (1) and the momentum equation (2). It is a mesh-, Lagrangian method that can be used to represent and discretize the fluid as a collection of particles. A. SPH Interpolation Each fluid particle has its own mass and can store various fluid quantities at certain points in the fluid, such as velocity,, pressure, viscosity, external forces, etc. In order to find such a quantity,, of a given particle at an arbitrary position,, SPH uses equation (3) to interpolate using the same type of quantities,, of all the neighboring particles. (1) B. Smoothing Kernels An important component of equation (3) and, at the same time, an essential aspect of every SPH method is the smoothing kernel W - a function that weights the quantities of the particles in the vicinity of the current particle based on position.. A neighboring particle that is close to the queried one contributes more to the evaluation compared to particles farther away. We can consider the general form of the kernel function given by equation (4), as presented in [2], where h represents the smoothing radius of the kernel and d represents the number of dimensions of the simulation domain. Most SPH implementations use a polynomial form for the kernel function as described in [5]. Although it is very efficiently computed, this kernel presents one important disadvantage. If used to obtain the pressure forces, the particles will tend to cluster together and produce sticking artifacts because the function s gradient nears zero when the particles get very close to each other, reducing the repulsion forces. To prevent this, [3] replaces the polynomial kernel with a spiky one when computing the pressure forces. However, both the polynomial and the spiky kernel have negative Laplacians that produce further repulsion forces when computing the viscosity forces, making the simulation unstable. To correct this, another kernel is used for the viscous terms, the viscosity kernel as presented in [3]. (2) (3) (4) /17 $ IEEE DOI /CSCS

2 C. Time Integration Usually, time integration schemes can be classified as either explicit or implicit. While implicit schemes that consider both the current state and the next state of the simulation use large time steps that are advantageous for real time rendering, they need, however, large execution times per simulation step. In contrast to implicit schemes, explicit integration schemes use only the current state of the simulation and require small execution times per simulation step but require smaller time steps for the integration. SPH methods usually employ explicit methods such as Verlet and Leap-Frog time integration schemes. In the case of Leap-Frog, the positions and velocities of the current state are forwarded in time using the time step and forces acting on particles in the current simulation step. In this paper, we compare two incompressible methods: IISPH and DFSPH. We present several implementation details and we show how each algorithm works. In addition, we study the correctors employed in each method. Also, we analyze and compare their performances: what level of compressibility can they reach, how fast and accurate the correctors are, etc. II. RELATED WORK Many SPH algorithms have been implemented to improve fluid simulations as much as possible, visual and computational wise. In [5], Monaghan uses state equations to weakly enforce incompressibility by penalizing errors using a user defined stiffness value relative to the speed of sound. The straightforward computation of pressure values makes Standard SPH (SSPH) well suited for efficient simulation of compressible fluids. For weakly compressible fluids, Weakly Compressible SPH (WCSPH) uses a stiff equation of state (EOS) that imposes a severe time step restriction that reduces the overall performance since lower compressibility requires smaller time steps, as per [7]. Some of the best performing SPH algorithms are those that aim to achieve a compressibility level as low as possible - these systems are often labeled as Incompressible SPH. These SPH methods first integrate the velocity field in time without enforcing incompressibility. Secondly, the resulting variation in particle or intermediate velocity field are projected onto a space to satisfy incompressibility through a pressure Poisson equation. This concept is known as splitting, as presented in [8], [9]. Some of the most notable incompressible SPH methods that are worth mentioned are: Predictive-Corrective Incompressible SPH (PCISPH) [3], Implicit Incompressible SPH (IISPH), Divergence-Free SPH (DFSPH). Predictor-corrector methods, Predictive-Corrective Incompressible SPH [3] and local Poisson SPH [10] model pressure forces as a constraint force that resolves compression generated by the non-pressure forces. This is done by iteratively predicting and correcting the particle positions based on an EOS. Implicit Incompressible SPH [2] employs a discretized form of the continuity equation (1) and computes symmetric pressure forces using Relaxed Jacobi in order to obtain a semi-implicit predictor. In addition, it considers velocity instead of positions to compute deviations. IISPH has proven to reduce the deviations down to 0.01%, at the same time allowing large time steps, making it a robust choice for real time fluid simulations. Divergence-Free SPH [1] combines two solvers to obtain volume compression below 0.01%, at the same time making it possible to use large time steps. First, it uses a solver to minimize the deviation, thus enforcing incompressibility on position level. The second solver enforces a - state of the fluid particles, enforcing incompressibility on velocity level and increasing particle stability. DFSPH can simulate complex scenes consisting of more than 5 million fluid particles and 40 million boundary particles. III. DIVERGENCE FREE SPH Incompressible SPH methods try to reduce fluid compression levels to acceptable values by correcting the pressure forces acting on the particles. This is equivalent to solving systems of equations resulted from the state of the particles. The algorithms that solve these systems of equations are called pressure solvers and are usually built around iterative methods (or relaxation methods) able to solve linear and nonlinear equation systems. One example of a relaxation method for SPH simulations is the Jacobi Iteration, useful in determining solutions for diagonally dominant systems of equations. Both SPH methods analyzed in this paper use Relaxed Jacobi pressure solvers. However, DFSPH combines two such Relaxed Jacobi based pressure solvers to correct both the variation and the error in the same simulation step. As such, a -field corrector maintains a small change rate, while the solver corrects the variations resulted from computational errors. This section further analyses the two pressure solvers used in [1], presenting the main implementation aspects and the advantages resulted from their approach. 272

3 A. Divergence Free Solver The first pressure solver ensures a near - velocity field by enforcing a velocity as close to zero as possible, meaning that the of the fluid does not change over time. If, for a certain particle, this condition is not fulfilled the solver computes a set of pressure forces using Jacobi iteration to change the velocities of the particle and its neighbors enough to ensure that [1]. The force created by the pressure of the ith particle is given by equation (5), where is the of the i th particle, is the gradient operator, represents the mass of the j th particle and is the fluid stiffness parameter. Also, the pressure forces exercised by the i th particle upon each of its neighboring particles are computed using equation (6). The change rate can be expressed using particle velocities (equation (7)) as described in [2]. (5) (6) (7) Keeping in mind that the pressure forces and cause velocity changes between two consecutive simulation steps, equation (7) can be rewritten to emphasize the contribution of the pressures. Furthermore, we can substitute the pressure force terms with equations (5) and (6), thus obtaining equation (8). (8) (9) According to [1], in order to compute the correct particle velocities to obtain a small change rate, the stiffness factor of each particle must be found. Using equation (9), the stiffness factor can be expressed with equation (10), where is a scalar factor computed using only particle positions as described in equation (11). Because depends solely on the positions of the particles, it is computed only at the beginning of each simulation step and used in both solvers. Using the stiffness from equation (10) we can compute the new pressure forces that fulfill the condition as per equation (12) [1]. (10) (11) (12) Below, we present our own implementation of the pressure solver used to correct the - error. At the beginning of each iteration, the average change rate is reinitialized to zero and recomputed at the end of the first loop. Each particle s change rate is computed and used to obtain the stiffness factors for all the parcels. The solvers iterate as long as the average change rate is above a certain, user defined threshold. Finally, the velocities of the particles are updated with regard to the total pressure forces that correct the error. In contrast to the solver algorithm presented in [1], we compute the stiffness factor for each particle at the same time as the change rate because the value of does not depend on the quantities of other particles. Second, because in our simulations all particles have the same mass, we moved the parameter outside of the summation as a minor optimization. DivergenceZeroSolver(particleList) i i B. Constant Density Solver Figure Divergence solver The second solver used for the DFSPH algorithm is the solver which corrects the variation in relation to the rest. As with the - 273

4 solver, this solver also uses the scalar factor in its computations, conferring the advantage of speed. The algorithm is outlined in Fig and is similar to the previous one; it runs until the average variation with respect to the rest lowers below a user defined threshold. Each iteration starts by computing the predicted for the i th particle, according to [1]. ConstantDensitySolver(particleList) i i Figure Constant solver overall performance. Note that, similar to the error solver, the stiffness factor is computed at the same time with advected. IV. IMPLICIT INCOMPRESSIBLE SPH Standard SPH methods employ an equation of state (EOS) in order to compute pressure forces that lower the compression rate. An alternative solution to EOS based SPH algorithms, projection schemes are used to calculate intermediate velocities without prior extraction of pressure forces. Also, a Poisson Pressure Equation (PPE) is solved to compute the pressure forces necessary to correct the intermediate velocities to a state. However, projectionbased SPH schemes are considered impractical in the context of computer graphics, the main reason being that their performance does not scale well with the size of the simulation. The method proposed in [2] addresses this point, using a discretization of the PPE that significantly improves the convergence of the solver and the stability of the time integration scheme. The pressure of a particle is computed using the equation of state (15), where is the rest of the fluid, and control the stiffness. Moment preserving pressure forces are computed using equation (16). (15) Finally, the stiffness factor needed to compute the pressure forces that correct the error is calculated in a similar way as in the - solver (equation (13)), which leads to equation (14) for computing the stiffness factor. A. Derivation (16) (13) (14) As stated above, due to the fact that the scalar factor is precomputed at the beginning of each simulation step and then used in both the field corrector and the variation corrector without needing any other modifications or updates, both solvers are very cheap computational-wise, needing very small CPU time. Also, due to the usage of the - solver to correct the velocities of the particles, the solver doesn t need as many as other pressure solvers to obtain a satisfying error. This also means that the system becomes very stable, allowing larger time steps. This, in turn, means that the neighborhood query, one of the most expensive operations per simulation step, is done less frequently for each particle, giving an increase to the The IISPH method considers the change rate and the continuity equation presented in (1) to obtain a predictor that uses both the current and the next value for the particle, as described in (19). (19) This semi-implicit predictor uses, however, unknown velocities dependent on pressure forces at time t. To compute these unknown factors, IISPH updates the positions and velocities using a semi-implicit Euler scheme. The particle velocities can be thus obtained as in (20) using unknown pressure forces and known forces such as gravity, surface tension, viscosity (. In order to predict the in (22), IISPH uses the advected velocities obtained as in (21). 274

5 (20) (21) (22) (26) (27) (23) Equation (23) describes the deviation from the rest considering in (19). From (16) and (23) a linear system is obtained which uses one equation and one unknown pressure value for each particle. B. Relaxed Jacobi (24) IISPH uses a relaxed Jacobi to iteratively solve equation system (24) for each particle pressure as in (25). (25) where is the relaxation factor ([2] suggests an optimal convergence for value 0.5). In order to compute this, and are computed using (26), where the first term represents (displacement of i due to pressure) and the second (movement caused by the pressure of neighboring particles). Using (26), (23) and denoting the neighbors of j with k yields the equation (27). Note that are computed using equation (28) and pressures are evaluated using (29). Figures and present the pressure solver used in IISPH method to compute the advected densities and velocities of the fluid particles. The first module iterates through the fluid particles in order to compute the densities, the velocities and the displacement factors of each particle. A second loop is necessary to compute the advected. The second module computes the pressures corresponding to the next state of the equation by calculating the movement caused by the pressures to each particle,. (28) V. PERFORMANCE COMPARISON DFSPH vs IISPH (29) The following section analyzes the behavior of the two algorithms described so far - Divergence-Free SPH [1] and Implicit Incompressible SPH [2] - and presents the results obtained using our own sequential implementations, on two simulation scenarios: breaking dam and -fall cube. Both SPH implementations used 125k particles to discretize the fluid body in the breaking dam scenario (fig ). For rigid body approximations, we employed a twoway coupling method using boundary particles as described in [11]. Also, to ensure a good approximation of continuous surfaces, we oversampled the objects four times compared to the smoothing kernel radius. In this regard, the walls and floor that represent the dam used for the simulation were constructed using 18k boundary particles. Although these particles do not change positions between successive states, they are included in the neighborhood queries and in the solver. We first executed the simulation using DFSPH method. We used the spiky smoothing kernel [3] for the solvers and for the computation of the change rate. Although we did not go for the cubic spline as in [1], we did use the same kernel for both solvers to ensure the symmetry between - and solvers so that they behave well when executed sequentially. We used a lookup table to discretize the scalar and the gradient values of the kernel to optimize the computations of, forces and other required factors. To this extent, we used a resolution of 1000 samples for the discretization process. Although the algorithm presented in [1] uses warm 275

6 (ms) average solver DFSPH max solver max error average solver IISPH max solver max error Table Breaking Dam scenario. DFSPH vs IISPH Pressure Solve() i i Predict Advection() i i Figure Advection Predictor Figure IISPH pressure solver start-ups for both solvers in each simulation step to improve the computations and lower the number of, we did not use warm start-ups in our own scenarios. After executing the simulation, we obtained the data presented in Table 1.0. For large times steps (i.e. 2.5 ms, 5 ms) the solver has higher iteration spikes compared to the solver, but behaves better in average with fewer over the entire simulation, the corrector needing only 2 to converge compared to 3 for the solver, results similar to those illustrated in [1]. For smaller time steps, the average and the maximum number of per solver are very close in value because, for small time steps, the deviations are small enough that the solvers do not need to execute too much to converge. In such cases, the corrector generally needs only 1 iteration, while the corrector needs no more than 2 to obtain very good results. We can observe that the solver obtains very low variations, regardless of the size of the time step. We conclude, from the simulation results, that the DFSPH solvers need a small number of to converge to our thresholds and give very small variations. This means that the compressibility of our simulations is under 0.01%. Because the - solver is executed first and obtains a very small change rate, the solver doesn t need too many to converge and offers an acceptable error. As previously stated, we also ran the IISPH implementation on the breaking dam. For a time step of 5ms, the corrector used in IISPH needs an average of 42 to converge, with an iteration spike of 87. While, for the same time step, both DFSPH solvers need around 5-6 to converge, the IISPH solver needs 7 times more to obtain good variations to bring the compressibility below 0.01%. At the same time, the corrector used in DFSPH outclasses the one used in IISPH, the first one obtaining a variation of , while the latter one resulted in a variation of

7 (ms) average solver DFSPH max solver max error average solver IISPH max solver max error Table Free Fall Cube. DFSPH vs IISPH For smaller times steps, the IISPH solver does indeed fare better, needing almost the same number of as DFSPH solvers. As the time step is decreased, the number of decrease as well, both the average and the maximum values. However, the error obtained after running the solver does not decrease too much compared to the results of DFSPH simulations. The error remains above for all the time steps used in our simulations. Thus, for the breaking dam simulation scenario, it can be concluded that IISPH behaves poorly compared to DFSPH. The second simulation scenario analyzed is the fall cube. The scene configuration consisted of a cube of 27k fluid particles left to fall on a flat surface approximated by a number of 10k boundary particles. The results are showcased in Table 2.0. In the case of DFSPH, similar to the breaking dam scenario, the - solver has higher iteration spikes than the solver, but a smaller number of on average. Also, if smaller time steps are used, the number of for both solvers decrease, both on average and maximum values. As was the case for the previous scenario, the IISPH solver needs more to converge, both on average and during execution spikes. The error does not decrease too much when using smaller time steps, compared to the improvements DFSPH presents when changing the integration step. The solver are higher for IISPH solver than for DFSPH solvers, regardless of the time step used. The similarity between the results obtained from both scenarios further confirm our analysis and data. We can observe that, indeed, the solvers used for DFSPH are faster than the pressure solver used in IISPH. In both scenarios, the - solver finished in an average of 1 or 2 and the solver in an average of 2 or 3, while, for IISPH, the solver needed much more execution steps. While the error is, indeed, below our threshold using both algorithms, we can clearly see that the DFSPH error is smaller than the IISPH error by at least one order of magnitude for large time steps. Thus, our comparison concludes that, although, both algorithms can achieve very good compressibility levels, DFSPH solvers are, indeed, faster than IISPH s, while still obtaining better, smaller variations. A similar comparison between DFSPH and IISPH using several fixed time steps was also made in [1]. In the case of the first fixed time step of 4 milliseconds, DFSPH solvers finished in an average of 2.8 for the solver and 4.5 for the solver. The summed execution times of both solvers for a simulation of 60 seconds approximated to 45 seconds, while the entire execution time of the algorithm rounded to 51 seconds. However, the IISPH solver was much slower, reaching even 50 per simulation step. The solver execution times reached even seconds, while the total duration of the algorithm was 318 seconds for 60 seconds of simulation. As such, for a time step of 4 ms, the solvers used for DFSPH combined were 6.9 times faster than the IISPH solver. For a fixed time step of 2 milliseconds, the number of for DFSPH solvers was lower, 1.3 for the - solver, and 2.1 for the solver. The execution time of both solvers, summed together, was 47.8 seconds. Even though slightly higher than the previous solver execution duration of 45.2 seconds, we must keep in mind that the time step is two times smaller than the previous one used. On the other hand, IISPH performance had improved compared to the previous tests. The solver needed an average of 21.4 to converge, as opposed to the previous number of 50.5, and a solver execution time of seconds with a total execution time of seconds. However, IISPH still behaved poorly compared to DFSPH for a time step of 2 milliseconds, the latter s solvers being 5.36 times faster and requiring fewer to converge. For small times steps (i.e milliseconds), both methods solvers required almost the same amount of, although the execution times of DFSPH solvers were just slightly lower, seconds compared to seconds. 277

8 Fig Breaking Dam - Initial state Fig Breaking Dam - Intermediate state The comparison performed in [1] confirms our conclusion that DFSPH behaves very well even when large time steps are used. This gives the advantage of better performance since the neighborhood query is necessary less often. VI. CONCLUSIONS In this paper, we presented two, very efficient incompressible SPH methods: Divergence-Free SPH [1] and Implicit Incompressible SPH [2]. We analyzed how each of these methods work and what solvers they use. DFSPH uses two solvers to obtain low compressibility levels: a - solver that minimizes change rate and a solver which aims to lower the error as much as possible. In contrast to DFSPH, IISPH uses only one pressure solver and discretizes the Poisson Pressure Equation to significantly improve the convergence of the corrector and the stability of the time integration scheme. We have also shown how our implementations of both SPH methods behave in two scenarios: the breaking dam scenario and a simpler one, a -falling cube on a flat surface. We compared the results from DFSPH simulation against the IISPH results and concluded that DFSPH solvers behave better than the IISPH solver, they need much fewer to converge and also yield better, smaller errors. VII. ACKNOWLEDGEMENT This work has been funded by University Politehnica of Bucharest, through the Excellence Research Grants Program, UPB GEX. Identifier: UPB EXCELEN Diafano Reconstructia si vizualizarea tesuturilor pe baza transiluminarii in NIR si a camerelor video 3D, Contract number 01/ , code 514 (acronym: 3Diafano). REFERENCES [1] Bender, Jan, and Dan Koschier Divergence-Free Smoothed Particle Hydrodynamics. In Proceedings of the 14th ACM SIGGRAPH / Eurographics Symposium on Computer Animation - SCA 15. [2] Ihmsen, Markus, Jens Cornelis, Barbara Solenthaler, Christopher Horvath, and Matthias Teschner Implicit Incompressible SPH. IEEE Transactions on Visualization and Computer Graphics, July. [3] Solenthaler, B., and R. Pajarola Predictive Corrective Incompressible SPH. In ACM SIGGRAPH 2009 [4] Ihmsen, M., Orthmann, J., Solenthaler, B., Kolb, A., and Teschner, M SPH Fluids in Computer Graphics. Eurographics (State of the Art Reports), [5] Monaghan, J. J Smoothed particle hydrodynamics. Ann. Rev. of Astron. and Astrophys. 30, [6] Muller, M., Charypar, D., and Gross, M ParticleBased Fluid Simulation for Interactive Applications. In ACM SIGGRAPH / Eurographics Symposium on Computer Animation, [7] Becker, M., and Teschner, M Weakly compressible SPH for surface flows. In ACM SIGGRAPH / Eurographics Symposium on Computer Animation, 1 8 [8] Chorin, A. J Numerical solution of the Navier-Stokes equations. Mathematics of Computation 22, [9] Bridson, R Fluid Simulation for Computer Graphics. A K Peters / CRC Press. [10] He, X., Liu, N., Li, S., Wang, H., and Wang, G., Local poisson SPH for viscous incompressible fluids. [11] Akinci, N., Ihmsen, M., Akinci, G., Solenthaler, B., and Teschner, M., Versatile rigid-fluid coupling for incompressible SPH. 278

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

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

Divergence-Free Smoothed Particle Hydrodynamics

Divergence-Free Smoothed Particle Hydrodynamics Divergence-Free Smoothed Particle Hydrodynamics Jan Bender Dan Koschier Graduate School CE TU Darmstadt Figure 1: Our new SPH method allows a stable simulation of incompressible fluids with high velocities

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

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

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

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

More information

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

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

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

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

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

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

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

A Geometric Approach to Animating Thin Surface Features in SPH Water

A Geometric Approach to Animating Thin Surface Features in SPH Water A Geometric Approach to Animating Thin Surface Features in SPH Water Taekwon Jang et al. Computer Animation and Social Agents 2013 (CASA) Jong-Hyun Kim 2013. 11.08 Abstract We propose a geometric approach

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

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

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

ADAPTIVE POSITION-BASED FLUIDS: IMPROVING PERFORMANCE OF FLUID SIMULATIONS FOR REAL-TIME APPLICATIONS

ADAPTIVE POSITION-BASED FLUIDS: IMPROVING PERFORMANCE OF FLUID SIMULATIONS FOR REAL-TIME APPLICATIONS ADAPTIVE POSITION-BASED FLUIDS: IMPROVING PERFORMANCE OF FLUID SIMULATIONS FOR REAL-TIME APPLICATIONS Marcel Köster and Antonio Krüger German Research Center for Artificial Intelligence, Saarland Informatics

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

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

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

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

Simulation in Computer Graphics. Deformable Objects. Matthias Teschner. Computer Science Department University of Freiburg Simulation in Computer Graphics Deformable Objects Matthias Teschner Computer Science Department University of Freiburg Outline introduction forces performance collision handling visualization University

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

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

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

Moving Least Squares Boundaries for SPH Fluids

Moving Least Squares Boundaries for SPH Fluids Workshop on Virtual Reality Interaction and Physical Simulation VRIPHYS (2017) F. Jaillet and F. Zara (Editors) Moving Least Squares Boundaries for SPH Fluids Stefan Band Christoph Gissler Matthias Teschner

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

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

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

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

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

Particle-Based Fluid Simulation. CSE169: Computer Animation Steve Rotenberg UCSD, Spring 2016

Particle-Based Fluid Simulation. CSE169: Computer Animation Steve Rotenberg UCSD, Spring 2016 Particle-Based Fluid Simulation CSE169: Computer Animation Steve Rotenberg UCSD, Spring 2016 Del Operations Del: = x Gradient: s = s x y s y z s z Divergence: v = v x + v y + v z x y z Curl: v = v z v

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

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

Parallel GPU-Based Fluid Animation. Master s thesis in Interaction Design and Technologies JAKOB SVENSSON

Parallel GPU-Based Fluid Animation. Master s thesis in Interaction Design and Technologies JAKOB SVENSSON Parallel GPU-Based Fluid Animation Master s thesis in Interaction Design and Technologies JAKOB SVENSSON Department of Applied Information Technology CHALMERS UNIVERSITY OF TECHNOLOGY Gothenburg, Sweden

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

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

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

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

A High Quality, Eulerian 3D Fluid Solver in C++ A Senior Project. presented to. the Faculty of the Computer Science Department of

A High Quality, Eulerian 3D Fluid Solver in C++ A Senior Project. presented to. the Faculty of the Computer Science Department of A High Quality, Eulerian 3D Fluid Solver in C++ A Senior Project presented to the Faculty of the Computer Science Department of California Polytechnic State University, San Luis Obispo In Partial Fulfillment

More information

T6: Position-Based Simulation Methods in Computer Graphics. Jan Bender Miles Macklin Matthias Müller

T6: Position-Based Simulation Methods in Computer Graphics. Jan Bender Miles Macklin Matthias Müller T6: Position-Based Simulation Methods in Computer Graphics Jan Bender Miles Macklin Matthias Müller Jan Bender Organizer Professor at the Visual Computing Institute at Aachen University Research topics

More information

NVIDIA. Interacting with Particle Simulation in Maya using CUDA & Maximus. Wil Braithwaite NVIDIA Applied Engineering Digital Film

NVIDIA. Interacting with Particle Simulation in Maya using CUDA & Maximus. Wil Braithwaite NVIDIA Applied Engineering Digital Film NVIDIA Interacting with Particle Simulation in Maya using CUDA & Maximus Wil Braithwaite NVIDIA Applied Engineering Digital Film Some particle milestones FX Rendering Physics 1982 - First CG particle FX

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

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

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

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

PHYSICALLY BASED ANIMATION

PHYSICALLY BASED ANIMATION PHYSICALLY BASED ANIMATION CS148 Introduction to Computer Graphics and Imaging David Hyde August 2 nd, 2016 WHAT IS PHYSICS? the study of everything? WHAT IS COMPUTATION? the study of everything? OUTLINE

More information

Density Maps for Improved SPH Boundary Handling

Density Maps for Improved SPH Boundary Handling Density Maps for Improved SPH Boundary Handling Dan Koschier Jan Bender RWTH Aachen University koschier@cs.rwth-aachen.de RWTH Aachen University bender@cs.rwth-aachen.de Figure 1: Left: Breaking dam scenario

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

Example 24 Spring-back

Example 24 Spring-back Example 24 Spring-back Summary The spring-back simulation of sheet metal bent into a hat-shape is studied. The problem is one of the famous tests from the Numisheet 93. As spring-back is generally a quasi-static

More information

The Immersed Interface Method

The Immersed Interface Method The Immersed Interface Method Numerical Solutions of PDEs Involving Interfaces and Irregular Domains Zhiiin Li Kazufumi Ito North Carolina State University Raleigh, North Carolina Society for Industrial

More information

The 3D DSC in Fluid Simulation

The 3D DSC in Fluid Simulation The 3D DSC in Fluid Simulation Marek K. Misztal Informatics and Mathematical Modelling, Technical University of Denmark mkm@imm.dtu.dk DSC 2011 Workshop Kgs. Lyngby, 26th August 2011 Governing Equations

More information

Volume preserving viscoelastic fluids with large deformations using position-based velocity corrections

Volume preserving viscoelastic fluids with large deformations using position-based velocity corrections Volume preserving viscoelastic fluids with large deformations using position-based velocity corrections Tetsuya Takahashi, Yoshinori Dobashi, Issei Fuishiro & Tomoyuki Nishita The Visual Computer International

More information

AN ADAPTIVE SAMPLING APPROACH TO INCOMPRESSIBLE PARTICLE-BASED FLUID. A Dissertation WOO-SUCK HONG

AN ADAPTIVE SAMPLING APPROACH TO INCOMPRESSIBLE PARTICLE-BASED FLUID. A Dissertation WOO-SUCK HONG AN ADAPTIVE SAMPLING APPROACH TO INCOMPRESSIBLE PARTICLE-BASED FLUID A Dissertation by WOO-SUCK HONG Submitted to the Office of Graduate Studies of Texas A&M University in partial fulfillment of the requirements

More information

Shape of Things to Come: Next-Gen Physics Deep Dive

Shape of Things to Come: Next-Gen Physics Deep Dive Shape of Things to Come: Next-Gen Physics Deep Dive Jean Pierre Bordes NVIDIA Corporation Free PhysX on CUDA PhysX by NVIDIA since March 2008 PhysX on CUDA available: August 2008 GPU PhysX in Games Physical

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

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

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

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

Hardware Accelerated Real-Time Fluid Surface Simulation

Hardware Accelerated Real-Time Fluid Surface Simulation Hardware Accelerated Real-Time Fluid Surface Simulation Björn Hellstrandh bjornh@cs.umu.se Jesper Byström c99jbm@cs.umu.se July 1, 2008 Master s Thesis in Computing Science, 2*30 ECTS credits Supervisor

More information

Hybrid Smoothed Particle Hydrodynamics

Hybrid Smoothed Particle Hydrodynamics Eurographics/ ACM SIGGRAPH Symposium on Computer Animation (2011) A. Bargteil and M. van de Panne (Editors) Hybrid Smoothed Particle Hydrodynamics Karthik Raveendran 1, Chris Wojtan 2 and Greg Turk 1 1

More information

Pressure Correction Scheme for Incompressible Fluid Flow

Pressure Correction Scheme for Incompressible Fluid Flow AALTO UNIVERSITY School of Chemical Technology CHEM-E7160 Fluid Flow in Process Units Pressure Correction Scheme for Incompressible Fluid Flow Ong Chin Kai 620503 Lee De Ming Benedict 620448 Page 1 Abstract

More information

Solidification using Smoothed Particle Hydrodynamics

Solidification using Smoothed Particle Hydrodynamics Solidification using Smoothed Particle Hydrodynamics Master Thesis CA-3817512 Game and Media Technology Utrecht University, The Netherlands Supervisors: dr. ir. J.Egges dr. N.G. Pronost July, 2014 - 2

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

Boundary handling and adaptive time-stepping for PCISPH

Boundary handling and adaptive time-stepping for PCISPH Workshop on Virtual Reality Interaction and Physical Simulation VRIPHYS (2010) J. Bender, K. Erleben, and M. Teschner (Editors) Boundary handling and adaptive time-stepping for PCISPH Markus Ihmsen Nadir

More information

Adaptive Particles for Incompressible Fluid Simulation (Technical Report tamu-cs-tr )

Adaptive Particles for Incompressible Fluid Simulation (Technical Report tamu-cs-tr ) Adaptive Particles for Incompressible Fluid Simulation (Technical Report tamu-cs-tr 2007-7-2) Woosuck Hong Dept. of Computer Science Texas A&M University wshong@cs.tamu.edu Donald H. House Visualization

More information

Cloth Simulation. Tanja Munz. Master of Science Computer Animation and Visual Effects. CGI Techniques Report

Cloth Simulation. Tanja Munz. Master of Science Computer Animation and Visual Effects. CGI Techniques Report Cloth Simulation CGI Techniques Report Tanja Munz Master of Science Computer Animation and Visual Effects 21st November, 2014 Abstract Cloth simulation is a wide and popular area of research. First papers

More information

Fluid Simulation by the Smoothed Particle Hydrodynamics Method: A Survey

Fluid Simulation by the Smoothed Particle Hydrodynamics Method: A Survey Fluid Simulation by the Smoothed Particle Hydrodynamics Method: A Survey T. Weaver and Z. Xiao Centre for Digital Entertainment, National Centre for Computer Animation, Bournemouth University, United Kingdom

More information

Cloth Hair. and. soft bodies

Cloth Hair. and. soft bodies Cloth Hair Lesson 11 and soft bodies Lesson 08 Outline Problem definition and motivations Modeling deformable solids with mass-spring model Position based dynamics Modeling cloths with mass-spring model

More information

FEMLAB Exercise 1 for ChE366

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

More information

Tutorial: Modeling Liquid Reactions in CIJR Using the Eulerian PDF transport (DQMOM-IEM) Model

Tutorial: Modeling Liquid Reactions in CIJR Using the Eulerian PDF transport (DQMOM-IEM) Model Tutorial: Modeling Liquid Reactions in CIJR Using the Eulerian PDF transport (DQMOM-IEM) Model Introduction The purpose of this tutorial is to demonstrate setup and solution procedure of liquid chemical

More information

Cloth Simulation. COMP 768 Presentation Zhen Wei

Cloth Simulation. COMP 768 Presentation Zhen Wei Cloth Simulation COMP 768 Presentation Zhen Wei Outline Motivation and Application Cloth Simulation Methods Physically-based Cloth Simulation Overview Development References 2 Motivation Movies Games VR

More information

Coupling of STAR-CCM+ to Other Theoretical or Numerical Solutions. Milovan Perić

Coupling of STAR-CCM+ to Other Theoretical or Numerical Solutions. Milovan Perić Coupling of STAR-CCM+ to Other Theoretical or Numerical Solutions Milovan Perić Contents The need to couple STAR-CCM+ with other theoretical or numerical solutions Coupling approaches: surface and volume

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

Simulating Sinkage & Trim for Planing Boat Hulls. A Fluent Dynamic Mesh 6DOF Tutorial

Simulating Sinkage & Trim for Planing Boat Hulls. A Fluent Dynamic Mesh 6DOF Tutorial Simulating Sinkage & Trim for Planing Boat Hulls A Fluent Dynamic Mesh 6DOF Tutorial 1 Introduction Workshop Description This workshop describes how to perform a transient 2DOF simulation of a planing

More information

Multigrid Solvers in CFD. David Emerson. Scientific Computing Department STFC Daresbury Laboratory Daresbury, Warrington, WA4 4AD, UK

Multigrid Solvers in CFD. David Emerson. Scientific Computing Department STFC Daresbury Laboratory Daresbury, Warrington, WA4 4AD, UK Multigrid Solvers in CFD David Emerson Scientific Computing Department STFC Daresbury Laboratory Daresbury, Warrington, WA4 4AD, UK david.emerson@stfc.ac.uk 1 Outline Multigrid: general comments Incompressible

More information

Simulation of Fuel Sloshing Comparative Study

Simulation of Fuel Sloshing Comparative Study 3. LS-DYNA Anwenderforum, Bamberg 2004 Netfreie Verfahren Simulation of Fuel Sloshing Comparative Study Matej Vesenjak 1, Heiner Müllerschön 2, Alexander Hummel 3, Zoran Ren 1 1 University of Maribor,

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

CS205b/CME306. Lecture 9

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

More information

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

Abstract. Introduction. Kevin Todisco

Abstract. Introduction. Kevin Todisco - Kevin Todisco Figure 1: A large scale example of the simulation. The leftmost image shows the beginning of the test case, and shows how the fluid refracts the environment around it. The middle image

More information

An Analysis of Interactive Deformable Solid Object Modeling

An Analysis of Interactive Deformable Solid Object Modeling An Analysis of Interactive Deformable Solid Object Modeling Shrirang Yardi Department of Electrical and Computer Engineering Virginia Tech Blacksburg, VA yardi@vt.edu Benjamin Bishop Department of Computing

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

Simulation of Automotive Fuel Tank Sloshing using Radioss

Simulation of Automotive Fuel Tank Sloshing using Radioss Simulation of Automotive Fuel Tank Sloshing using Radioss Prashant V. Kulkarni CAE Analyst Tata Motors. Pimpri, Pune - 411018, India Sanjay S. Patil Senior Manager Tata Motors. Pimpri, Pune - 411018, India

More information

Fast Particle Neighbor Searching for Unlimited Scene with Fluid Refraction Improvement

Fast Particle Neighbor Searching for Unlimited Scene with Fluid Refraction Improvement Fast Particle Neighbor Searching for Unlimited Scene with Fluid Refraction Improvement Sio-Kei Im and Ka-Hou Chan Abstract With the popular application of physics-based simulation in virtual reality, real-time

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

ALE Seamless Immersed Boundary Method with Overset Grid System for Multiple Moving Objects

ALE Seamless Immersed Boundary Method with Overset Grid System for Multiple Moving Objects Tenth International Conference on Computational Fluid Dynamics (ICCFD10), Barcelona,Spain, July 9-13, 2018 ICCFD10-047 ALE Seamless Immersed Boundary Method with Overset Grid System for Multiple Moving

More information

An Adaptive Sampling Approach to Incompressible Particle-Based Fluid

An Adaptive Sampling Approach to Incompressible Particle-Based Fluid EG UK Theory and Practice of Computer Graphics (2009) Ik Soo Lim, Wen Tang (Editors) An Adaptive Sampling Approach to Incompressible Particle-Based Fluid Woosuck Hong 1, Donald H. House 2 and John Keyser

More information

Fluids in Games. Jim Van Verth Insomniac Games

Fluids in Games. Jim Van Verth Insomniac Games Fluids in Games Jim Van Verth Insomniac Games www.insomniacgames.com jim@essentialmath.com Introductory Bits General summary with some details Not a fluids expert Theory and examples What is a Fluid? Deformable

More information

Physically Based Simulation

Physically Based Simulation CSCI 480 Computer Graphics Lecture 21 Physically Based Simulation April 11, 2011 Jernej Barbic University of Southern California http://www-bcf.usc.edu/~jbarbic/cs480-s11/ Examples Particle Systems Numerical

More information

Smoothed Particle Hydrodynamics on GPUs

Smoothed Particle Hydrodynamics on GPUs The Visual Computer manuscript No. (will be inserted by the editor) Takahiro Harada Seiichi Koshizuka Yoichiro Kawaguchi Smoothed Particle Hydrodynamics on GPUs Abstract In this paper, we present a Smoothed

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

Surface Reconstruction. Gianpaolo Palma

Surface Reconstruction. Gianpaolo Palma Surface Reconstruction Gianpaolo Palma Surface reconstruction Input Point cloud With or without normals Examples: multi-view stereo, union of range scan vertices Range scans Each scan is a triangular mesh

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

Physically Based Simulation

Physically Based Simulation CSCI 420 Computer Graphics Lecture 21 Physically Based Simulation Examples Particle Systems Numerical Integration Cloth Simulation [Angel Ch. 9] Jernej Barbic University of Southern California 1 Physics

More information

Introduction to Computer Graphics. Animation (2) May 26, 2016 Kenshi Takayama

Introduction to Computer Graphics. Animation (2) May 26, 2016 Kenshi Takayama Introduction to Computer Graphics Animation (2) May 26, 2016 Kenshi Takayama Physically-based deformations 2 Simple example: single mass & spring in 1D Mass m, position x, spring coefficient k, rest length

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

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

Simulation in Computer Graphics. Introduction. Matthias Teschner. Computer Science Department University of Freiburg Simulation in Computer Graphics Introduction Matthias Teschner Computer Science Department University of Freiburg Contact Matthias Teschner Computer Graphics University of Freiburg Georges-Koehler-Allee

More information

03 - Reconstruction. Acknowledgements: Olga Sorkine-Hornung. CSCI-GA Geometric Modeling - Spring 17 - Daniele Panozzo

03 - Reconstruction. Acknowledgements: Olga Sorkine-Hornung. CSCI-GA Geometric Modeling - Spring 17 - Daniele Panozzo 3 - Reconstruction Acknowledgements: Olga Sorkine-Hornung Geometry Acquisition Pipeline Scanning: results in range images Registration: bring all range images to one coordinate system Stitching/ reconstruction:

More information

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