An Improved Volume-of-Fluid Method for Wave Impact Problems

Size: px
Start display at page:

Download "An Improved Volume-of-Fluid Method for Wave Impact Problems"

Transcription

1 An Improved Volume-of-Fluid Metod for Wave Impact Problems K.M. Teresa Kleefsman, Geert Fekken, Artur E.P. Veldman Dept. of Matematics and Computing Science, University of Groningen Groningen, te Neterlands Bogdan Iwanowski FORCE Tecnoloy Norway AS Oslo, Norway ABSTRACT In tis paper, a calculation metod for wave impact problems is presented. Tis metod is based on te Navier-Stokes equations and uses an improved volume-of-fluid (VOF) metod for te displacement of te free surface. Results are sown for a dambreak simulation for wic experimental results are available for comparison. Also drop tests ave been simulated wit wedges and circular cylinders. Te results are very promising for te furter development of te metod. KEYWORDS: Wave loading; moving body; numerical simulation; Cartesian grid; volume-of-fluid. INTRODUCTION Tere is a great need for calculation metods for local penomena of wave impact loading and loading from green water on te deck of a sip. Most of te existing metods are not capable of predicting te local loads. Part of te Joint Industry Project SafeFLOW, initiated in January 2001, is devoted to te development of a metod wic is able to predict local wave impact on floaters operating in te offsore industry. Te development of te metod, called ComFLOW, as started in 1995 wit te simulation of liquid-filled spacecraft, tat are tumbling in space [Gerrits, 2001]. In tis application were te surface tension is te driving force, a good andling of te free surface is crucial. Te metod as also been applied to blood flow troug (elastic) arteries, were no free surface was present [Loots, 2003]. A rater new application was found in te maritime world were slosing inside anti-roll tanks as been simulated. In 1999 a pilot study of te simulation of green water on te deck of an FPSO as been performed, to investigate if te metod is capable of capturing te local flow details on te deck [Bucner, 1999]. Because of promising results, it was decided to move on in tis direction in te SafeFLOW project. Te simulation of fluid flow in ComFLOW is based on te Navier-Stokes equations for an incompressible, viscous fluid. Te equations are discretised using te finite volume metod. For te displacement of te free surface te VOF metod as been used adapted wit a local eigt function wic is essential for a good simulation of te free surface flow. To simulate wave impact in a robust and accurate way, a good coice of te discrete boundary conditions at te free surface turns out to be very important. In tis paper, te model used in ComFLOW is described. Results are sown of simulations for a dambreak wit a box in te flow. Tis simulation can be seen as a model of te water flow on te deck of a sip due to green water. Also results ave been sown of water entry of two-dimensional objects. Comparison wit teory and experiments is available. GOVERNING EQUATIONS Flow of a omogeneous, incompressible, viscous fluid is described by te continuity equation and te Navier-Stokes equations. Te continuity equation describes conservation of mass and te Navier-Stokes equations describe conservation of momentum. In conservative form, tey are given by u nds = 0, (1) V u t dv + uu T nds = 1 (pn µ u n)ds + F dv. (2) ρ Here, is te boundary of volume V, u = (u, v, w) is te velocity vector in te tree coordinate directions, n is te normal of volume V, ρ denotes te density, p is te pressure, is te gradient operator. Furter µ denotes te dynamic viscosity and F = (F x, F y, F z ) is an external body force, for example gravity. In te case tat moving rigid bodies are present in te domain V, te above equations still old, wit te additional condition tat te fluid velocity at te boundary of te object is equal to te object velocity. V Paper No JSC-365 Kleefsman Page: 1 of 8

2 Boundary conditions At te solid walls of te computational domain and at te objects inside te domain, a no-slip boundary condition is used. Tis condition is described by u = 0 for fixed boundaries, and u = u b for moving objects wit u b te object velocity. Some of te domain boundaries may let fluid flow in or out of te domain. Especially, wen performing wave simulations, an inflow boundary is needed were te incoming wave is prescribed and at te opposite boundary a non-reflecting outflow condition sould be used. In our metod, te wave on te inflow boundary can be prescribed as a regular linear wave or a regular 5t order Stokes wave. Also a superposition of linear components can be used wic results in an irregular wave. At te outflow boundary, a Sommerfeld condition is very appropriate in cases were a regular wave is used. In te case of an irregular wave or a muc deformed regular wave (e.g. due to te presence of an object in te flow) a damping zone is added at te end of te domain. Free surface If te position of te free surface is given by s(x, t) = 0, te displacement of te free surface is described using te following equation Ds Dt = s + (u )s = 0. (3) t At te free surface, boundary conditions are necessary for te pressure and te velocities. Continuity of normal and tangential stresses leads to te equations p + 2µ u n n = p 0 + 2γH (4) ( un µ t + u ) t = 0. (5) n Here, u n is te normal component of te velocity, p 0 is te atmosperic pressure, γ is te surface tension and 2H denotes te total curvature. NUMERICAL MODEL To solve te Navier-Stokes equations numerically, te computational domain is covered wit a fixed Cartesian grid. Te variables are staggered, wic means tat te velocities are defined at cell faces, wereas te pressure is defined in cell centers. Te body geometry is piecewise linear and cuts troug te fixed rectangular grid. Volume apertures (F b ) and edge apertures (A x, A y, and A z ) are used to indicate for eac cell wic part of te cell and cell face respectively is open for fluid and wic part is blocked by solid geometry. To track te free surface, te volumeof-fluid function F s is used, wic is 0 if no fluid is present in te cell, 1 if te cell is completely filled wit fluid and between 0 and 1 if te cell is partly filled wit fluid. Te Navier-Stokes equations are solved in every cell containing fluid. Cell labeling is introduced to distinguis between cells of different caracters. First te cells wic are completely blocked by geometry are called B(oundary) cells. Tese cells ave volume aperture F b =0. Ten te cells wic are empty, but ave te possibility of letting fluid flow in are labeled E(mpty). Te adjacent cells, containing fluid, are S(urface) cells. Te remaining cells are labeled as F(luid) cells. Note tat tese cells do not ave to be completely filled wit fluid. In Figure 1 an example of te labeling is given. E E E E E E E S B B S S F F B F F F F F F F F F F Figure 1: Cell labeling: dark grey denotes solid body, ligt grey is liquid Discretisation of te continuity equation Te continuity and Navier-Stokes equations are discretised using te finite volume metod. Te natural form of te equations wen using te finite volume metod is te conservative formulation as given in Eq. (1) and (2). In tis paper, te discretisation is explained in two dimensions. In most situations, tis can be extended to tree dimensions in a straigtforward manner. In A x wδy A y nδx F b δxδy l A y sδx A x eδy Figure 2: Conservation cell for te continuity equation Figure 2 a computational cell is sown, wic is cut by te body geometry. Wen applying conservation of mass in tis cell, te discretisation results in u w u e A x eδy + v n A y nδx u w A x wδy v s A y sδx + u b (A x e A x w)δy + v b (A y n A y s)δx = 0, (6) were te notation is explained in Figure 2. Discretisation of te Navier-Stokes equations For te discretisation of te Navier-Stokes equations, control volumes are defined containing velocities wic are defined on cell faces. In te case of uncut cells, te control volume of a velocity simply consists of te rigt alf of te cell left of te velocity and te left alf of te cell rigt of te velocity. In case of cut cells te procedure to define control volumes as been explained in detail in [Gerrits, 2001]. Te time derivative in te Navier-Stokes equations is discretised in space using te midpoint rule. Tis results in V u t dv v b v n u b v s u e. = u c t F b c δx c δy. (7) Paper No JSC-365 Kleefsman Page: 2 of 8

3 Here, u c is te central velocity around wic te control volume is placed and Fc b δx c δy is te volume of te control volume. Te convective term is discretised directly from te boundary integral wic is given by uu nds. (8) Note, tat tis integral contains two different velocities: te scalar velocity u is advected wit te velocity vector u. Tis integral is evaluated along all boundaries of te control volume by multiplying te scalar velocity u wit te mass flux troug te boundary u nds. Finally, te convective term discretisation results in a matrix tat is skew symmetric, wic is also a property of te continuous convective operator [Verstappen, 2003]. Te diffusive term, wic for te Navier-Stokes equation in x- direction is given by 1 µ u ds, (9) ρ n is discretised along all boundaries of te control volume. To ensure stability, te term n u is discretised in cut-cells as if te cells are uncut. Te error introduced tis way is small and as no influence in te convection-dominated simulations. Te discretisation results in a symmetric matrix wic is negative definite. Te pressure term is discretised as a boundary integral, resulting for te Navier-Stokes equation in x-direction in pn x ds =. (p e p w )A x c δy. (10) Here, p e and p w are te pressure in te eastern and western cell respectively, A x c is te edge aperture of te cell face were te central velocity is defined. Te external force is discretised similar to te time derivative, resulting for te x-direction in F x dv =. F xc Fc b δx c δy. (11) V Here, F xc is te force at te location of te central velocity. A detailed explanation of te discretisations described in tis section is given in [Gerrits, 2001]. Temporal discretisation Te continuity and Navier-Stokes equations are discretised in time using te forward Euler metod. Tis first order metod is accurate enoug, because te order of te overall accuracy is already determined by te first order accuracy of te free surface displacement algoritm. Using superscript n for te time level, te temporal discretisation results in Mu n+1 = 0, (12) Ω un+1 u n + C(u n δt )u n = 1 ρ (M T p n+1 µdu n ) + F n. (13) Te continuity equation is discretised at te new time level to ensure a divergence free velocity field. Te spatial discretisation is written in matrix notation were M is te divergence operator, Ω contains cell volumes, C contains te convection coefficients (wic depend on te velocity vector) and D contains diffusive coefficients. Solution metod To solve te system of equations, te equations are rearranged to u n+1 = ũ n + δtω 1 1 ρ M T p n+1, (14) were ũ n = u n δtω 1 (C(u n )u n µ ρ Dun F n ). (15) First, an auxiliary vector field ũ n is calculated using Eq. (15). Next, Eq. (14) is substituted in Eq. (12) wic results in a Poisson equation for te pressure. From tis equation te pressure is solved using te SOR (Successive Over Relaxation) metod were te optimal relaxation parameter is determined during te iterations [Botta, 1985]. Once te pressure field is known, te new velocity field is calculated from ũ n using te pressure gradient. Free surface displacement After te new velocity field as been calculated, te free surface can be displaced. Tis is done using an adapted version of te volume-of-fluid metod first introduced by [Hirt, 1981]. A piecewise constant reconstruction of te free surface is used, were te free surface is displaced by canging te VOF-value in a cell using calculated fluxes troug cell faces. Te original VOF metod as two main drawbacks. Te first is tat flotsam and jetsam can appear, wic are small droplets disconnecting from te free surface. Te oter drawback is te gain or loss of water due to rounding of te VOF function. By combining te VOF metod wit a local eigt function as introduced in [Gerrits, 2001], tese problems do not appear any more. Te resulting metod is strictly mass conservative. FREE SURFACE BOUNDARY CONDITIONS At te free surface, boundary conditions are needed for te pressure and te velocities. Te pressure in surface cells is calculated as an interpolation or extrapolation from te pressure in an adjacent fluid cell and te boundary condition at te free surface. Te velocities in te neigbourood of te free surface can be grouped in different classes (see Figure 3). Te first class contains E E E S FF, FS, SS: momentum equation S S S F S F F F SE: extrapolation EE: tangential free surface condition Figure 3: Different caracters of velocities near te free surface te velocities between two F-cells, between two S-cells and between an S- and F-cell. Tese velocities are determined by solving te momentum equation, so te velocities are called momentum velocities. Te second class consists of te velocities between an S- and an E-cell. Tese velocities are determined using boundary conditions wic will be described below. Te last class consists of velocities between two E-cells wic are sometimes needed to Paper No JSC-365 Kleefsman Page: 3 of 8

4 solve te momentum equation. Tese are determined using te tangential free surface condition time is 375 s treatment SE vel: mass conservation treatment SE vel: extrapolation model test SE-velocities Te coice for te metod to determine te velocities at te cell faces between surface and empty cells is very important for te robustness and te accuracy of te flow model. Furtermore, tis as an influence on te occurrence of numerical spikes in te pressure signal (see Figure 11 were numerical spikes occur). Te reason for pressure spikes is tat tere is not always conservation of mass in a surface (or empty) cell (depending on te boundary conditions). Wen suc a cell becomes a fluid cell, te pressure reacts wit a spike to restore mass conservation. In te following paragraps two metods will be described for te definition of free surface velocities. Metod 1: conservation of mass in S-cells Te first metod demands conservation of mass in surface cells. Te SE-velocity or velocities at te faces of a surface cell are cosen suc tat conservation of mass is satisfied in tat cell. Te advantage of tis metod is tat no spikes will occur in te pressure signal, because conservation of mass is already satisfied if tis surface cell canges to a fluid cell. Tere are two disadvantages. Te first one is tat tis metod is not always robust. In te case of Figure 4 te SE-velocity will become very large. If tis configuration does not cange during a number of time steps, te metod will diverge. S S E S S E Figure 4: Very large SE velocity wen using metod 1 Te oter disadvantage is tat te metod does not give accurate results in wave simulations. Tis is sown by te dased line of Figure 5. Metod 2: extrapolation from direction of fluid In te second metod, te SE-velocities are calculated as an extrapolation from te direction of te fluid. Using a linear extrapolation gives very accurate results for steep wave simulations (see Figure 5). But linear extrapolation can lead to instability of te metod wen te velocity field is not smoot. In tat case constant extrapolation is a better coice. In practice, a metod as been cosen wic is an engineering mix between te two metods described above. To prevent spikes in te pressure signal, te mass conservation principle as been cosen wen a cell canges label from surface cell to fluid cell. In all oter cases linear or constant extrapolation is used from te direction of te main body of te fluid, wic gives a ig accuracy and a very robust metod. wave elevation (m) x axis (m) Figure 5: Different metods for free surface velocities in a steep wave simulation STABILITY In te case of uncut cells wit fixed objects, te stability of te equation containing te time integration term and te convective term is given by te CFL-restriction δt u 1. Here, is te size of te uncut cell. Wen cut cells are present, tis criterion is not canged. Tis result is not directly straigtforward wen looking at te equation containing te time derivative and te convective term u t = Ω 1 C(u, u b )u (16) were u b is te object velocity. Te matrix Ω is a diagonal matrix containing te volumes of te cells, so tese entries can become arbitrary small for cut cells. So te elements in te matrix Ω 1 can become arbitrary large. But, wen estimating te eigenvalues of te convective matrix using Gerscgorin circles by being order O( Ω u), it can be concluded tat te same stability criterion is needed as for te uncut-cells case. Wen moving objects are present, te story becomes somewat different. Now, te CFL-criterion does not guarantee stability anymore, because te eigenvalues of Ω 1 C(u, u b ) are of order O(Ω 1 u b ) wic means tat tey can become arbitrary large. To cancel te effect of Ω a formulation based on a weigted average of te fluid velocity and te boundary velocity sould be applied in te cells cut by te moving object. To avoid smearing of te interface in cases were it is not necessary to stabilise te convective term, te following discretisation is used u n+1 = Ω n+1 (Ω n+1 + Ω ) 1 (u n + δt(ω n+1 ) 1 ( C n u n )) + (I Ω n+1 (Ω n+1 + Ω ) 1 )u n+1 b (17) were Ω = Ω n+1 Ω n is te difference between Ω s at two different time steps. Te factor Ω n+1 (Ω n+1 + Ω ) 1 is cosen because ten te stabilising term is only used wen te body is moving; note tat it equals unity for fixed objects. Te maximal stabilisation is required wen te object is moving normal to its boundary, wereas no stabilisation is needed wen te object is moving tangential to its boundary (see Figure 6). A detailed explanation of te stability of te convective terms is given in [Fekken, 2004]. Paper No JSC-365 Kleefsman Page: 4 of 8

5 te simulation are sown togeter wit images of te video of te experiment (at te same moments in time). Te smaller pictures ub ub ub ub Figure 6: Left: boundary moving normal to itself: maximal stabilisation is required; rigt: boundary moving tangential to itself: no stabilisation is required From te diffusive term, also a stability criterion follows wit a restriction on te time step. In te case of uncut cells, tis cri2 terion is given by δt 2ν, were ν denotes kinematic viscosity. Because te diffusive term is discretised as if all cells were uncut ( staircase approac), te above criterion is also valid in our model. Figure 8: Snapsots of a dambreak simulation wit a box in te flow compared wit experiment at time 0.4 and 0.56 seconds DAMBREAK SIMULATION At te Maritime Researc Institute Neterlands (MARIN), experiments ave been performed for breaking dam flows. Tese experiments can be seen as a simple model of green water flow on te deck of a sip. Te dambreak is a very popular validation case, because te set up is easy, no special in- or outflow conditions are needed. A large tank of 3.22 by 1 by 1 meter is used wit an open roof (scale 1:15). Te rigt part of te tank is first closed by a door. Beind te door, 0.55 meter of water is waiting to flow into te tank wen te door is opened. At a certain moment, a weigt is released wic opens te door. In te tank, a box is placed wic is a scale model of a container on te deck of a sip. inside te snapsots sow te water in te reservoir. Tere is a very large agreement between te simulation and experiment. Te moment in time wen te water is first itting te box is te same. Te sape of te free surface, bending a bit forwards in te second picture, is seen in bot experiment and simulation. In te simulation, te free surface as some ripples, and tese are due to te computational grid. Figure 7: Measurement positions for water eigts and pressures in te dambreak experiment Figure 9: Horizontal wave probe along te side of te tank During te experiment, measurements ave been performed of water eigts, pressures and forces. In Figure 7, te positions of te measured water eigts and pressures are sown. In te tank, four vertical wave probes ave been used. One in te reservoir and te oter tree in te tank. Te box was covered by eigt pressure pick-ups, four on te front of te box and four on te top. Te forces on te box were also measured. To determine te velocity of te water wen entering te tank, a orizonal wave probe is used near te side wall of te tank. As starting configuration of te simulation wit ComFLOW, te water in te rigt part of te domain is at rest. Wen te simulation is started, te water starts to flow into te empty tank due to gravity. In Figure 8 two snapsots of te early stages of In Figure 9 te time istory of te orizontal wave probe is sown, compared wit te simulation. Te first stage of te simulation compares very well wit te experiment, te velocity wit wic te water is flowing into te tank is predicted very well. By te time te water its te box, tere is a difference between te experiment and te simulation. In te experiment, te water is slowed down, te wave probe is totally covered by water only after 2 seconds. In te simulation tis is te case after 0.5 seconds. Wen looking at te movie of simulation and experiment, tis difference is not present, suggesting an inconsistency in te wave probe measurements. Te flow reaces te end wall at te same time in simulation and experiment. So te appearing difference in Figure 9 is not a real difference between simulation and Paper No JSC-365 Kleefsman Page: 5 of 8

6 experiment. In Figure 10, te water eigt at two locations is sown: in te reservoir, and in te tank just in front of te box. Te agreement in bot pictures is very good until te water as returned from te back wall (after about 1.8 seconds). After tat some differences occur, but te global beaviour is still te same. Wen te water as returned from te wall, te water eigt at probe H2 is largest. Te water flows back to te reservoir, were it turns over again at about 4 seconds. Te moment tat tis second wave meets te wave probe at H2 again is almost exactly te same in simulation and experiment. coming back from te wall is overturning. Tis difference is a real difference wic cannot be explained properly at te moment. Several spikes appear in te pressure signals, wic are spikes in all te graps at te same moment. Tese spikes occur, because some water enters an empty cell wic is completely surrounded by cells wit fluid. Ten, tis empty cell canges to a fluid cell in one time step witout being a surface cell in between. Tis cange in label results in a pressure spike over te wole pressure field. Te results of te dambreak simulation are in good agreement wit te experiment. Te global beaviour of te fluid is te same and te impact peak of te pressure agrees well, especially at te lowest part of te box. WATER ENTRY AND EXIT Figure 10: Vertical water eigts in te reservoir H4 (left) and te tank H2 (rigt) In tis section, validation results of water entry and exit of twodimensional objects are presented. Te simulations ave been carried out in two dimensions. Te objects are moving according to a constant prescribed motion. Figure 12 presents free surface profiles for te entry of two wedges. Te wedges ave deadrise angles of 30 and 45 degrees, respectively. Te simulation results ave been compared wit potograps of experiments by Greenow [Greenow, 1983]. Te Figure 11: Pressure time istories of P1 (upper left), P3 (upper rigt), P5 (lower left), and P7 (lower rigt) Te moment te wave its te box is perfectly captured by te simulation as can be seen from Figure 11. Here te pressure at point P1 and P3 at te front of te box and at te top of te box, P5 and P7 (see Figure 7), are sown. Te magnitude of te impact pressure is te same for simulation and experiment at pressure point P1 (te lowest on te box), but is underpredicted by te simulation at point P3. Te moment te return wave its te box again (at about 4.7 seconds) is again visible in te graps. In te bottom graps of Figure 11, were te time istory of pressure transducers at te top op te box are sown, a clear difference occurs between simulation and experiment. After about 1.3 seconds, tere is a wiggle in te simulation wit a duration of 0.5 seconds, wic is not present in te experiment. Before tis point, te water its te top of te box wen te wave Figure 12: Snapsots of wedge entry wit deadrise angles 30 degrees (up) and 45 degrees (down) simulations ave been performed on a grid of 300x280 computational cells. Te visual comparison between te experiments and te simulations is very good. Te jets wic are formed aside of te wedge are created by ComFLOW to a certain extent, but te small details of te jets and te spray are not reproduced, mainly due to te limited number of grid cells. A visual comparison of te free surface development of cylinder entry is presented in Figure 13. Te simulation as been performed on a grid of 400x400 points. Te same can be concluded for te cylinder as for te wedges: te details of te spray are not reproduced by ComFLOW. Te total ydrodynamic force on te cylinder during te first stage of te impact as been calculated and compared wit ex- Paper No JSC-365 Kleefsman Page: 6 of 8

7 Figure 13: Snapsots of te water entry of a circular cylinder perimental results of Campbell and Weynberg [Campbell, 1980], also reported in [Battistin, 2003]. In Figure 14 te slamming coefficients of te cylinder entry wit different entry velocities ave been plotted versus te nondimensional penetration dept. Te slamming coefficient is given by C s = F/ρRV 2 wit F te total vertical ydrodynamic force, R te radius of te circular cylinder and V te entry velocity. Besides te experimental result of Campbell and Weynberg, also te teory of Von Karman (1929), reported by Faltinsen [Faltinsen, 1990], as been included. Tis teory is based on potential teory. For te very initial stage of te entry of a circular cylinder, te vertical ydrodynamic slamming force can be estimated by F = V ρ π 2 (2V R 2V 2 t), (18) were t denotes time wit t = 0 at te moment of first impact. Te comparison between te experiments of Campbell and Weynberg and te simulations is reasonable. It can be seen tat te initial impact is a bit underpredicted by ComFLOW for all entry velocities. Te initial impact is more in agreement wit te teory of Von Karman. In a later stage, te results are in good agreement wit te experiments of Campbell and Weynberg. Te results of ComFLOW are almost similar for different entry velocities, wic confirms near perfect scaling wit V 2. To study te convergence of te metod under grid refinement, te circular cylinder entry simulations ave been run wit different grids also. Te results are presented in Figure 15. It can be seen tat te coarseness of te grid as a very large influence on te formation of te jets aside te cylinder. A very fine grid is needed to capture te jets. However, te formation of te jets does not ave a large influence on te total ydrodynamic force, because of te almost zero pressures inside te jets [Battistin, 2003]. In Figure 16, snapsots of simulations of cylinder exit are compared wit potograps of experiments [Greenow, 1983]. Te Froude number, defined by F r = V 2 Rg, is taken Te simulation as been performed on a grid of 300x280 points. Te visual comparison between simulation and experiment is very Figure 14: Slamming coefficient of te entry of a circular cylinder compared to te experiments of Campbell & Weynberg and te teory of Von Karman Figure 15: Effect of grid refinement on te jets formed during water entry of a circular cylinder: from left to rigt 100x100, 200x200 and 400x400 grid cells good. Te free surface development is well resolved by Com- FLOW, also te very tin layer of fluid around te cylinder is present. CONCLUSIONS In tis paper, a numerical metod is described for te prediction of local impact loads on floating structures. Te metod is based on a cut-cell approac on a fixed Cartesian grid, and is stable even wen very small cells appear. For te displacement of te free surface, an improved VOF metod is used, wic results in full mass conservation. Te determination of te free surface boundary conditions ave sown to ave a large influence on te accuracy of wave simulations. To improve tis furter, te metod will be extended to a two-pase fluid flow model, in wic tese boundary conditions will not be needed any more. Te metod as been validated using two kinds of simulations. Te first simulation is a dambreak simulation wit a box in te flow. Time series of pressure and water eigt ave been compared wit measurements from MARIN. Te results are satisfying, especially wen considering tat te flow is very violent. Te global beaviour of te fluid is very muc te same. Te second kind of validation consists of water entry and exit of wedges and cylinders. Te development of te free surface as been com- Paper No JSC-365 Kleefsman Page: 7 of 8

8 REFERENCES Figure 16: Snapsots of cylinder exit at t=0.9 seconds and t=1.06 seconds, wit exit velocity V=1 m/s pared wit experimental results, were a good comparison as been found. Also te jets appearing at te sides of te wedges and cylinders are resolved by ComFLOW, altoug te details of te spray are not reproduced. Using a finer grid gives a large improvement for te reproduction of te jets. Te ydrodynamic forces during te impact of a cylinder entering te water ave been compared wit experiments and teory, wic sow a rater good agreement. Te next step in te validation of te metod will be to simulate green water due to large waves wic flow over te deck of a floating vessel. In te coming years, te metod will be extended wit a coupling to an outer domain were waves are generated using a muc ceaper diffraction code. In tis way, te Com- FLOW domain can be limited to te close surroundings of te places of impact. Battistin, D., Iafrati, A., Hydrodynamic loads during water entry of two-dimensional and axisymmetric bodies, J. Fluids Struc., 17, , Botta, E.F.F., Ellenbroek, M.H.M., A Modified SOR Metod for te Poisson Equation in Unsteady Free-Surface Flow Calculations, J. Comp. Pys., 60, , Fekken, G., Bucner, B., Veldman, A.E.P., Simulation of greenwater loading using te Navier-Stokes equations, J. Piquet, editor, Proc. 7t Int. Conf. on Numerical Sip Hydrodynamics, , Nantes, Campbell, I.M.C., Weynberg, P.A., Measurement of parameters affecting slamming, Report No. 440, Wolfson Unit of Marine Tecnology, Tec. Rep. Centre No. TO-R-8042, Soutampton, Faltinsen, O.M., Sea loads on sips and offsore structures, Cambridge University Press, Cambridge, Fekken, G., Numerical Simulation of Free-Surface Flow wit Moving Rigid Bodies, PD tesis, University of Groningen, Marc 2004, URL: ttp:// Greenow, M., Lin, W.-M. Nonlinear free surface effects: experiments and teory, Rep. No 83-19, Department of Ocean Engineering, MIT, Cambridge, Mass, Gerrits, J., Dynamics of Liquid-Filled Spacecraft, PD tesis, University of Groningen, December 2001, URL: ttp:// Hirt, C.R., Nicols, B.D. Volume of fluid (VOF) metod for te dynamics of free boundaries, J. Comp. Pys., 39, , Loots, G.E., Hillen, B., Veldman, A.E.P., Te role of emodynamics in te development of te outflow tract of te eart, J. Eng. Mat., 45, , Verstappen, R.W.C.P., Veldman, A.E.P., Symmetry-preserving discretization of turbulent flow, J. Comp. Pys, 187, , ACKNOWLEDGMENT Te project is supported by te European Community under te FP5 GROWTH program; te autors are solely responsible for te present paper and it does not represent te opinion of te European Community. It is also supported by 26 parties from te industry (oil companies, sipyards, engineering companies, regulating bodies). Paper No JSC-365 Kleefsman Page: 8 of 8

AN IMPROVED VOLUME-OF-FLUID (IVOF) METHOD FOR WAVE IMPACT TYPE PROBLEMS. K.M.Theresa Kleefsman, Arthur E.P. Veldman

AN IMPROVED VOLUME-OF-FLUID (IVOF) METHOD FOR WAVE IMPACT TYPE PROBLEMS. K.M.Theresa Kleefsman, Arthur E.P. Veldman Proceedings of OMAE-FPSO 2004 OMAE Speciality Symposium on FPSO Integrity 2004, Houston, USA OMAE-FPSO 04-0066 AN IMPROVED VOLUME-OF-FLUID (IVOF) METHOD FOR WAVE IMPACT TYPE PROBLEMS K.M.Teresa Kleefsman,

More information

THE NUMERICAL SIMULATION OF GREEN WATER LOADING INCLUDING VESSEL MOTIONS AND THE INCOMING WAVE FIELD

THE NUMERICAL SIMULATION OF GREEN WATER LOADING INCLUDING VESSEL MOTIONS AND THE INCOMING WAVE FIELD Proceedings of OMAE 05 24th International Conference on Offshore Mechanics and Arctic Engineering (OMAE 2005) June, 12-17, 2005, Halkidiki, Greece OMAE2005-67448 THE NUMERICAL SIMULATION OF GREEN WATER

More information

A New Simulation Method for the Installation of Subsea Structures from the Splash Zone to the Ultra Deep

A New Simulation Method for the Installation of Subsea Structures from the Splash Zone to the Ultra Deep A New Simulation Method for the Installation of Subsea Structures from the Splash Zone to the Ultra Deep Bas Buchner and Tim Bunnik MARIN (Maritime Research Institute Netherlands) Haagsteeg 2 / P.O. Box

More information

Simulation of Offshore Wave Impacts with a Volume of Fluid Method. Tim Bunnik Tim Bunnik MARIN

Simulation of Offshore Wave Impacts with a Volume of Fluid Method. Tim Bunnik Tim Bunnik MARIN Simulation of Offshore Wave Impacts with a Volume of Fluid Method Tim Bunnik Tim Bunnik MARIN Outline Part I: Numerical method -Overview Part II: Applications - Dambreak - Wave run-up - Sloshing loads

More information

Citation for published version (APA): Kleefsman, K. M. T. (2005). Water impact loading on offshore structures. - A numerical study s.n.

Citation for published version (APA): Kleefsman, K. M. T. (2005). Water impact loading on offshore structures. - A numerical study s.n. University of Groningen Water impact loading on offshore structures. - A numerical study Kleefsman, Kornelia Marchien Theresa IMPORTANT NOTE: You are advised to consult the publisher's version (publisher's

More information

Water Impact Loading on Offshore Structures

Water Impact Loading on Offshore Structures Water Impact Loading on Offshore Structures A Numerical Study Theresa Kleefsman The research presented in this thesis was funded by the European Community under the Competitive and Sustainable Growth Programme

More information

A Volume-of-Fluid based simulation method for wave impact problems Kleefsman, K.M.T.; Fekken, G.; Veldman, Arthur; Iwanowski, B.; Buchner, B.

A Volume-of-Fluid based simulation method for wave impact problems Kleefsman, K.M.T.; Fekken, G.; Veldman, Arthur; Iwanowski, B.; Buchner, B. University of Groningen A Volume-of-Fluid based simulation method for wave impact problems Kleefsman, K.M.T.; Fekken, G.; Veldman, Arthur; Iwanowski, B.; Buchner, B. Published in: Journal of computational

More information

Non-Interferometric Testing

Non-Interferometric Testing NonInterferometric Testing.nb Optics 513 - James C. Wyant 1 Non-Interferometric Testing Introduction In tese notes four non-interferometric tests are described: (1) te Sack-Hartmann test, (2) te Foucault

More information

Piecewise Polynomial Interpolation, cont d

Piecewise Polynomial Interpolation, cont d Jim Lambers MAT 460/560 Fall Semester 2009-0 Lecture 2 Notes Tese notes correspond to Section 4 in te text Piecewise Polynomial Interpolation, cont d Constructing Cubic Splines, cont d Having determined

More information

Vector Processing Contours

Vector Processing Contours Vector Processing Contours Andrey Kirsanov Department of Automation and Control Processes MAMI Moscow State Tecnical University Moscow, Russia AndKirsanov@yandex.ru A.Vavilin and K-H. Jo Department of

More information

WAVE PATTERNS, WAVE INDUCED FORCES AND MOMENTS FOR A GRAVITY BASED STRUCTURE PREDICTED USING CFD

WAVE PATTERNS, WAVE INDUCED FORCES AND MOMENTS FOR A GRAVITY BASED STRUCTURE PREDICTED USING CFD Proceedings of the ASME 2011 30th International Conference on Ocean, Offshore and Arctic Engineering OMAE2011 June 19-24, 2011, Rotterdam, The Netherlands OMAE2011-49593 WAVE PATTERNS, WAVE INDUCED FORCES

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

Fast Calculation of Thermodynamic Properties of Water and Steam in Process Modelling using Spline Interpolation

Fast Calculation of Thermodynamic Properties of Water and Steam in Process Modelling using Spline Interpolation P R E P R N T CPWS XV Berlin, September 8, 008 Fast Calculation of Termodynamic Properties of Water and Steam in Process Modelling using Spline nterpolation Mattias Kunick a, Hans-Joacim Kretzscmar a,

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

Numerical Simulation of Two-Phase Free Surface Flows

Numerical Simulation of Two-Phase Free Surface Flows Arc. Comput. Met. Engng. Vol. 12, 2, 165-224 (2005) Arcives of Computational Metods in Engineering State of te art reviews Numerical Simulation of Two-Pase Free Surface Flows Alexandre Caboussat Department

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

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

Our Calibrated Model has No Predictive Value: An Example from the Petroleum Industry

Our Calibrated Model has No Predictive Value: An Example from the Petroleum Industry Our Calibrated Model as No Predictive Value: An Example from te Petroleum Industry J.N. Carter a, P.J. Ballester a, Z. Tavassoli a and P.R. King a a Department of Eart Sciences and Engineering, Imperial

More information

MAPI Computer Vision

MAPI Computer Vision MAPI Computer Vision Multiple View Geometry In tis module we intend to present several tecniques in te domain of te 3D vision Manuel Joao University of Mino Dep Industrial Electronics - Applications -

More information

MATH 5a Spring 2018 READING ASSIGNMENTS FOR CHAPTER 2

MATH 5a Spring 2018 READING ASSIGNMENTS FOR CHAPTER 2 MATH 5a Spring 2018 READING ASSIGNMENTS FOR CHAPTER 2 Note: Tere will be a very sort online reading quiz (WebWork) on eac reading assignment due one our before class on its due date. Due dates can be found

More information

Chapter K. Geometric Optics. Blinn College - Physics Terry Honan

Chapter K. Geometric Optics. Blinn College - Physics Terry Honan Capter K Geometric Optics Blinn College - Pysics 2426 - Terry Honan K. - Properties of Ligt Te Speed of Ligt Te speed of ligt in a vacuum is approximately c > 3.0µ0 8 mês. Because of its most fundamental

More information

Interference and Diffraction of Light

Interference and Diffraction of Light Interference and Diffraction of Ligt References: [1] A.P. Frenc: Vibrations and Waves, Norton Publ. 1971, Capter 8, p. 280-297 [2] PASCO Interference and Diffraction EX-9918 guide (written by Ann Hanks)

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

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

More on Functions and Their Graphs

More on Functions and Their Graphs More on Functions and Teir Graps Difference Quotient ( + ) ( ) f a f a is known as te difference quotient and is used exclusively wit functions. Te objective to keep in mind is to factor te appearing in

More information

2 The Derivative. 2.0 Introduction to Derivatives. Slopes of Tangent Lines: Graphically

2 The Derivative. 2.0 Introduction to Derivatives. Slopes of Tangent Lines: Graphically 2 Te Derivative Te two previous capters ave laid te foundation for te study of calculus. Tey provided a review of some material you will need and started to empasize te various ways we will view and use

More information

Implementation of Integral based Digital Curvature Estimators in DGtal

Implementation of Integral based Digital Curvature Estimators in DGtal Implementation of Integral based Digital Curvature Estimators in DGtal David Coeurjolly 1, Jacques-Olivier Lacaud 2, Jérémy Levallois 1,2 1 Université de Lyon, CNRS INSA-Lyon, LIRIS, UMR5205, F-69621,

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

Cubic smoothing spline

Cubic smoothing spline Cubic smooting spline Menu: QCExpert Regression Cubic spline e module Cubic Spline is used to fit any functional regression curve troug data wit one independent variable x and one dependent random variable

More information

RECONSTRUCTING OF A GIVEN PIXEL S THREE- DIMENSIONAL COORDINATES GIVEN BY A PERSPECTIVE DIGITAL AERIAL PHOTOS BY APPLYING DIGITAL TERRAIN MODEL

RECONSTRUCTING OF A GIVEN PIXEL S THREE- DIMENSIONAL COORDINATES GIVEN BY A PERSPECTIVE DIGITAL AERIAL PHOTOS BY APPLYING DIGITAL TERRAIN MODEL IV. Évfolyam 3. szám - 2009. szeptember Horvát Zoltán orvat.zoltan@zmne.u REONSTRUTING OF GIVEN PIXEL S THREE- DIMENSIONL OORDINTES GIVEN Y PERSPETIVE DIGITL ERIL PHOTOS Y PPLYING DIGITL TERRIN MODEL bsztrakt/bstract

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

4.1 Tangent Lines. y 2 y 1 = y 2 y 1

4.1 Tangent Lines. y 2 y 1 = y 2 y 1 41 Tangent Lines Introduction Recall tat te slope of a line tells us ow fast te line rises or falls Given distinct points (x 1, y 1 ) and (x 2, y 2 ), te slope of te line troug tese two points is cange

More information

2.8 The derivative as a function

2.8 The derivative as a function CHAPTER 2. LIMITS 56 2.8 Te derivative as a function Definition. Te derivative of f(x) istefunction f (x) defined as follows f f(x + ) f(x) (x). 0 Note: tis differs from te definition in section 2.7 in

More information

Linear Interpolating Splines

Linear Interpolating Splines Jim Lambers MAT 772 Fall Semester 2010-11 Lecture 17 Notes Tese notes correspond to Sections 112, 11, and 114 in te text Linear Interpolating Splines We ave seen tat ig-degree polynomial interpolation

More information

4.2 The Derivative. f(x + h) f(x) lim

4.2 The Derivative. f(x + h) f(x) lim 4.2 Te Derivative Introduction In te previous section, it was sown tat if a function f as a nonvertical tangent line at a point (x, f(x)), ten its slope is given by te it f(x + ) f(x). (*) Tis is potentially

More information

Simulation of Sloshing Dynamics in a Tank by an Improved Volume-of-Fluid Method

Simulation of Sloshing Dynamics in a Tank by an Improved Volume-of-Fluid Method Proceedings of the Nineteenth (2009) International Offshore and Polar Engineering Conference Osaka, Japan, June 21-26, 2009 Copyright 2009 by The International Society of Offshore and Polar Engineers (ISOPE)

More information

Strömningslära Fluid Dynamics. Computer laboratories using COMSOL v4.4

Strömningslära Fluid Dynamics. Computer laboratories using COMSOL v4.4 UMEÅ UNIVERSITY Department of Physics Claude Dion Olexii Iukhymenko May 15, 2015 Strömningslära Fluid Dynamics (5FY144) Computer laboratories using COMSOL v4.4!! Report requirements Computer labs must

More information

Numerical Derivatives

Numerical Derivatives Lab 15 Numerical Derivatives Lab Objective: Understand and implement finite difference approximations of te derivative in single and multiple dimensions. Evaluate te accuracy of tese approximations. Ten

More information

UUV DEPTH MEASUREMENT USING CAMERA IMAGES

UUV DEPTH MEASUREMENT USING CAMERA IMAGES ABCM Symposium Series in Mecatronics - Vol. 3 - pp.292-299 Copyrigt c 2008 by ABCM UUV DEPTH MEASUREMENT USING CAMERA IMAGES Rogerio Yugo Takimoto Graduate Scool of Engineering Yokoama National University

More information

ANTENNA SPHERICAL COORDINATE SYSTEMS AND THEIR APPLICATION IN COMBINING RESULTS FROM DIFFERENT ANTENNA ORIENTATIONS

ANTENNA SPHERICAL COORDINATE SYSTEMS AND THEIR APPLICATION IN COMBINING RESULTS FROM DIFFERENT ANTENNA ORIENTATIONS NTNN SPHRICL COORDINT SSTMS ND THIR PPLICTION IN COMBINING RSULTS FROM DIFFRNT NTNN ORINTTIONS llen C. Newell, Greg Hindman Nearfield Systems Incorporated 133. 223 rd St. Bldg. 524 Carson, C 9745 US BSTRCT

More information

OpenFOAM in Wave and Offshore CFD

OpenFOAM in Wave and Offshore CFD OpenFOAM in Wave and Offshore CFD Capabilities of the Naval Hydro Pack Hrvoje Jasak Wikki Ltd. United Kingdom Faculty of Mechanical Engineering and Naval Architecture, Uni Zagreb, Croatia University of

More information

The impact of simplified UNBab mapping function on GPS tropospheric delay

The impact of simplified UNBab mapping function on GPS tropospheric delay Te impact of simplified UNBab mapping function on GPS troposperic delay Hamza Sakidin, Tay Coo Cuan, and Asmala Amad Citation: AIP Conference Proceedings 1621, 363 (2014); doi: 10.1063/1.4898493 View online:

More information

Eulerian Techniques for Fluid-Structure Interactions - Part II: Applications

Eulerian Techniques for Fluid-Structure Interactions - Part II: Applications Published in Lecture Notes in Computational Science and Engineering Vol. 103, Proceedings of ENUMATH 2013, pp. 755-762, Springer, 2014 Eulerian Techniques for Fluid-Structure Interactions - Part II: Applications

More information

Microwell Mixing with Surface Tension

Microwell Mixing with Surface Tension Microwell Mixing with Surface Tension Nick Cox Supervised by Professor Bruce Finlayson University of Washington Department of Chemical Engineering June 6, 2007 Abstract For many applications in the pharmaceutical

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

Solutions Manual for Fundamentals of Fluid Mechanics 7th edition by Munson Rothmayer Okiishi and Huebsch

Solutions Manual for Fundamentals of Fluid Mechanics 7th edition by Munson Rothmayer Okiishi and Huebsch Solutions Manual for Fundamentals of Fluid Mecanics 7t edition by Munson Rotmayer Okiisi and Huebsc Link full download : ttps://digitalcontentmarket.org/download/solutions-manual-forfundamentals-of-fluid-mecanics-7t-edition-by-munson-rotmayer-okiisi-and-uebsc/

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

VOLUMES. The volume of a cylinder is determined by multiplying the cross sectional area by the height. r h V. a) 10 mm 25 mm.

VOLUMES. The volume of a cylinder is determined by multiplying the cross sectional area by the height. r h V. a) 10 mm 25 mm. OLUME OF A CYLINDER OLUMES Te volume of a cylinder is determined by multiplying te cross sectional area by te eigt. r Were: = volume r = radius = eigt Exercise 1 Complete te table ( =.14) r a) 10 mm 5

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

Investigating an automated method for the sensitivity analysis of functions

Investigating an automated method for the sensitivity analysis of functions Investigating an automated metod for te sensitivity analysis of functions Sibel EKER s.eker@student.tudelft.nl Jill SLINGER j..slinger@tudelft.nl Delft University of Tecnology 2628 BX, Delft, te Neterlands

More information

THANK YOU FOR YOUR PURCHASE!

THANK YOU FOR YOUR PURCHASE! THANK YOU FOR YOUR PURCHASE! Te resources included in tis purcase were designed and created by me. I ope tat you find tis resource elpful in your classroom. Please feel free to contact me wit any questions

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

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

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

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

More information

Calculate a solution using the pressure-based coupled solver.

Calculate a solution using the pressure-based coupled solver. Tutorial 19. Modeling Cavitation Introduction This tutorial examines the pressure-driven cavitating flow of water through a sharpedged orifice. This is a typical configuration in fuel injectors, and brings

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

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

When the dimensions of a solid increase by a factor of k, how does the surface area change? How does the volume change?

When the dimensions of a solid increase by a factor of k, how does the surface area change? How does the volume change? 8.4 Surface Areas and Volumes of Similar Solids Wen te dimensions of a solid increase by a factor of k, ow does te surface area cange? How does te volume cange? 1 ACTIVITY: Comparing Surface Areas and

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

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

13.5 DIRECTIONAL DERIVATIVES and the GRADIENT VECTOR

13.5 DIRECTIONAL DERIVATIVES and the GRADIENT VECTOR 13.5 Directional Derivatives and te Gradient Vector Contemporary Calculus 1 13.5 DIRECTIONAL DERIVATIVES and te GRADIENT VECTOR Directional Derivatives In Section 13.3 te partial derivatives f x and f

More information

3.6 Directional Derivatives and the Gradient Vector

3.6 Directional Derivatives and the Gradient Vector 288 CHAPTER 3. FUNCTIONS OF SEVERAL VARIABLES 3.6 Directional Derivatives and te Gradient Vector 3.6.1 Functions of two Variables Directional Derivatives Let us first quickly review, one more time, te

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

THE SIMULATION OF VIOLENT FREE-SURFACE DYNAMICS AT SEA AND IN SPACE

THE SIMULATION OF VIOLENT FREE-SURFACE DYNAMICS AT SEA AND IN SPACE European Conference on Computational Fluid Dynamics ECCOMAS CFD 2006 P. Wesseling, E. Oñate and J. Périaux (Eds) c TU Delft, The Netherlands, 2006 THE SIMULATION OF VIOLENT FREE-SURFACE DYNAMICS AT SEA

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

Section 1.2 The Slope of a Tangent

Section 1.2 The Slope of a Tangent Section 1.2 Te Slope of a Tangent You are familiar wit te concept of a tangent to a curve. Wat geometric interpretation can be given to a tangent to te grap of a function at a point? A tangent is te straigt

More information

Using a Single Rotating Reference Frame

Using a Single Rotating Reference Frame Tutorial 9. Using a Single Rotating Reference Frame Introduction This tutorial considers the flow within a 2D, axisymmetric, co-rotating disk cavity system. Understanding the behavior of such flows is

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

19.2 Surface Area of Prisms and Cylinders

19.2 Surface Area of Prisms and Cylinders Name Class Date 19 Surface Area of Prisms and Cylinders Essential Question: How can you find te surface area of a prism or cylinder? Resource Locker Explore Developing a Surface Area Formula Surface area

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

CESILA: Communication Circle External Square Intersection-Based WSN Localization Algorithm

CESILA: Communication Circle External Square Intersection-Based WSN Localization Algorithm Sensors & Transducers 2013 by IFSA ttp://www.sensorsportal.com CESILA: Communication Circle External Square Intersection-Based WSN Localization Algoritm Sun Hongyu, Fang Ziyi, Qu Guannan College of Computer

More information

Non-Newtonian Transitional Flow in an Eccentric Annulus

Non-Newtonian Transitional Flow in an Eccentric Annulus Tutorial 8. Non-Newtonian Transitional Flow in an Eccentric Annulus Introduction The purpose of this tutorial is to illustrate the setup and solution of a 3D, turbulent flow of a non-newtonian fluid. Turbulent

More information

Haar Transform CS 430 Denbigh Starkey

Haar Transform CS 430 Denbigh Starkey Haar Transform CS Denbig Starkey. Background. Computing te transform. Restoring te original image from te transform 7. Producing te transform matrix 8 5. Using Haar for lossless compression 6. Using Haar

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

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

Symmetric Tree Replication Protocol for Efficient Distributed Storage System*

Symmetric Tree Replication Protocol for Efficient Distributed Storage System* ymmetric Tree Replication Protocol for Efficient Distributed torage ystem* ung Cune Coi 1, Hee Yong Youn 1, and Joong up Coi 2 1 cool of Information and Communications Engineering ungkyunkwan University

More information

Numerical Estimation and Validation of Shallow Draft Effect on Roll Damping

Numerical Estimation and Validation of Shallow Draft Effect on Roll Damping The 14 th International Ship Stability Workshop (ISSW), 29 th September- 1 st October 2014, Kuala Lumpur, Malaysia Numerical Estimation and Validation of Shallow Draft Effect on Roll Damping Toru Katayama

More information

Tutorial 1. Introduction to Using FLUENT: Fluid Flow and Heat Transfer in a Mixing Elbow

Tutorial 1. Introduction to Using FLUENT: Fluid Flow and Heat Transfer in a Mixing Elbow Tutorial 1. Introduction to Using FLUENT: Fluid Flow and Heat Transfer in a Mixing Elbow Introduction This tutorial illustrates the setup and solution of the two-dimensional turbulent fluid flow and heat

More information

12.2 Investigate Surface Area

12.2 Investigate Surface Area Investigating g Geometry ACTIVITY Use before Lesson 12.2 12.2 Investigate Surface Area MATERIALS grap paper scissors tape Q U E S T I O N How can you find te surface area of a polyedron? A net is a pattern

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

Best Practices Workshop: Overset Meshing

Best Practices Workshop: Overset Meshing Best Practices Workshop: Overset Meshing Overview Introduction to Overset Meshes Range of Application Workflow Demonstrations and Best Practices What are Overset Meshes? Overset meshes are also known as

More information

Section 3. Imaging With A Thin Lens

Section 3. Imaging With A Thin Lens Section 3 Imaging Wit A Tin Lens 3- at Ininity An object at ininity produces a set o collimated set o rays entering te optical system. Consider te rays rom a inite object located on te axis. Wen te object

More information

Multi-Stack Boundary Labeling Problems

Multi-Stack Boundary Labeling Problems Multi-Stack Boundary Labeling Problems Micael A. Bekos 1, Micael Kaufmann 2, Katerina Potika 1 Antonios Symvonis 1 1 National Tecnical University of Atens, Scool of Applied Matematical & Pysical Sciences,

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

A Finite Element Scheme for Calculating Inverse Dynamics of Link Mechanisms

A Finite Element Scheme for Calculating Inverse Dynamics of Link Mechanisms WCCM V Fift World Congress on Computational Mecanics July -1,, Vienna, Austria Eds.: H.A. Mang, F.G. Rammerstorfer, J. Eberardsteiner A Finite Element Sceme for Calculating Inverse Dynamics of Link Mecanisms

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

Fourth-order NMO velocity for P-waves in layered orthorhombic media vs. offset-azimuth

Fourth-order NMO velocity for P-waves in layered orthorhombic media vs. offset-azimuth Fourt-order NMO velocity for P-waves in layered orrombic media vs. set-azimut Zvi Koren* and Igor Ravve Paradigm Geopysical Summary We derive te fourt-order NMO velocity of compressional waves for a multi-layer

More information

A COUPLED FINITE VOLUME SOLVER FOR THE SOLUTION OF LAMINAR TURBULENT INCOMPRESSIBLE AND COMPRESSIBLE FLOWS

A COUPLED FINITE VOLUME SOLVER FOR THE SOLUTION OF LAMINAR TURBULENT INCOMPRESSIBLE AND COMPRESSIBLE FLOWS A COUPLED FINITE VOLUME SOLVER FOR THE SOLUTION OF LAMINAR TURBULENT INCOMPRESSIBLE AND COMPRESSIBLE FLOWS L. Mangani Maschinentechnik CC Fluidmechanik und Hydromaschinen Hochschule Luzern Technik& Architektur

More information

12.2 Techniques for Evaluating Limits

12.2 Techniques for Evaluating Limits 335_qd /4/5 :5 PM Page 863 Section Tecniques for Evaluating Limits 863 Tecniques for Evaluating Limits Wat ou sould learn Use te dividing out tecnique to evaluate its of functions Use te rationalizing

More information

Grid Adaptation for Functional Outputs: Application to Two-Dimensional Inviscid Flows

Grid Adaptation for Functional Outputs: Application to Two-Dimensional Inviscid Flows Journal of Computational Pysics 176, 40 69 (2002) doi:10.1006/jcp.2001.6967, available online at ttp://www.idealibrary.com on Grid Adaptation for Functional Outputs: Application to Two-Dimensional Inviscid

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

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

Drop Impact Simulation with a Velocity-Dependent Contact Angle

Drop Impact Simulation with a Velocity-Dependent Contact Angle ILASS Americas 19th Annual Conference on Liquid Atomization and Spray Systems, Toronto, Canada, May 2006 Drop Impact Simulation with a Velocity-Dependent Contact Angle S. Afkhami and M. Bussmann Department

More information

Alternating Direction Implicit Methods for FDTD Using the Dey-Mittra Embedded Boundary Method

Alternating Direction Implicit Methods for FDTD Using the Dey-Mittra Embedded Boundary Method Te Open Plasma Pysics Journal, 2010, 3, 29-35 29 Open Access Alternating Direction Implicit Metods for FDTD Using te Dey-Mittra Embedded Boundary Metod T.M. Austin *, J.R. Cary, D.N. Smite C. Nieter Tec-X

More information

cuibm A GPU Accelerated Immersed Boundary Method

cuibm A GPU Accelerated Immersed Boundary Method cuibm A GPU Accelerated Immersed Boundary Method S. K. Layton, A. Krishnan and L. A. Barba Corresponding author: labarba@bu.edu Department of Mechanical Engineering, Boston University, Boston, MA, 225,

More information

Bounding Tree Cover Number and Positive Semidefinite Zero Forcing Number

Bounding Tree Cover Number and Positive Semidefinite Zero Forcing Number Bounding Tree Cover Number and Positive Semidefinite Zero Forcing Number Sofia Burille Mentor: Micael Natanson September 15, 2014 Abstract Given a grap, G, wit a set of vertices, v, and edges, various

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

The (, D) and (, N) problems in double-step digraphs with unilateral distance

The (, D) and (, N) problems in double-step digraphs with unilateral distance Electronic Journal of Grap Teory and Applications () (), Te (, D) and (, N) problems in double-step digraps wit unilateral distance C Dalfó, MA Fiol Departament de Matemàtica Aplicada IV Universitat Politècnica

More information

( ) ( ) Mat 241 Homework Set 5 Due Professor David Schultz. x y. 9 4 The domain is the interior of the hyperbola.

( ) ( ) Mat 241 Homework Set 5 Due Professor David Schultz. x y. 9 4 The domain is the interior of the hyperbola. Mat 4 Homework Set 5 Due Professor David Scultz Directions: Sow all algebraic steps neatly and concisely using proper matematical symbolism. Wen graps and tecnology are to be implemented, do so appropriately.

More information

Some Handwritten Signature Parameters in Biometric Recognition Process

Some Handwritten Signature Parameters in Biometric Recognition Process Some Handwritten Signature Parameters in Biometric Recognition Process Piotr Porwik Institute of Informatics, Silesian Uniersity, Bdziska 39, 41- Sosnowiec, Poland porwik@us.edu.pl Tomasz Para Institute

More information