Fluid Simulation and Reaction-Diffusion Textures on Surfaces Maria Andrade Luiz Velho (supervisor) Technical Report TR Relatório Técnico

Size: px
Start display at page:

Download "Fluid Simulation and Reaction-Diffusion Textures on Surfaces Maria Andrade Luiz Velho (supervisor) Technical Report TR Relatório Técnico"

Transcription

1 Laboratório VISGRAF Instituto de Matemática Pura e Aplicada Fluid Simulation and Reaction-Diffusion Textures on Surfaces Maria Andrade Luiz Velho (supervisor) Technical Report TR-0-0 Relatório Técnico February Fevereiro The contents of this report are the sole responsibility of the authors. O conteúdo do presente relatório é de única responsabilidade dos autores.

2 Fluid Simulation and Reaction - Diffusion Textures on Surface Maria Andrade mcosta@impa.br Supervisor: Luiz Velho February 0 Abstract: In this note we show how to simulate fluids on surfaces using Navier- Stokes equations and generate texture on surfaces with the reaction-diffusion model due to Gray and Scott. The parametrization of Catmull-Clark surfaces is used to obtain a good discretization of the operators defined on surfaces which implies nice results on simulation and textures. Introduction Firstly, to simulate fluid (see the figure ) on surface we need to get a parametrization for this surface, one good candidate is a Catmull-Clark surface, which is smooth almost everywhere [5]. Moreover, it is necessary to compare vectors in different points on the surface to evaluate velocity, force, etc. Figure : Simulation of fluid on closed surfaces. To solve the Navier-Stokes equations on surfaces we follow these steps: take a parametrization of a Catmull-Clark surface; calculate a metric that depends on its tangent vectors and use this metric to get the necessary differential operators; solve the Navier- Stokes equations on a discretization of the surface, dealing with the transition of the fluid between the patches that form the surface. This research on fluid simulation on surfaces was performed togheter with Leonardo Carvalho and Dalia Bonilla based on [8] during the Trimester Program on Computacional Manifolds and Applications, see mcosta/fluidsurf/

3 In the second part of this note it is shown how to generate texture on a surface with the reaction diffusion model due to Gray and Scott. More precisely, to solve reactiondiffusion sytems on surfaces the basics steps used here are: use the parametrization of a Catmull-Clark surface and calculate only the Laplacian operator defined on this surface. In this case it is simpler than the simulation fluid, because it is not necessary to calculate the gradient and divergent operators. Previous Work In recent years, many researches were developed to use the Navier-Stokes equations for fluid simulation. In particular, these investigations have contributed for many areas. For example, special effects industry. In this way, Jos Stam [6] had proposed a stable algoritm called stable-fluid that solves the Navier-Stokes equations for three-dimensional fluids, which is fast, stable and it is the basis to simulate smoke, water and fire, but this process is dissipative. Fedkiw, R. et al. [7] did a change in the discretization, which improved the problem with dissipation. More recently, algorithms were developed to simulate fluids on arbitrary surfaces [8]. In this case, one important point is to get information about the metric defined on surfaces, because to solve Navier-Stokes equations we need to calculate differential operators: gradient, Laplacian and divergent, which depend on the metric and if this is ignored, then there will be visible artefacts (see figure ). Figure : Ignores the metric (left) [8]. In the case of reaction-diffusion systems, Turing [] in 95 had described at the first time a chemical mechanism for pattern formation which is called reaction-diffusion. Greg Turk [4] used this mechanism to generate textures on surfaces. Moreover, Sanderson et al. [9] used many reaction-diffusion models for textures synthesis. Bajaj, C. et al. [] gave an approach to solve reaction-diffusion sytem on surfaces using a Galerkin based finite element methods.

4 Subdivision Surfaces In computer graphics it is usual to create a coarse polygon mesh that aproximates the shape of a desired surface. To obtain the smooth surfaces we subdivide each polygonal face into smaller faces that better approximate the smooth surface and in the limit of subdision we get the smooth surface. In this work it is used the Catmull-Clark subdivision (see figure 3), which is a generalization of bi-cubic uniform B-spline for arbitrary meshes. This process generates limit surfaces that are C continuos everywhere except at extradordinary vertices where they are C continous, in particular at each point on a surface the tangent plane can be defined. Figure 3: Example of a Catmull-Clark subdivision surface ( c wikipedia). One vertice is called extraordinary if its valence in not four. For example, in figure 4 the color blue corresponds to the regions that have extraordinary vertices. Figure 4: Paramettrization of a Catmull-Clark surface [5]. 3

5 Operators on Surfaces In order to solve the differential equations on a surface we need to calculate some differential operators on the surface. In our case, we need the Laplacian, gradient and divergent operators [3]. Given a parametrization X(x, x ) of a surface, we obtain the X X metric gij = h x, i, i, j =,, the matrix of the metric g = (gij ) and the inverse of i xj g g g, g = g = and g =, the metric is denoted by g = (g ij ), where g = G G G here G = det(gij ) = g g g > 0. The differential operators Laplacian, gradient and divergent on the surface are, respectively, given by ϕ= G xi 3 i,j ϕ Gg xj ϕ, ϕ = g and u = j x G i,j i Gu. xi Discretization We have used a parametrization of the Catmull-Clark subdivision surface, as described by Jos Stam [5], where the surface is divided into patches Xp (x, x ) : Ωp R3, here Ωp = [0, ] [0, ], p =... P (see the figure 5). Figure 5: On the left, surface divided into patches. The colors indicate the coordinate system of each patch. On the right, the scalar functions are calculated at the cell centers and for vectors functions the first and second coordiantes are defined at the squares and diamonds, respectively. Note that in the Euclidean case we have G P= =i,jg = g and g = 0. i,j The Einstein s notation means ai b cj = i,j ai b cj. 4

6 Each domain is divided in a uniform grid with (N + ) (N + ) cells, where the N N inner cells correpond to the regions of each patch ( white cells in figure 5) and the outer cells correspond to regions of neighbor patches (gray cells), for each domain we need to update the neighbor cell it is important to know the orientation of each neighbor patch. We associate a label for each edge ( see figure 6). 3 Figure 6: Boundaries and label each edge. 0 The base mesh can be supposed to be made up only by quads, if it is not can be refined once. To simulate fluid through the patches we need to determine the transition function between neighbor patches. The transition function φ depends only on the number given by t k = e k, e j = (4 + e k (e j + )%4)%4 for k and j {0,,, 3}. The transition functions between patches depends only on four functions: φ 0 = id, φ = R π/ φ 0, φ = R π/ φ and φ 3 = R π/ φ 3, where R π/ is the rotation of 90 in counterclockwise. To update the boundary values for scalar functions we calculate the transition number and then we determine the transition function calculate in the corresponding domain, as shown in figure 8. The figure 7 showns an example of the transition function. In this case, t = 3. So, the boundary is calculated by ϕ(n +, j) = ϕ (φ 3 (, j)) Figure 7: Example of transition function. 5

7 Figure 8: Boundary values for scalar functions. For vector fields, we need to calculate the change of coordinates given by the derivatives of the transitions functions, the new coordinate systems are given by the matrices: ( ) ( ) ( ) ( M t0 =, M t =, M t =, M t3 = ) 0. 0 So, we apply the following rules, see figure 9, to update the neighbor values for vector fields: Figure 9: Boundary values for vector fields. 6

8 4 Navier-Stokes Equations A fluid is a velocity field satisfying the Navier-Stokes equations: u = (u )u + ν u + f, t u = 0 where u is the velocity, ν is the viscosity and f is an external force. We can add a scalar field representing a density moving through the velocity field satisfying: ρ t = (u )ρ + κ ρ + S where ρ is the density, κ is a diffusion rate and S is source of density. Solution of Navier-Stokes Equations Temam [] had proved that we can solve the Navier-Stokes equations in four steps. u 0 = force u == diffuse u == advect u 3 ==== project In the first step the force is added, after the diffusion is solved, then the advection and finally the projection, in other words we solve each one of these equations, sequentially u 4. Adding forces - First, we solve this equation u t = f which is discretized by u = u 0 + tf. So, we just sum the values of the external forces to the current velocity, see figure 0. Figure 0: Forces added to a velocity field on the surface. 7

9 . Diffusion - Now, we solve the diffusion equation which is discretized by u t = ν u, u u t = ν u (I tν )u = u. This is a linear system that we solve using an iterative method (Jacobi) improved by a multigrid schemme. The figure shows the result after solve the diffusion. Figure : On the right after diffusion. where The Laplacian operator is discretized, see [8], as follows: ( ϕ) i,j = h ( G) i,j (D, i,j + D, i,j + D, i,j + D, i,j ), D, i,j = A i+,jd, A i+,j i,jd, i D,,j, i,j = B i+,jd, B i+,j i,jd, i,j, D, i,j = B i,j+ D, i,j+ B i,j D,, D, i,j i,j = C i,j+ D, i,j+ A = Gg,, B = Gg,, C = Gg, (see figure ). C i,j D,, i,j (i-, j+) (i, j+) (i+, j+) (i-, j) (i, j) (i+, j) (i-, j-) (i, j-) (i+, j-) Figure : For example D, i,j = ϕ i+,j ϕ i,j. 8

10 3. Advection - The advection equation is given by u 3 t = (u )u 3 = (ū R )u 3, here ū = (u g + u g, u g + u g ). Which is solved using a semi-lagrangian technique, where we calculate the trajectory of each point using ū to find its position in the moment t t ( see figure 4). x(t t) x(t) x(t t) = x(t) tū, u 3 (x(t)) = u (x(t t)). We denote the position in the time t t by x(t t) := (i, j). Then we calculate the velocity u(i, j): if (i < 0.5) u(i, j) = M t3 (u 3 (φ t3 (i + N, j))) if (i > N + 0.5) u(i, j) = M t (u (φ t (i N, j))) if (j < 0.5) u(i, j) = M t0 (u 0 (φ t0 (i, j + N))) if (j > N + 0.5) u(i, j) = M t (u (φ t (i, j N))) else u(i, j) = interpolation 9

11 Interpolation of velocities: If (j j 0.5) ( u (i, j) = bilerp i ī, j j + 0.5, u (ī, j 0.5), u (ī +, j 0.5), ) u (ī, j + 0.5), u (ī +, ī + 0.5) else ( u (i, j) = bilerp i ī, j j 0.5, u (ī, j + 0.5), u (ī +, j + 0.5), ) u (ī, j +.5), u (ī +, ī +.5) end if The same way for i. 4. Projection - The result of the last step is projected on a space whose divergent is 0 (see figure 3). Pu 3 = u 4, u 4 = 0. Figure 3: Projection. This operator can be defined using Theorem [Hemholtz-Hodge Decompositon Theorem ] Let W R n be a a fluid region and u : W R n a smooth vector field. There exists a unique decompostion of u such that, for smooth u s : W R n and u p : W R n, u = u s + u p, u s = 0 on W, u s n = 0 on W, u p ϕ on W for some smooth ϕ : W R. Proof: The proof of this theorem can be seen in [0]. 0

12 By the Hemholtz-Hodge decomposition theorem, we can write u = u s + u p = u s + ϕ. So, u = u s + ϕ = ϕ, where the divergence operator is discretized by here ( u) ij = ( G) i,j h (D i,j + D i,j), D i,j = ( G) i+,j(u ) i+,j ( G) i,j(u ) i,j Di,j = ( G) i,j+ (u ) i,j+ ( G) i,j (u ) i,j and finally we define u 4 = u 3 ϕ, where the gradient operator is discretized by ( ϕ) i+,j = h ( ϕ) i,j+ and h = /N is grid spacing. = h ( (g, i+,j)d, i+,j + (g, i+,j)d,, ) i+,j ) ( (g, )D, + (g, )D, i,j+ i,j+ i,j+ i,j+ Figure 4: On the left after advection and on the right after projection. The figure 4 compares the advection with the projection. For the density field we want to solve the equation This is done in three steps: ρ t = (u )ρ + κ ρ + S. ρ 0 ====== add source ρ ===== diffusion ρ ===== advection ρ 3

13 . Addition of density sources - We first solve this equation ρ t = S, which is discretized by ρ = ρ 0 + S t (see figure 5 after add source). Figure 5: From the initial density (on the left), we add sources (on the right).. Diffusion of density field - Next, we solve the diffusion ρ t = κ ρ, which is discretized by (I tκ )ρ = ρ (see figure 6). And solve using the same schemme used for the velocity field. Figure 6: On the left before diffusion and on the right after diffusion. 3. Advection of density field - Finally, the advection equation is given by ρ t = (u )ρ = (ū R )ρ, where ū = (u g + u g, u g + u g ).

14 In the same way that we analyze the boundary conditions for the velocity, now we calculate the value of density field in the boundary of domain. if (i < 0.5) ρ(i, j) = ρ 3 (φ t3 (i + N, j)) if (i > N + 0.5) ρ(i, j) = ρ (φ t (i N, j)) if (j < 0.5) ρ(i, j) = ρ 0 (φ t0 (i, j + N)) if (j > N + 0.5) ρ(i, j) = ρ (φ t (i, j N)) else ρ(i, j) = interpolation Interpolation of density ( ρ(i, j) = bilerp i ī, j j, ρ(ī, j), ρ(ī +, j), ) ρ(ī, j + ), ρ(ī +, j + ) Example Let f g = Gρu g be the gravity force (see figure 8 and 9), where G is a constant and u g are the coordinates of the projection d T = d (d n)n of d in the plane tangent. Figure 7: [8]. 3

15 Define a = d T t, b = d T s and c = t s. Then we get u g = a bc c u g = b cu g. Figure 8: Stanford Bunny initial (on the left) and after simulation (on the right). Figure 9: Model fertilily initial (on the left) and after simulation (on the right). For this example, we read result meshes of the work Mixed-Integer Quadrangulation []. 4

16 Example Another example is a simulation of a force applied by a finger moving on each surface patch. In our examples the finger follows a circular trajectory defined on the parameter space of each patch (see figure 0). Figure 0: Plane initial (on the left) and after appply the finger force (on the right). 5 Reaction-Diffusion Systems The other application of the discretization of differential operators on surfaces that we have studied is the solution of reaction-diffusion systems. This kind of systems can be applied in chemistry, but it can also be found for example in biology and ecology. In our case, they are used to obtain textures on surfaces. Reaction-Diffusion systems are defined by these nonlinear partial differential equations: a = F (a, b) + ra a, t b = G(a, b) + rb b, t where a and b are substances distributed in space, F and G are functions that control the production rate of a and b, the coefficients ra and rb are the diffusion rates, and is the Laplacian operator. These substances are affected by two processes: local chemical reactions, which means that the substances are transformed into each other, and diffusion which causes the substances to spread out over a surface in space. We consider the reaction-diffusion model developed by Gray and Scott, which is defined by F (a, b) = ab + f ( a) and G(a, b) = ab (f + k)b, where f and k are real parameters. 5

17 For implementation, we used the structure described in the first part where we have the parametrization of Catmull-Clark and the Laplacian operator. To solve the Gray- Scott reaction diffusion system, we have used the parameters k, f, r a and r b that Greg Turk 3 had suggested. Since this model is quite sensitive to its initial conditions, we firstly initialize the concentration values in the cell centers. After this, we use the Laplacian operator calculated before and we solve the reaction-diffusion system using the Euler method as the next algorithm shows. Data: r a, r b, f, k, t. Result: The concentratrions a and b. for l to N do end for c to N do Compute the Laplacian operator of concentrations a and b. //compute the new rate of change of a and b da(c, l) = a b b + f ( a) + r a Laplacian(a, c, l); db(c, l) = a b b (f + k) b + r b Laplacian(b, c, l); end //effect change for l to N do end for c to N do a(c, l)+ = ( t da(c, l)); b(c, l)+ = ( t db(c, l)); end Algorithm : Reaction diffusion system. Note that in this algorithm we do not update the neighbor concentrations, but this brings problems, because the concentrations in the patches influence each others (see figure ). So, we update the neighbor concentrations in the same way that we did for the density. 3 See turk 6

18 Figure : Reaction diffusion sytems without update neighbors concentrations (on the left) and with update neighbors concentrations (on the right.) 6 Conclusion In this work, we had simulated fluids and applied textures on surfaces using the Navier-Stokes equations and the Gray-Scott model, respectively. The first case is more complicated, because we need to solve the Navier-Stokes equations in four steps, which involve the Laplacian, divergent and gradient operators. For future works, we want to improve the numerical instability caused by the Euler method using to solve the reaction - diffusion system. Moreover, we begin to study other models to reaction - diffusion to apply different textures on surfaces. Acknowledgements The author would like to thank Luiz Velho, Leonardo Carvalho and Dalia Bonilla for their constructive remarks and incentive. This work is partially financed by CAPES/INCTMat. Some Results. Simulation of fluids examples: Figure : This example compares the results of the simulation without and with the treatment of neighbour patches, respectively. 7

19 Figure 3: This example shows the result of the simulation without the treatment of neighbour patches. The fluid seems to vanish from one patch to another. Figure 4: Fluids simulation with the treatment of neighbour patches. Figure 5: For this example, we read result meshes of the work Mixed-Integer Quadrangulation []. 8

20 . Reaction-diffusion examples: Figure 6: We use ra = 0.08, rb = 0.5ra, f = 0.056, k = Figure 7: We use ra = 0.08, rb = 0.5ra, f = 0.08, k = Figure 8: We use ra = 0.08, rb = 0.5ra, f = 0.08, k =

21 Figure 9: We use ra = 0.08, rb = 0.5ra, f = 0.035, k = Figure 30: We use ra = 0.08, rb = 0.5ra, f = 0.038, k =

22 References [] Turing, A. The Chemical Basis of Morphogenesis. Philosophical Transactions of the Royal Society B, August 4, 95. Vol. 37, [] Temam, R. Sur l approximation de la solution des équations de navier-stokes par la méthodes des pas fractionnaires. Arch. Rat. Mech. Anal. 33, [3] Aris, R. Vectors, Tensors and the Basic Equations of Fluid Mechanics. 989, Dover, New York. [4] Turk, G. Generating Textures on Arbitrary Surfaces Using Reaction-Diffusion. In Computer Graphics (SIGGRAPH 9), [5] Stam, J. Exact Evaluation of Catmull-Clark Subdivision Surfaces at Arbitrary Parameter Values. In SIGGRAPH 98 Conference Proceedings, Annual Conference Series, July 998, [6] Stam, J. Stable Fluids. In SIGGRAPH 99 Conference Proceedings, Annual Conference Series, August 999, -8. [7] Fedkiw, R., Stam, J. and Jensen, H.W. Visual Simulation of Smoke. In SIGGRAPH 00 Conference Proceedings, Annual Conference Series, August 00, 5-. [8] Stam, J. Flows on Surfaces of Arbitrary Topology. ACM Transactions On Graphics (TOG), Volume, Issue 3 (July 003) : Proceedings of SIGGRAPH 003, [9] Sanderson, A. R., Kirby, R. M., Johnson, C. R. and Yang L. Advanced Reaction- Diffusion Models for Texture Synthesis. J. Graphics Tools 006,, [0] Macedo, I. On the Simaulation of Fluids for Computer Graphics. Master s thesis, IMPA - Instituto de Matematica Pura e Aplicada, December 007. [] Bajaj, C., Zhang, Y. and Xu, G. Physically-based Surface Texture Synthesis Using a Coupled Finite Element System. GMP 08 Proceedings of the 5th international conference on Advances in geometric modeling and processing.springer-verlag Berlin. [] Bommes, D., Zimmer H. and Kobbelt, L. Mixed-Integer Quadrangulation. ACM Transactions On Graphics (TOG),8(3), 009: Proceedings of SIGGRAPH 009.

Flows on Surfaces of Arbitrary Topology

Flows on Surfaces of Arbitrary Topology Flows on Surfaces of Arbitrary Topology Jos Stam Alias wavefront a b c d e Figure : Snapshots of flows on various surfaces computed using our novel technique Abstract In this paper we introduce a method

More information

Generalizing the C 4 Four-directional Box Spline to Surfaces of Arbitrary Topology Luiz Velho Abstract. In this paper we introduce a new scheme that g

Generalizing the C 4 Four-directional Box Spline to Surfaces of Arbitrary Topology Luiz Velho Abstract. In this paper we introduce a new scheme that g Generalizing the C 4 Four-directional Box Spline to Surfaces of Arbitrary Topology Luiz Velho Abstract. In this paper we introduce a new scheme that generalizes the four-directional box spline of class

More information

Using Semi-Regular 4 8 Meshes for Subdivision Surfaces

Using Semi-Regular 4 8 Meshes for Subdivision Surfaces Using Semi-Regular 8 Meshes for Subdivision Surfaces Luiz Velho IMPA Instituto de Matemática Pura e Aplicada Abstract. Semi-regular 8 meshes are refinable triangulated quadrangulations. They provide a

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

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

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

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

Subdivision. Outline. Key Questions. Subdivision Surfaces. Advanced Computer Graphics (Spring 2013) Video: Geri s Game (outside link)

Subdivision. Outline. Key Questions. Subdivision Surfaces. Advanced Computer Graphics (Spring 2013) Video: Geri s Game (outside link) Advanced Computer Graphics (Spring 03) CS 83, Lecture 7: Subdivision Ravi Ramamoorthi http://inst.eecs.berkeley.edu/~cs83/sp3 Slides courtesy of Szymon Rusinkiewicz, James O Brien with material from Denis

More information

G 2 Interpolation for Polar Surfaces

G 2 Interpolation for Polar Surfaces 1 G 2 Interpolation for Polar Surfaces Jianzhong Wang 1, Fuhua Cheng 2,3 1 University of Kentucky, jwangf@uky.edu 2 University of Kentucky, cheng@cs.uky.edu 3 National Tsinhua University ABSTRACT In this

More information

Evaluation of Loop Subdivision Surfaces

Evaluation of Loop Subdivision Surfaces Evaluation of Loop Subdivision Surfaces Jos Stam Alias wavefront, Inc. 8 Third Ave, 8th Floor, Seattle, WA 980, U.S.A. jstam@aw.sgi.com Abstract This paper describes a technique to evaluate Loop subdivision

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

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

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

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

Overview. Applications of DEC: Fluid Mechanics and Meshing. Fluid Models (I) Part I. Computational Fluids with DEC. Fluid Models (II) Fluid Models (I)

Overview. Applications of DEC: Fluid Mechanics and Meshing. Fluid Models (I) Part I. Computational Fluids with DEC. Fluid Models (II) Fluid Models (I) Applications of DEC: Fluid Mechanics and Meshing Mathieu Desbrun Applied Geometry Lab Overview Putting DEC to good use Fluids, fluids, fluids geometric interpretation of classical models discrete geometric

More information

Subdivision Surfaces

Subdivision Surfaces Subdivision Surfaces 1 Geometric Modeling Sometimes need more than polygon meshes Smooth surfaces Traditional geometric modeling used NURBS Non uniform rational B-Spline Demo 2 Problems with NURBS A single

More information

Normals of subdivision surfaces and their control polyhedra

Normals of subdivision surfaces and their control polyhedra Computer Aided Geometric Design 24 (27 112 116 www.elsevier.com/locate/cagd Normals of subdivision surfaces and their control polyhedra I. Ginkel a,j.peters b,,g.umlauf a a University of Kaiserslautern,

More information

Subdivision Curves and Surfaces

Subdivision Curves and Surfaces Subdivision Surfaces or How to Generate a Smooth Mesh?? Subdivision Curves and Surfaces Subdivision given polyline(2d)/mesh(3d) recursively modify & add vertices to achieve smooth curve/surface Each iteration

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

u 0+u 2 new boundary vertex

u 0+u 2 new boundary vertex Combined Subdivision Schemes for the design of surfaces satisfying boundary conditions Adi Levin School of Mathematical Sciences, Tel-Aviv University, Tel-Aviv 69978, Israel. Email:fadilev@math.tau.ac.ilg

More information

Subdivision overview

Subdivision overview Subdivision overview CS4620 Lecture 16 2018 Steve Marschner 1 Introduction: corner cutting Piecewise linear curve too jagged for you? Lop off the corners! results in a curve with twice as many corners

More information

SOLVING PARTIAL DIFFERENTIAL EQUATIONS ON POINT CLOUDS

SOLVING PARTIAL DIFFERENTIAL EQUATIONS ON POINT CLOUDS SOLVING PARTIAL DIFFERENTIAL EQUATIONS ON POINT CLOUDS JIAN LIANG AND HONGKAI ZHAO Abstract. In this paper we present a general framework for solving partial differential equations on manifolds represented

More information

Shape Modeling and Geometry Processing

Shape Modeling and Geometry Processing 252-0538-00L, Spring 2018 Shape Modeling and Geometry Processing Discrete Differential Geometry Differential Geometry Motivation Formalize geometric properties of shapes Roi Poranne # 2 Differential Geometry

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

Until now we have worked with flat entities such as lines and flat polygons. Fit well with graphics hardware Mathematically simple

Until now we have worked with flat entities such as lines and flat polygons. Fit well with graphics hardware Mathematically simple Curves and surfaces Escaping Flatland Until now we have worked with flat entities such as lines and flat polygons Fit well with graphics hardware Mathematically simple But the world is not composed of

More information

Non-Uniform Recursive Doo-Sabin Surfaces (NURDSes)

Non-Uniform Recursive Doo-Sabin Surfaces (NURDSes) Non-Uniform Recursive Doo-Sabin Surfaces Zhangjin Huang 1 Guoping Wang 2 1 University of Science and Technology of China 2 Peking University, China SIAM Conference on Geometric and Physical Modeling Doo-Sabin

More information

Subdivision Curves and Surfaces: An Introduction

Subdivision Curves and Surfaces: An Introduction Subdivision Curves and Surfaces: An Introduction Corner Cutting De Casteljau s and de Boor s algorithms all use corner-cutting procedures. Corner cutting can be local or non-local. A cut is local if it

More information

Subdivision Surfaces

Subdivision Surfaces Subdivision Surfaces 1 Geometric Modeling Sometimes need more than polygon meshes Smooth surfaces Traditional geometric modeling used NURBS Non uniform rational B-Spline Demo 2 Problems with NURBS A single

More information

Computational Fluid Dynamics - Incompressible Flows

Computational Fluid Dynamics - Incompressible Flows Computational Fluid Dynamics - Incompressible Flows March 25, 2008 Incompressible Flows Basis Functions Discrete Equations CFD - Incompressible Flows CFD is a Huge field Numerical Techniques for solving

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

FLUID SIMULATION. Kristofer Schlachter

FLUID SIMULATION. Kristofer Schlachter FLUID SIMULATION Kristofer Schlachter The Equations Incompressible Navier-Stokes: @u @t = (r u)u 1 rp + vr2 u + F Incompressibility condition r u =0 Breakdown @u @t The derivative of velocity with respect

More information

Curve Corner Cutting

Curve Corner Cutting Subdivision ision Techniqueses Spring 2010 1 Curve Corner Cutting Take two points on different edges of a polygon and join them with a line segment. Then, use this line segment to replace all vertices

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

The Level Set Method. Lecture Notes, MIT J / 2.097J / 6.339J Numerical Methods for Partial Differential Equations

The Level Set Method. Lecture Notes, MIT J / 2.097J / 6.339J Numerical Methods for Partial Differential Equations The Level Set Method Lecture Notes, MIT 16.920J / 2.097J / 6.339J Numerical Methods for Partial Differential Equations Per-Olof Persson persson@mit.edu March 7, 2005 1 Evolving Curves and Surfaces Evolving

More information

On Smooth Bicubic Surfaces from Quad Meshes

On Smooth Bicubic Surfaces from Quad Meshes On Smooth Bicubic Surfaces from Quad Meshes Jianhua Fan and Jörg Peters Dept CISE, University of Florida Abstract. Determining the least m such that one m m bi-cubic macropatch per quadrilateral offers

More information

UNIVERSITY OF CALGARY. Subdivision Surfaces. Advanced Geometric Modeling Faramarz Samavati

UNIVERSITY OF CALGARY. Subdivision Surfaces. Advanced Geometric Modeling Faramarz Samavati Subdivision Surfaces Surfaces Having arbitrary Topologies Tensor Product Surfaces Non Tensor Surfaces We can t find u-curves and v-curves in general surfaces General Subdivision Coarse mesh Subdivision

More information

Polar Embedded Catmull-Clark Subdivision Surface

Polar Embedded Catmull-Clark Subdivision Surface Polar Embedded Catmull-Clark Subdivision Surface Anonymous submission Abstract In this paper, a new subdivision scheme with Polar embedded Catmull-Clark mesh structure is presented. In this new subdivision

More information

Near-Optimum Adaptive Tessellation of General Catmull-Clark Subdivision Surfaces

Near-Optimum Adaptive Tessellation of General Catmull-Clark Subdivision Surfaces Near-Optimum Adaptive Tessellation of General Catmull-Clark Subdivision Surfaces Shuhua Lai and Fuhua (Frank) Cheng (University of Kentucky) Graphics & Geometric Modeling Lab, Department of Computer Science,

More information

A Continuous 3-D Medial Shape Model with Branching

A Continuous 3-D Medial Shape Model with Branching A Continuous 3-D Medial Shape Model with Branching Timothy B. Terriberry Guido Gerig Outline Introduction The Generic 3-D Medial Axis Review of Subdivision Surfaces Boundary Reconstruction Edge Curves

More information

Tiled Textures What if Miro Had Painted a Sphere

Tiled Textures What if Miro Had Painted a Sphere Tiled Textures What if Miro Had Painted a Sphere ERGUN AKLEMAN, AVNEET KAUR and LORI GREEN Visualization Sciences Program, Department of Architecture Texas A&M University December 26, 2005 Abstract We

More information

2.2 Weighting function

2.2 Weighting function Annual Report (23) Kawahara Lab. On Shape Function of Element-Free Galerkin Method for Flow Analysis Daigo NAKAI and Mutsuto KAWAHARA Department of Civil Engineering, Chuo University, Kasuga 3 27, Bunkyo

More information

INF3320 Computer Graphics and Discrete Geometry

INF3320 Computer Graphics and Discrete Geometry INF3320 Computer Graphics and Discrete Geometry More smooth Curves and Surfaces Christopher Dyken, Michael Floater and Martin Reimers 10.11.2010 Page 1 More smooth Curves and Surfaces Akenine-Möller, Haines

More information

Spline Curves. Spline Curves. Prof. Dr. Hans Hagen Algorithmic Geometry WS 2013/2014 1

Spline Curves. Spline Curves. Prof. Dr. Hans Hagen Algorithmic Geometry WS 2013/2014 1 Spline Curves Prof. Dr. Hans Hagen Algorithmic Geometry WS 2013/2014 1 Problem: In the previous chapter, we have seen that interpolating polynomials, especially those of high degree, tend to produce strong

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

Example: Loop Scheme. Example: Loop Scheme. What makes a good scheme? recursive application leads to a smooth surface.

Example: Loop Scheme. Example: Loop Scheme. What makes a good scheme? recursive application leads to a smooth surface. Example: Loop Scheme What makes a good scheme? recursive application leads to a smooth surface 200, Denis Zorin Example: Loop Scheme Refinement rule 200, Denis Zorin Example: Loop Scheme Two geometric

More information

Approximating Catmull-Clark Subdivision Surfaces with Bicubic Patches

Approximating Catmull-Clark Subdivision Surfaces with Bicubic Patches Approximating Catmull-Clark Subdivision Surfaces with Bicubic Patches Charles Loop Microsoft Research Scott Schaefer Texas A&M University April 24, 2007 Technical Report MSR-TR-2007-44 Microsoft Research

More information

Free-Form Deformation and Other Deformation Techniques

Free-Form Deformation and Other Deformation Techniques Free-Form Deformation and Other Deformation Techniques Deformation Deformation Basic Definition Deformation: A transformation/mapping of the positions of every particle in the original object to those

More information

Approximation of 3D-Parametric Functions by Bicubic B-spline Functions

Approximation of 3D-Parametric Functions by Bicubic B-spline Functions International Journal of Mathematical Modelling & Computations Vol. 02, No. 03, 2012, 211-220 Approximation of 3D-Parametric Functions by Bicubic B-spline Functions M. Amirfakhrian a, a Department of Mathematics,

More information

Fully discrete Finite Element Approximations of Semilinear Parabolic Equations in a Nonconvex Polygon

Fully discrete Finite Element Approximations of Semilinear Parabolic Equations in a Nonconvex Polygon Fully discrete Finite Element Approximations of Semilinear Parabolic Equations in a Nonconvex Polygon Tamal Pramanick 1,a) 1 Department of Mathematics, Indian Institute of Technology Guwahati, Guwahati

More information

Fall CSCI 420: Computer Graphics. 4.2 Splines. Hao Li.

Fall CSCI 420: Computer Graphics. 4.2 Splines. Hao Li. Fall 2014 CSCI 420: Computer Graphics 4.2 Splines Hao Li http://cs420.hao-li.com 1 Roller coaster Next programming assignment involves creating a 3D roller coaster animation We must model the 3D curve

More information

Physically Based Simulation and Animation of Gaseous Phenomena in a Periodic Domain

Physically Based Simulation and Animation of Gaseous Phenomena in a Periodic Domain Physically Based Simulation and Animation of Gaseous Phenomena in a Periodic Domain Andrew Nealen Department of Computer Science, University of British Columbia CPSC 533b: Algorithmic Animation, Project

More information

Normals of subdivision surfaces and their control polyhedra

Normals of subdivision surfaces and their control polyhedra Normals of subdivision surfaces and their control polyhedra I. Ginkel, a, J. Peters b, and G. Umlauf a, a University of Kaiserslautern, Germany b University of Florida, Gainesville, FL, USA Abstract For

More information

Subdivision Depth Computation for Extra-Ordinary Catmull-Clark Subdivision Surface Patches

Subdivision Depth Computation for Extra-Ordinary Catmull-Clark Subdivision Surface Patches Subdivision Depth Computation for Extra-Ordinary Catmull-Clark Subdivision Surface Patches Fuhua Frank Cheng,GangChen, and Jun-Hai Yong University of Kentucky, Lexington, KY, USA Tsinghua University, Beijing,

More information

3-D Wind Field Simulation over Complex Terrain

3-D Wind Field Simulation over Complex Terrain 3-D Wind Field Simulation over Complex Terrain University Institute for Intelligent Systems and Numerical Applications in Engineering Congreso de la RSME 2015 Soluciones Matemáticas e Innovación en la

More information

Numerical Methods for PDEs. SSC Workgroup Meetings Juan J. Alonso October 8, SSC Working Group Meetings, JJA 1

Numerical Methods for PDEs. SSC Workgroup Meetings Juan J. Alonso October 8, SSC Working Group Meetings, JJA 1 Numerical Methods for PDEs SSC Workgroup Meetings Juan J. Alonso October 8, 2001 SSC Working Group Meetings, JJA 1 Overview These notes are meant to be an overview of the various memory access patterns

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

Geometric and Solid Modeling. Problems

Geometric and Solid Modeling. Problems Geometric and Solid Modeling Problems Define a Solid Define Representation Schemes Devise Data Structures Construct Solids Page 1 Mathematical Models Points Curves Surfaces Solids A shape is a set of Points

More information

Semi-Regular 4 8 Refinement and Box Spline Surfaces

Semi-Regular 4 8 Refinement and Box Spline Surfaces Semi-Regular 4 8 Refinement and Box Spline Surfaces LUIZ VELHO IMPA Instituto de Matemática Pura e Aplicada, lvelho@visgraf.impa.br Abstract. In this paper we introduce a new mesh refinement method for

More information

The goal is the definition of points with numbers and primitives with equations or functions. The definition of points with numbers requires a

The goal is the definition of points with numbers and primitives with equations or functions. The definition of points with numbers requires a The goal is the definition of points with numbers and primitives with equations or functions. The definition of points with numbers requires a coordinate system and then the measuring of the point with

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

Modified Catmull-Clark Methods for Modelling, Reparameterization and Grid Generation

Modified Catmull-Clark Methods for Modelling, Reparameterization and Grid Generation Modified Catmull-Clark Methods for Modelling, Reparameterization and Grid Generation Karl-Heinz Brakhage RWTH Aachen, 55 Aachen, Deutschland, Email: brakhage@igpm.rwth-aachen.de Abstract In this paper

More information

Geometric modeling 1

Geometric modeling 1 Geometric Modeling 1 Look around the room. To make a 3D model of a room requires modeling every single object you can see. Leaving out smaller objects (clutter) makes the room seem sterile and unrealistic

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

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

CS354 Computer Graphics Surface Representation IV. Qixing Huang March 7th 2018

CS354 Computer Graphics Surface Representation IV. Qixing Huang March 7th 2018 CS354 Computer Graphics Surface Representation IV Qixing Huang March 7th 2018 Today s Topic Subdivision surfaces Implicit surface representation Subdivision Surfaces Building complex models We can extend

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

Parameterization with Manifolds

Parameterization with Manifolds Parameterization with Manifolds Manifold What they are Why they re difficult to use When a mesh isn t good enough Problem areas besides surface models A simple manifold Sphere, torus, plane, etc. Using

More information

Interpolatory 3-Subdivision

Interpolatory 3-Subdivision EUROGRAPHICS 2000 / M. Gross and F.R.A. Hopgood (Guest Editors) Volume 19 (2000), Number 3 Interpolatory 3-Subdivision U. Labsik G. Greiner Computer Graphics Group University of Erlangen-Nuremberg Am Weichselgarten

More information

Subdivision surfaces for CAD: integration through parameterization and local correction

Subdivision surfaces for CAD: integration through parameterization and local correction Workshop: New trends in subdivision and related applications September 4 7, 212 Department of Mathematics and Applications, University of Milano-Bicocca, Italy Subdivision surfaces for CAD: integration

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

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

Computer Graphics Curves and Surfaces. Matthias Teschner

Computer Graphics Curves and Surfaces. Matthias Teschner Computer Graphics Curves and Surfaces Matthias Teschner Outline Introduction Polynomial curves Bézier curves Matrix notation Curve subdivision Differential curve properties Piecewise polynomial curves

More information

Hierarchical Grid Conversion

Hierarchical Grid Conversion Hierarchical Grid Conversion Ali Mahdavi-Amiri, Erika Harrison, Faramarz Samavati Abstract Hierarchical grids appear in various applications in computer graphics such as subdivision and multiresolution

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

Simulating Smoke with an Octree Data Structure and Ray Marching

Simulating Smoke with an Octree Data Structure and Ray Marching Simulating Smoke with an Octree Data Structure and Ray Marching Edward Eisenberger Maria Montenegro Abstract We present a method for simulating and rendering smoke using an Octree data structure and Monte

More information

What is Multigrid? They have been extended to solve a wide variety of other problems, linear and nonlinear.

What is Multigrid? They have been extended to solve a wide variety of other problems, linear and nonlinear. AMSC 600/CMSC 760 Fall 2007 Solution of Sparse Linear Systems Multigrid, Part 1 Dianne P. O Leary c 2006, 2007 What is Multigrid? Originally, multigrid algorithms were proposed as an iterative method to

More information

Honeycomb Subdivision

Honeycomb Subdivision Honeycomb Subdivision Ergun Akleman and Vinod Srinivasan Visualization Sciences Program, Texas A&M University Abstract In this paper, we introduce a new subdivision scheme which we call honeycomb subdivision.

More information

Meshless Modeling, Animating, and Simulating Point-Based Geometry

Meshless Modeling, Animating, and Simulating Point-Based Geometry Meshless Modeling, Animating, and Simulating Point-Based Geometry Xiaohu Guo SUNY @ Stony Brook Email: xguo@cs.sunysb.edu http://www.cs.sunysb.edu/~xguo Graphics Primitives - Points The emergence of points

More information

Curves and Surfaces. Shireen Elhabian and Aly A. Farag University of Louisville

Curves and Surfaces. Shireen Elhabian and Aly A. Farag University of Louisville Curves and Surfaces Shireen Elhabian and Aly A. Farag University of Louisville February 21 A smile is a curve that sets everything straight Phyllis Diller (American comedienne and actress, born 1917) Outline

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

ELEC Dr Reji Mathew Electrical Engineering UNSW

ELEC Dr Reji Mathew Electrical Engineering UNSW ELEC 4622 Dr Reji Mathew Electrical Engineering UNSW Review of Motion Modelling and Estimation Introduction to Motion Modelling & Estimation Forward Motion Backward Motion Block Motion Estimation Motion

More information

Geodesic Paths on Triangular Meshes

Geodesic Paths on Triangular Meshes Geodesic Paths on Triangular Meshes Dimas Martínez Luiz Velho Paulo Cezar Carvalho IMPA Instituto Nacional de Matemática Pura e Aplicada Estrada Dona Castorina, 110, 22460-320 Rio de Janeiro, RJ, Brasil

More information

A NURBS-BASED APPROACH FOR SHAPE AND TOPOLOGY OPTIMIZATION OF FLOW DOMAINS

A NURBS-BASED APPROACH FOR SHAPE AND TOPOLOGY OPTIMIZATION OF FLOW DOMAINS 6th European Conference on Computational Mechanics (ECCM 6) 7th European Conference on Computational Fluid Dynamics (ECFD 7) 11 15 June 2018, Glasgow, UK A NURBS-BASED APPROACH FOR SHAPE AND TOPOLOGY OPTIMIZATION

More information

Advective and conservative semi-lagrangian schemes on uniform and non-uniform grids

Advective and conservative semi-lagrangian schemes on uniform and non-uniform grids Advective and conservative semi-lagrangian schemes on uniform and non-uniform grids M. Mehrenberger Université de Strasbourg and Max-Planck Institut für Plasmaphysik 5 September 2013 M. Mehrenberger (UDS

More information

3D Modeling Parametric Curves & Surfaces

3D Modeling Parametric Curves & Surfaces 3D Modeling Parametric Curves & Surfaces Shandong University Spring 2012 3D Object Representations Raw data Point cloud Range image Polygon soup Solids Voxels BSP tree CSG Sweep Surfaces Mesh Subdivision

More information

SUBDIVISION ALGORITHMS FOR MOTION DESIGN BASED ON HOMOLOGOUS POINTS

SUBDIVISION ALGORITHMS FOR MOTION DESIGN BASED ON HOMOLOGOUS POINTS SUBDIVISION ALGORITHMS FOR MOTION DESIGN BASED ON HOMOLOGOUS POINTS M. Hofer and H. Pottmann Institute of Geometry Vienna University of Technology, Vienna, Austria hofer@geometrie.tuwien.ac.at, pottmann@geometrie.tuwien.ac.at

More information

Geodesics in heat: A new approach to computing distance

Geodesics in heat: A new approach to computing distance Geodesics in heat: A new approach to computing distance based on heat flow Diana Papyan Faculty of Informatics - Technische Universität München Abstract In this report we are going to introduce new method

More information

Contents. I The Basic Framework for Stationary Problems 1

Contents. I The Basic Framework for Stationary Problems 1 page v Preface xiii I The Basic Framework for Stationary Problems 1 1 Some model PDEs 3 1.1 Laplace s equation; elliptic BVPs... 3 1.1.1 Physical experiments modeled by Laplace s equation... 5 1.2 Other

More information

Texture Blending to Point Sampled Geometry Jose Luiz Soares Luz, Paulo Cezar Carvalho, Luiz Velho. Technical Report TR Relatório Técnico

Texture Blending to Point Sampled Geometry Jose Luiz Soares Luz, Paulo Cezar Carvalho, Luiz Velho. Technical Report TR Relatório Técnico Laboratório VISGRAF Instituto de Matemática Pura e Aplicada Texture Blending to Point Sampled Geometry Jose Luiz Soares Luz, Paulo Cezar Carvalho, Luiz Velho Technical Report TR-2004-06 Relatório Técnico

More information

Fluid Simulation Quality with Violated CFL Condition

Fluid Simulation Quality with Violated CFL Condition Fluid Simulation Quality with Violated CFL Condition Philipp Erler Supervised by: Christian Hafner, Michael Wimmer Institute of Computer Graphics and Algorithms TU Wien Vienna / Austria Abstract Fluid

More information

arxiv: v1 [math.na] 20 Sep 2016

arxiv: v1 [math.na] 20 Sep 2016 arxiv:1609.06236v1 [math.na] 20 Sep 2016 A Local Mesh Modification Strategy for Interface Problems with Application to Shape and Topology Optimization P. Gangl 1,2 and U. Langer 3 1 Doctoral Program Comp.

More information

Geometric Modeling in Graphics

Geometric Modeling in Graphics Geometric Modeling in Graphics Part 10: Surface reconstruction Martin Samuelčík www.sccg.sk/~samuelcik samuelcik@sccg.sk Curve, surface reconstruction Finding compact connected orientable 2-manifold surface

More information

Chapter 11 Representation & Description

Chapter 11 Representation & Description Chain Codes Chain codes are used to represent a boundary by a connected sequence of straight-line segments of specified length and direction. The direction of each segment is coded by using a numbering

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

Fluid Simulation. Dhruv Kore, Giancarlo Gonzalez, and Jenny Sum CS 488: Introduction to Computer Graphics Professor Angus Forbes

Fluid Simulation. Dhruv Kore, Giancarlo Gonzalez, and Jenny Sum CS 488: Introduction to Computer Graphics Professor Angus Forbes Fluid Simulation Dhruv Kore, Giancarlo Gonzalez, and Jenny Sum CS 488: Introduction to Computer Graphics Professor Angus Forbes 1) Introduction Figure 1.1: Realistic water and ice simulation using Blender,

More information

12.3 Subdivision Surfaces. What is subdivision based representation? Subdivision Surfaces

12.3 Subdivision Surfaces. What is subdivision based representation? Subdivision Surfaces 2.3 Subdivision Surfaces What is subdivision based representation? Subdivision Surfaces Multi-resolution (Scalability) One piece representation (arbitrary topology) What is so special? Numerical stability

More information

Radiosity. Johns Hopkins Department of Computer Science Course : Rendering Techniques, Professor: Jonathan Cohen

Radiosity. Johns Hopkins Department of Computer Science Course : Rendering Techniques, Professor: Jonathan Cohen Radiosity Radiosity Concept Global computation of diffuse interreflections among scene objects Diffuse lighting changes fairly slowly across a surface Break surfaces up into some number of patches Assume

More information

Joe Warren, Scott Schaefer Rice University

Joe Warren, Scott Schaefer Rice University Joe Warren, Scott Schaefer Rice University Polygons are a ubiquitous modeling primitive in computer graphics. Their popularity is such that special purpose graphics hardware designed to render polygons

More information

Finite Volume Discretization on Irregular Voronoi Grids

Finite Volume Discretization on Irregular Voronoi Grids Finite Volume Discretization on Irregular Voronoi Grids C.Huettig 1, W. Moore 1 1 Hampton University / National Institute of Aerospace Folie 1 The earth and its terrestrial neighbors NASA Colin Rose, Dorling

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