Hierarchical Visualization of Large-scale Unstructured Hexahedral Volume Data

Size: px
Start display at page:

Download "Hierarchical Visualization of Large-scale Unstructured Hexahedral Volume Data"

Transcription

1 Hierarchical Visualization of Large-scale Unstructured Hexahedral Volume Data Jaya Sreevalsan-Nair Lars Linsen Benjamin A. Ahlborn Michael S. Green Bernd Hamann Center for Image Processing and Integrated Computing (CIPIC) Department of Computer Science University of California, Davis, Davis, CA Abstract Multi-block unstructured hexahedral grids are widely used in numerical simulations, but they cause various problems for data visualization due to the hangingnode problem. We present a multi-resolution approach for unstructured hexahedral grid visualization based on cost-minimizing face collapses. We resolve the hangingnode problem in its general form in order to generate visualizations using cutting planes and isosurface extraction. We alleviate the problems due to discontinuities on cell boundaries by using local interpolation schemes and dual contouring approaches in cutting-plane visualization and isosurface extraction, respectively. 1 Introduction Scientific volume data sets are typically defined on structured or unstructured 3D grids. Unstructured grids adapt well to the underlying trivariate function describing some field function (a scalar, vector, or tensor field - or even multiple fields). This adaptivity makes unstructured grids appropriate for visual representation of many scientific phenomena. Though unstructured tetrahedral meshes, for instance, have been examined for a long time, hardly any work has been done on multi-resolution approaches in unstructured hexahedral meshes, despite the fact that hexahedral grids are commonly used in simulations such as finite element analysis and computational fluid dynamics. Unfortunately, standard data exploration and visualization tools can, in general, not be applied directly to multi-block unstructured hexahedral grids and we need to generate a multi-resolution hierarchy in these meshes. We propose generation of the hierarchy of unstructured, rectilinear, hexahedral grids using minimal local variation for collapsing two neighboring cells. This approach allows us to construct a continuous level-ofdetail representation [10]. However, visualization of the resulting data hierarchy {sreevals, ahlborn, greenm, hamann}@cs.ucdavis.edu, llinsen@ucdavis.edu. is difficult due to continuity desiderata in the levelsof-detail. Hence, we have developed a cutting-plane and an isosurface extraction tool for a general setting, where arbitrary-sized hexahedral building blocks, possibly with hanging nodes on cell boundaries, are used to discretize a 3D domain. In addition, our method preserves the adaptive characteristics of the unstructured grids. Isosurface extraction using conventional cube-based algorithms, like the Marching Cubes algorithm, would lead to cracks in the resulting isosurface. Fixing such cracks in a general hexahedral setting is a tedious process and may not be free of artifacts. Thus, we chose to use a dual approach (cf. [5] [8]). For cutting-plane visualization, trilinear interpolation leads to discontinuities when hanging nodes exist. Our approach uses scattered data interpolation techniques for generating slices and includes neighboring hanging nodes for interpolation. We compare several techniques, namely Shepard s local method, and Sibson s method, for the estimation of function values locally. 2 Related Work Although several multi-resolution approaches exist for unstructured tetrahedral meshes, efforts for hexahedral meshes are restricted to (adaptive) multi-resolution approaches for structured grids [11, 14, 20, 23, 28]. This unequal treatment of tetrahedral and hexahedral grids is due to the fact that unstructured hexahedral grids generate hanging nodes during the construction of a multi-resolution hierarchy, and hanging nodes are generally intractable during visualization. However, this fact does not deter the use of unstructured hexahedral grids in numerical simulations such as in finite element applications that exploit the adaptive nature of these grids (as in the case of adaptive hp grids). At the same time, hexahedral-to-tetrahedral mesh transformations for resolving the hanging-node problem are not free from artifacts, as, there is a conflict between the linear interpolation for tetrahedra and trilinear interpolation for hexahedra. Since these transformations lead

2 to a different piecewise polynomial representation of a data field, they are futile. Hence, instead of eliminating the hanging nodes in the hierarchy, we focus on designing visualization techniques on unstructured hexahedral grids with hanging nodes. Usually, construction of mesh hierarchies is done using either bottom-up or top-down strategies. Our problem requires a bottom-up approach producing coarser mesh resolutions by mesh simplification [1]. Previous work on bottom-up schemes are as follows: Renze and Oliver used vertex removal for 3D mesh decimation [22]. Re-triangulation is done using Delaunay triangulation of the vertices adjacent to a removed vertex. Irregular tetrahedral mesh simplification was done by Trotts et al. [27] using ordering of approximation errors that would result from a tetrahedral cell collapse (implemented via three edge collapses). Staadt et al. [26] extend Hoppe s progressive mesh algorithm [7] of collapses applied to tetrahedra. Hoppe uses an energy function whose minimization drives edge collapses. Meredith et al. [16] use view-dependent error-based resolution selection for generating a hierarchy in order to maintain accuracy at all levels. Energy-based methods, using Dirichlet energy specifically, are common for surface reconstruction purposes [3]. Pinkall and Polthier [21] use minimum Dirichlet energy to be the exact equivalent of the distortion measure to determine an optimal triangulation. Desbrun et al. [3] extended this work to obtain intrinsic parametrization by minimization of different distortion measures of the mesh. Levy et al. [9] mentioned that Dirichlet energy minimizers are harmonic functions and that hierarchical solvers perform well when minimizing a criterion for which the minimum is a harmonic map. These works inspired us to extend the use of Dirichlet energy minimizers in defining a criterion for face removal in an unstructured hexahedral 3D mesh. Our work focuses on cutting-plane visualization and isosurface generation on multi-resolution hierarchy in unstructured hexahedral grids. Cutting planes constrain the visualization of 3D data set to an arbitrarily oriented 2D slice. Hence, it is a useful tool to study changes in the interior of a volume. For a uniformly resolved mesh, cutting-plane values can be computed using trilinear interpolation. However, in an adaptive multi-resolution representation, discontinuities along cell boundaries are inevitable. Hence, we have adopted scattered data interpolation for constructing slice values instead. Isosurfacing is an indispensable tool used in scientific visualization. However, hanging nodes pose a problem for adaptively refined grids, as the conventional MC algorithm determines the isopoints using linear interpolation on cell edges, which unfortunately yields bad results in these grids due to the inherent edge discontinuities in their cells. To overcome this problem, we explore the local continuity of the scalar (or vector) field distribution in the cell interior, and use dual-contouring techniques. In contrast to dual-contouring methods [5, 8], our algorithm generates vertices on the actual isosurface without using the normal information at vertex locations. Instead, we adopt a ray-casting technique to find the points lying in the cell interior. Though the use of ray-casting techniques is not new in isosurfacing problems, there are differences in the purpose and mechanisms adopted in our work. Earlier ray-casting techniques for isosurfacing were used for refining the isosurface generated using the conventional MC Algorithm [2]. Frühauf [4] pioneered in adopting a ray-casting approach (which usually uses a trilinear interpolation filter) to produce output meshes that are better than those generated by the MC technique. A number of different interpolation filters have been proposed [6, 15, 17, 18] for more precise computation of field values and gradients. However, its drawbacks are its high time complexity and view-dependence. We blend ray-casting and dual isocontouring in a viewindependent fashion to construct a crack-free isosurface. View-independence is achieved by casting rays along the space (or body) diagonals in each cell. In addition, the advantage of our technique is the fact that it supports the adoption of any reconstruction filter used for interpolation of field values. 3 Multi-resolution Hierarchy We introduce a novel face-removal technique for constructing multi-resolution hierarchy in unstructured hexahedral grids. The underlying fields typically result from numerical simulations, and are approximated using trilinear interpolation in the cell interior. The function is a trivariate harmonic function, as it has continuous second order partial derivatives that satisfies the Laplace equation. For such a real-valued harmonic function in a closed domain, one can define the Dirichlet energy to be the closed integral of the square of the L 2 norm of the function s gradient over the domain. Dirichlet energies of different cells provide an estimate of the relativeness of the gradients of the function. Gradients reflect the behavior of the function in the cells: high gradients indicate significant changes in the scalar field, and low gradients indicate smooth variation over the cell. Our goal while generating coarser resolutions of a multi-resolution hierarchy is to preserve as much information about the function as possible. In order to retain regions of significant changes in the function, we sort the Dirichlet energy contained in each cell to define an order for face removal. The discrete Dirichlet energy in each cell, computed as the sum of squares of the L 2 norm of function gradient in each cell edge, is represented as: E = ( f i 2 ) 2, (1) all edges e i where f i is the function value along edge e i of a cell. The cells in the grid are sorted in ascending order of

3 Dirichlet energy functional values. A user-defined minimum number of cells with low Dirichlet energy value is considered. From the reduced set of cells, combinations of two cells are selected, which must satisfy the following criteria for collapsing: 1. The cells share a common face. 2. The Dirichlet energy of the resulting collapsed cell should be minimal. If the first pass fails, the next group of cells in the initial sorted list is considered. This two-pass sorting process terminates when two appropriate cells, which can be collapsed to one, are found. Intuitively, the combinations occurring in consecutive iterations are in the regions of the grid where the field varies smoothly. We chose this two-pass approach over the straightforward one-pass approach in order to reduce computational overhead. Once the appropriate set of cells is found, the collapse operation is implemented by removing the common face and appropriately rearranging the connectivity information of the vertices in the resulting cell. Removal of the common face results in a new hexahedral cell, thus favorably preserving shape properties even after the cell collapse. 4 Cutting planes Cutting planes is a restriction of the 3D volume data on an arbitrary 2D plane. This helps us to study the variation of the field in the interior of the volume. Trilinear interpolation of the points in the cutting plane is a very simple technique for rectilinear grids. However. it fails on a coarse grid with hanging nodes, as it generates artifacts due to the inherent edge discontinuities in the cells. This fact makes trilinear interpolation a poor choice for cutting-plane visualization in certain cases. Thus, we turn to scattered data interpolation techniques like the Sibson s interpolation and Shepard s local method, where the interpolation using closest neighboring points may include hanging nodes from neighboring cells. Sibson s interpolation method [25] uses information from voxels in the neighborhood of a point in the cutting plane. This method effectively addresses the problem of cracks in cutting-plane value computation in a coarse grid. However, it has a drawback due to high computational overhead, which compels us to revisit other scattered data interpolation techniques. Shepard s localized scattered data interpolation method [24], like Sibson interpolation, uses information of the points in the immediate neighborhood of the cutting plane point to be evaluated. Since this technique solely uses distances of the local neighborhood voxels, there is increased user interactivity. Though we trade accuracy for time complexity in this case, the results obtained using Shepard s method are good. 5 Isosurfacing The idea of dual isocontouring was inspired mainly by the work of Ju et al. [8] and Greß et al. [5]. In contrast to the MC algorithm [12, 13, 16, 19], dual contouring computes the isopoints in the cell interior, rather than on the edges. The dual approach is desirable in the case of hanging nodes. However, our algorithm still uses the case look-up table of the MC algorithm in order to distinguish between the cases. We shoot rays along the space diagonals of the hexahedral cell and find the intersection points with the trilinearly interpolated implicit surfaces in the cell interior using Cardan s solution for cubic equations. The algorithm is divided into three parts, namely, case identification, isopoint computation and triangulation. 5.1 Case Identification The preprocessing of our isosurfacing algorithm involves the use of a look-up table of the conventional MC algorithm in order to identify the specific case to which a cell corresponds. Using the information in the look-up table, we can determine: 1. The rays that are to be shot along the body diagonals (Since we use the minimum number of rays necessary for determining isopoints, the look-up table defines which rays intersect the isosurface). 2. The number of disjoint isosurface components in each cell (as the look-up table defines how many isosurface components exist in a cell and how they are connected to the components detected in the neighboring cells). 5.2 Isopoint Computation This step involves finding the intersection of a ray and the implicitly defined isosurface for a given isovalue. A ray is represented as: r = r 1 + p(r 2 r 1 ), (2) where r 1 and r 2 are the position vectors of two points on the ray (which, in this case, are the endpoints of the diagonal along which the ray is shot) and p [0, 1] is the parameter. The isosurface is given as: I = (1 s)(1 t)(1 u)f (1 s)(1 t)uf (1 s)t(1 u)f (1 s)tuf s(1 t)(1 u)f s(1 t)uf st(1 u)f stuf 111, (3) where s, t, and u are local parameters along x, y, and z directions, respectively, f ijk is a field value at the corresponding vertex of the cell, and I is the isovalue. The

4 parametric representation of the intersection point in (s, t, u) space is expressed via p, which reduces Equation 3 to a cubic equation for p. The zeros of the cubic equation are found using Cardan s solution. Real roots in the range [0,1] define the required intersection points. There may be more than one real root in a cell, which indicates the existence of disconnected multiple surface components in a cell. We choose as many real roots as there are isosurface components existing in the cell. In cases where we may get real roots (solution from different rays) corresponding to the same isosurface component, we take any one of them and discard the others. This ensures that there will be at least one point per cell containing at least one edge with opposite signs at its ends, and there will be one intersection point for each isosurface component existing in the cell. 5.3 Triangulation The triangulation of all interior points is determined by the following rules: 1. Edges are constructed from an interior point to points in at most three distinct neighboring cells [8]. 2. In case of boundary cells, the MC algorithm is used to find points on the mesh boundaries for terminating the isosurface. 3. Points in a cell are not connected to each other. This is necessary to maintain the number of disconnected isosurface components within each cell. 6 Results For developing our isosurfacing algorithm, we have used simple test cases. For finding the minimum number of rays to be cast, a test case of one cube is used and for constructing the isosurface triangulation, a test case of eight neighboring cubes is used. Some of the isosurfaces that are obtained are as shown in Figures 1 and 2. Figure 1: Cells (a) and (b) corresponding to cases 6 and 7, respectively, of the original MC look-up table. The number of rays (yellow lines) cast is minimal. The white triangles are the MC isosurfaces, and the cyan points are the dual isopoints. Figure 2: (a) compares the MC isosurface (white) and the dual isosurface (magenta). (b) shows the octahedron (white) of the MC method and its dual, a cube (edges shown in green) generated using our dual method. We have applied our methods to a multi-block data set of flow simulations of an oil-water field at different time steps, with data representing oil pressure, oil concentration, water saturation and oil velocity. The data set consists of 876, 148, 576, 152 and 872 cells in five different blocks, as shown in Figure 3. Each block is considered as a separate grid for most of our computational procedures, except while constructing multiresolution hierarchy, we sort the Dirichlet energies in the five blocks together in order to find the optimum cells for collapse. Our multi-resolution hierarchy is constructed using the oil pressure field, whose color representation is as shown in Figure 3. For developing the multi-resolution hierarchy, shown in Figure 4, we observe that after 1000 cell collapses only small changes in the color representing oil pressure are seen. However, after 1500 cell collapses, discontinuities in the color mapping become visible. Most of the initial cell collapses occur in the third grid, where the function varies smoothly. The artifacts in the color mapping in the latter case are due to the Gouraud shading. Trilinear, Sibson s and Shepard s local interpolation schemes were applied to the dataset to obtain a slice orthogonal to xz plane, as shown in Figure 5. Sibson s interpolation is more time-consuming than Shepard s. The quality of the results is more accurate in the Sibson s method than in the other two, where discontinuities can be seen (Figure 5). It can be observed that Shepard s method is the best tradeoff between time complexity and accuracy, though one should resort to Sibson s method when accuracy is weighed more. Our isosurfacing algorithm was applied to the oil pressure field. We observed that prior to cell collapse, our algorithm and the MC algorithm yield similar results (Figure 6). Except in our method, there exists a discontinuity on the boundary between different blocks. 7 Conclusions and Future Work Overall, our method leads to desirable results. However, certain issues need to be addressed further. They are : 1. One cell collapse per iteration is not economical.

5 The algorithm should be improved in order to perform more than one collapse per iteration. 2. Optimization of the isosurfacing algorithm is needed to make the approach applicable on largescale data sets too. 3. Isosurfacing needs to be extended to deal with cases including more complex isosurface cases, like tunnels [12]. 4. A complete look-up table for isosurfacing must be defined. Specific boundary cases must be considered. This aspect is essential for using the algorithm in cases of hanging nodes. Acknowledgments This work was supported by the National Science Foundation under contracts ACI (CAREER Award) and ACI , through the Large Scientific and Software Data Set Visualization (LSSDSV) program under contract ACI , and through the National Partnership for Advanced Computational Infrastructure (NPACI); the National Institute of Mental Health and the National Science Foundation under contract NIMH 2 P20 MH A2; and the Lawrence Livermore National Laboratory under ASCI ASAP Level-2 Memorandum Agreement B and under Memorandum Agreement B We thank the members of the Visualization and Graphics Research Group at the Center for Image Processing and Integrated Computing (CIPIC) at the University of California, Davis. References [1] P. Cignoni, D. Costanza, C. Montani, C. Rocchini, and R. Scopigno, Simplification of tetrahedral meshes with accurate error evaluation, in Proceedings of Visualization 2000, Los Alamitos, CA, 2000, IEEE Computer Society Press, pp [2] P. Cignoni, F. Ganovelli, C. Montani, and R. Scopigno, Reconstruction of topologically correct and adaptive trilinear isosurfaces, Computer & Graphics, 24(3) (2000), pp [3] M. Desbrun, M. Meyer, and P. Alliez, Intrinsic parameterization of surface meshes, in Proceedings of Eurographics 2002, 2002, pp [4] T. Frühauf, Raycasting opaque isosurfaces in nonregularly gridded cfd data, in Visualization in Scientific Computing (1995 Eurographics WS Proc.), Springer KG, Wien, Chia, 3-5 May 1995, pp [5] A. GREß AND R. KLEIN, Efficient representation and extraction of 2-manifold isosurfaces using kdtrees, in Proceedings of Pacific Graphics 2003, IEEE CS Press, October [6] B. Hamann, E. LaMar, and K. I. Joy, Highquality rendering of smooth isosurfaces, The Journal of Visualization and Computer Animation, 10 (1999), pp [7] H. Hoppe, Progressive meshes, in Proceedings of Siggraph 1996, ACM Press, New York, NY, 1996, pp [8] T. Ju, F. Losasso, S. Schaefer, and J. Warren, Dual contouring of hermite data, in Proceedings of Siggraph 2002, ACM Press, New York, NY, 2002, pp [9] B. Levy, S. Petitjean, N. Ray, and J. Mailot, Least squares conformal maps for automatic texture atlas generation, in Proceedings of SIGGRAPH 2002, ACM Press, New York, NY, 2002, pp [10] P. Lindstrom, D. Koller, W. Ribarsky, L. F. Hodges, N. Faust, and G. A.Turner, Real-time, continuous level of detail rendering of height fields, in Proceedings of the SIGGRAPH 1996, ACM Press, 1996, pp [11] L. Lippert, M. H. Gross, and C. Kurmann, Compression domain volume rendering for distributed environments, in Proceedings of the Eurographics 97, vol. 14, COMPUTER GRAPHICS Forum, 1997, pp [12] A. Lopes and K. Brodlie, Improving the robustness and accuracy of the marching cubes algorithm for isosurfacing, IEEE Transactions on Visualization and Computer Graphics, 9(1) (2003), pp [13] W. E. Lorensen and H.E.Cline, Marching cubes: A high-resolution 3d surface construction algorithm, in Proceedings of SIGGRAPH 1987, vol. 21(4), Computer Graphics, 1987, pp [14] D. Maegher, Geometric modeling using octree encoding, Computer Graphics and Image Processing, 19 (1982), pp [15] S. R. Marschner and R. J. Lobb, An evaluation of reconstruction filters for volume rendering, in Proceedings of IEEE Visualization 1994, Tyson Corner, VA, 1994, R. D. Bergeron and A. E. Kaufman, pp [16] J. Meredith and K.-L. Ma, Multiresolution view-dependent splat-based volume rendering of large irregular data, in Proceedings of IEEE Symposium on Parallel and Large Data Visualization and Graphics, 2001, pp

6 [17] T. Mo ller, R. Machiraju, K. Mu eller, and R. Yagel, Classification and local error estimation of interpolation and derivative filters for volume rendering, in Proceedings of IEEE Symposium on Volume Visualization 1996, 1996, pp [18] T. Mo ller, R. Machiraju, K. Mu eller, and R. Yagel, A comparison of normal estimation schemes, in IEEE Visualization, 1997, pp [19] G. M. Nielson, On marching cubes, IEEE Transactions on Visualization and Computer Graphics, 9(3) (2003), pp Figure 3: (a) Oil field mesh with different colors indicating different blocks. (b) Color representation of the oil pressure field. [20] M. Ohlberger and M. Rumpf, Hierarchical and adaptive visualization on nested grids, Computing, 59 (1997), pp [21] U. Pinkall and K. Polthier, Computing discrete minimal surfaces, Experimental Mathematics, 2(1) (1993), pp [22] K. J. Renze and J.H.Oliver, Generalized unstructured decimation, IEEE Computer Graphics & Applications, 16(6) (1996), pp [23] R. Shekhar, E. Fayyad, R. Yagel, and J. F. Cornhill, Octree-based decimation of marching cubes surfaces, in Proceedings of IEEE Conference on Visualization 1997, R. Yagel and G. M. Nielson, eds., IEEE, IEEE Computer Society Press, 1996, pp Figure 4: Mesh and Oil pressure field (a) after 1000 collapses (b) after 1500 collapses [24] D. Shepard., A two-dimensional interpolation function for irregularly spaced data, in Proceedings of the 23rd National Conference, ACM, August 1968, pp [25] R. Sibson, A brief description of natural neighbor interpolation, in Interpreting Multivariate Data, V.Barnett, ed., John Wiley & Sons, New York, 1981, pp [26] O. G. Staadt and M.H.Gross, Progressive tetrahedralization, in Proceedings of IEEE Visualization 1998, IEEE Computer Society, Washington DC, 1998, pp Figure 5: Comparison of (a) trilinear, (b) Sibson s, and (c) Shepard s local interpolation schemes for cuttingplane visualization on a grid obtained after 500 collapses. [27] I. J. Trotts, B. Hamann, K. I. Joy, and D. F. Wiley, Simplification of tetrahedral meshes, in Proceedings of IEEE Visualization 1998, IEEE Computer Society, Washington DC, 1998, pp [28] R. Westermann, L. Kobbelt, and T. Ertl, Real-time exploration of regular volume data by adaptive reconstruction of isosurfaces, The Visual Computer, (1999), pp Figure 6: (a) Isosurface obtained using the MC algorithm (b) Isosurface obtained using our algorithm. The discontinuity in the surface is due to boundaries between blocks, not due to cell collapse.

Dual Marching Cubes: Primal Contouring of Dual Grids

Dual Marching Cubes: Primal Contouring of Dual Grids Dual Marching Cubes: Primal Contouring of Dual Grids Scott Schaefer and Joe Warren Rice University 6100 Main St. Houston, TX 77005 sschaefe@rice.edu and jwarren@rice.edu Abstract We present a method for

More information

Multiresolution Tetrahedral Meshes: an Analysis and a Comparison

Multiresolution Tetrahedral Meshes: an Analysis and a Comparison Multiresolution Tetrahedral Meshes: an Analysis and a Comparison Emanuele Danovaro, Leila De Floriani Dipartimento di Informatica e Scienze dell Informazione, Università di Genova, Via Dodecaneso 35, 16146

More information

Constrained Tetrahedral Mesh Generation of Human Organs on Segmented Volume *

Constrained Tetrahedral Mesh Generation of Human Organs on Segmented Volume * Constrained Tetrahedral Mesh Generation of Human Organs on Segmented Volume * Xiaosong Yang 1, Pheng Ann Heng 2, Zesheng Tang 3 1 Department of Computer Science and Technology, Tsinghua University, Beijing

More information

Lecture 7 - Meshing. Applied Computational Fluid Dynamics

Lecture 7 - Meshing. Applied Computational Fluid Dynamics Lecture 7 - Meshing Applied Computational Fluid Dynamics Instructor: André Bakker http://www.bakker.org André Bakker (2002-2006) Fluent Inc. (2002) 1 Outline Why is a grid needed? Element types. Grid types.

More information

Model Repair. Leif Kobbelt RWTH Aachen University )NPUT $ATA 2EMOVAL OF TOPOLOGICAL AND GEOMETRICAL ERRORS !NALYSIS OF SURFACE QUALITY

Model Repair. Leif Kobbelt RWTH Aachen University )NPUT $ATA 2EMOVAL OF TOPOLOGICAL AND GEOMETRICAL ERRORS !NALYSIS OF SURFACE QUALITY )NPUT $ATA 2ANGE 3CAN #!$ 4OMOGRAPHY 2EMOVAL OF TOPOLOGICAL AND GEOMETRICAL ERRORS!NALYSIS OF SURFACE QUALITY 3URFACE SMOOTHING FOR NOISE REMOVAL 0ARAMETERIZATION 3IMPLIFICATION FOR COMPLEXITY REDUCTION

More information

Volume visualization I Elvins

Volume visualization I Elvins Volume visualization I Elvins 1 surface fitting algorithms marching cubes dividing cubes direct volume rendering algorithms ray casting, integration methods voxel projection, projected tetrahedra, splatting

More information

Efficient Storage, Compression and Transmission

Efficient Storage, Compression and Transmission Efficient Storage, Compression and Transmission of Complex 3D Models context & problem definition general framework & classification our new algorithm applications for digital documents Mesh Decimation

More information

How To Write A Level Of Detail Model For A D-Dimensional Simplicial Mesh

How To Write A Level Of Detail Model For A D-Dimensional Simplicial Mesh Encoding Level-Of-Detail Tetrahedral Meshes Neta Sokolovsky 1, Emanuele Danovaro 2, Leila De Floriani 2, and Paola Magillo 2 1 Department of Computer Science, Ben Gurion University of the Negev, Beer Sheva,

More information

Volumetric Meshes for Real Time Medical Simulations

Volumetric Meshes for Real Time Medical Simulations Volumetric Meshes for Real Time Medical Simulations Matthias Mueller and Matthias Teschner Computer Graphics Laboratory ETH Zurich, Switzerland muellerm@inf.ethz.ch, http://graphics.ethz.ch/ Abstract.

More information

Dual Contouring of Hermite Data

Dual Contouring of Hermite Data Dual Contouring of Hermite Data Tao Ju, Frank Losasso, Scott Schaefer, Joe Warren Rice University Figure 1: A temple undergoing destructive modifications. Both models were generated by dual contouring

More information

Feature Sensitive Surface Extraction from Volume Data

Feature Sensitive Surface Extraction from Volume Data Feature Sensitive Surface Extraction from Volume Data Leif P. Kobbelt Mario Botsch Ulrich Schwanecke Hans-Peter Seidel Computer Graphics Group, RWTH-Aachen Computer Graphics Group, MPI Saarbrücken Figure

More information

How To Create A Surface From Points On A Computer With A Marching Cube

How To Create A Surface From Points On A Computer With A Marching Cube Surface Reconstruction from a Point Cloud with Normals Landon Boyd and Massih Khorvash Department of Computer Science University of British Columbia,2366 Main Mall Vancouver, BC, V6T1Z4, Canada {blandon,khorvash}@cs.ubc.ca

More information

Mean Value Coordinates

Mean Value Coordinates Mean Value Coordinates Michael S. Floater Abstract: We derive a generalization of barycentric coordinates which allows a vertex in a planar triangulation to be expressed as a convex combination of its

More information

SECONDARY STORAGE TERRAIN VISUALIZATION IN A CLIENT-SERVER ENVIRONMENT: A SURVEY

SECONDARY STORAGE TERRAIN VISUALIZATION IN A CLIENT-SERVER ENVIRONMENT: A SURVEY SECONDARY STORAGE TERRAIN VISUALIZATION IN A CLIENT-SERVER ENVIRONMENT: A SURVEY Kai Xu and Xiaofang Zhou School of Information Technology and Electrical Engineering The University of Queensland, Brisbane,

More information

Multiresolution Terrain Database Visualization

Multiresolution Terrain Database Visualization Multiresolution Terrain Database Visualization Kai Xu School of Information Technology and Electrical Engineering The University of Queensland, Brisbane, QLD 4072, Australia kaixu@itee.uq.edu.au Abstract.

More information

From Scattered Samples to Smooth Surfaces

From Scattered Samples to Smooth Surfaces From Scattered Samples to Smooth Surfaces Kai Hormann 1 California Institute of Technology (a) (b) (c) (d) Figure 1: A point cloud with 4,100 scattered samples (a), its triangulation with 7,938 triangles

More information

A Generalized Marching Cubes Algorithm Based On Non-Binary Classifications

A Generalized Marching Cubes Algorithm Based On Non-Binary Classifications Konrad-Zuse-Zentrum fu r Informationstechnik Berlin Takustraße 7 D-14195 Berlin-Dahlem Germany HANS-CHRISTIAN HEGE DETLEV STALLING MARTIN SEEBASS MALTE ZOCKLER A Generalized Marching Cubes Algorithm Based

More information

Employing Complex GPU Data Structures for the Interactive Visualization of Adaptive Mesh Refinement Data

Employing Complex GPU Data Structures for the Interactive Visualization of Adaptive Mesh Refinement Data Volume Graphics (2006) T. Möller, R. Machiraju, T. Ertl, M. Chen (Editors) Employing Complex GPU Data Structures for the Interactive Visualization of Adaptive Mesh Refinement Data Joachim E. Vollrath Tobias

More information

Wavelet Representation of functions defined on Tetrahedrical Grids

Wavelet Representation of functions defined on Tetrahedrical Grids Wavelet Representation of functions defined on Tetrahedrical Grids Silvia Castro (1), Liliana Castro (2), Liliana Boscardín (2), and Armando De Giusti (3) (1) Dpto. de Cs. e Ing. de la Computación (2)

More information

A New Approach to Cutting Tetrahedral Meshes

A New Approach to Cutting Tetrahedral Meshes A New Approach to Cutting Tetrahedral Meshes Menion Croll August 9, 2007 1 Introduction Volumetric models provide a realistic representation of three dimensional objects above and beyond what traditional

More information

A FRAMEWORK FOR REAL-TIME TERRAIN VISUALIZATION WITH ADAPTIVE SEMI- REGULAR MESHES

A FRAMEWORK FOR REAL-TIME TERRAIN VISUALIZATION WITH ADAPTIVE SEMI- REGULAR MESHES A FRAMEWORK FOR REAL-TIME TERRAIN VISUALIZATION WITH ADAPTIVE SEMI- REGULAR MESHES Lourena Rocha, Sérgio Pinheiro, Marcelo B. Vieira, Luiz Velho IMPA - Instituto Nacional de Matemática Pura e Aplicada

More information

Visualization Tools for Adaptive Mesh Refinement Data

Visualization Tools for Adaptive Mesh Refinement Data Visualization Tools for Adaptive Mesh Refinement Data Gunther H. Weber 1 and Vincent E. Beckner 1 and Hank Childs 2 and Terry J. Ligocki 1 and Mark C. Miller 2 and Brian Van Straalen 1 and E. Wes Bethel

More information

Spatio-Temporal Mapping -A Technique for Overview Visualization of Time-Series Datasets-

Spatio-Temporal Mapping -A Technique for Overview Visualization of Time-Series Datasets- Progress in NUCLEAR SCIENCE and TECHNOLOGY, Vol. 2, pp.603-608 (2011) ARTICLE Spatio-Temporal Mapping -A Technique for Overview Visualization of Time-Series Datasets- Hiroko Nakamura MIYAMURA 1,*, Sachiko

More information

Multi-Block Gridding Technique for FLOW-3D Flow Science, Inc. July 2004

Multi-Block Gridding Technique for FLOW-3D Flow Science, Inc. July 2004 FSI-02-TN59-R2 Multi-Block Gridding Technique for FLOW-3D Flow Science, Inc. July 2004 1. Introduction A major new extension of the capabilities of FLOW-3D -- the multi-block grid model -- has been incorporated

More information

Massive Data Visualization: A Survey

Massive Data Visualization: A Survey Massive Data Visualization: A Survey Kenneth I. Joy 1 Institute for Data Analysis and Visualization University of California, Davis kijoy@ucdavis.edu Summary. Today s scientific and engineering problems

More information

Automating Transfer Function Design Based on Topology Analysis

Automating Transfer Function Design Based on Topology Analysis Automating Transfer Function Design Based on Topology Analysis Gunther H. Weber 1,2 and Gerik Scheuermann 1 1 AG Graphische Datenverarbeitung und Computergeometrie, FB Informatik, University of Kaiserslautern,

More information

Technical Report. An Interactive Iso-Surface Based 3D Weather Radar Data Visualization Package Using VisAD for WDSSII

Technical Report. An Interactive Iso-Surface Based 3D Weather Radar Data Visualization Package Using VisAD for WDSSII Technical Report An Interactive Iso-Surface Based 3D Weather Radar Data Visualization Package Using VisAD for WDSSII (Jianting Zhang, Last Modified 2/5/2004) Abstract... 2 1 Introduction... 3 2 Overviews

More information

FIRST: A Flexible and Interactive Resampling Tool for CFD Simulation Data

FIRST: A Flexible and Interactive Resampling Tool for CFD Simulation Data FIRST: A Flexible and Interactive Resampling Tool for CFD Simulation Data Robert S. Laramee VRVis Research Center, Austria Laramee@VRVis.at www.vrvis.at July 7, 2003 Abstract We introduce a flexible, variable

More information

1 INTRODUCTION. Abstract

1 INTRODUCTION. Abstract TetFusion: An Algorithm For Rapid Tetrahedral Mesh Simplification Prashant Chopra and Joerg Meyer* Mississippi State University Engineering Research Center Figure 1: Four macrolods (defined in section

More information

Anatomic Modeling from Unstructured Samples Using Variational Implicit Surfaces

Anatomic Modeling from Unstructured Samples Using Variational Implicit Surfaces Studies in Health Technology and Informatics, vol. 81 (Proceedings of Medicine Meets Virtual Reality 2001. J. D. Westwood, et al., eds.), Amsterdam: IOS Press, pp. 594-600. Anatomic Modeling from Unstructured

More information

Overset Grids Technology in STAR-CCM+: Methodology and Applications

Overset Grids Technology in STAR-CCM+: Methodology and Applications Overset Grids Technology in STAR-CCM+: Methodology and Applications Eberhard Schreck, Milovan Perić and Deryl Snyder eberhard.schreck@cd-adapco.com milovan.peric@cd-adapco.com deryl.snyder@cd-adapco.com

More information

3D Distance from a Point to a Triangle

3D Distance from a Point to a Triangle 3D Distance from a Point to a Triangle Mark W. Jones Technical Report CSR-5-95 Department of Computer Science, University of Wales Swansea February 1995 Abstract In this technical report, two different

More information

A unified representation for interactive 3D modeling

A unified representation for interactive 3D modeling A unified representation for interactive 3D modeling Dragan Tubić, Patrick Hébert, Jean-Daniel Deschênes and Denis Laurendeau Computer Vision and Systems Laboratory, University Laval, Québec, Canada [tdragan,hebert,laurendeau]@gel.ulaval.ca

More information

Faculty of Computer Science Computer Graphics Group. Final Diploma Examination

Faculty of Computer Science Computer Graphics Group. Final Diploma Examination Faculty of Computer Science Computer Graphics Group Final Diploma Examination Communication Mechanisms for Parallel, Adaptive Level-of-Detail in VR Simulations Author: Tino Schwarze Advisors: Prof. Dr.

More information

COMPARING TECHNIQUES FOR TETRAHEDRAL MESH GENERATION

COMPARING TECHNIQUES FOR TETRAHEDRAL MESH GENERATION COMPARING TECHNIQUES FOR TETRAHEDRAL MESH GENERATION M. A. S. Lizier Instituto de Ciências Matemáticas e de Computação - Universidade de São Paulo, Brazil lizier@icmc.usp.br J. F. Shepherd Sandia National

More information

Segmentation of building models from dense 3D point-clouds

Segmentation of building models from dense 3D point-clouds Segmentation of building models from dense 3D point-clouds Joachim Bauer, Konrad Karner, Konrad Schindler, Andreas Klaus, Christopher Zach VRVis Research Center for Virtual Reality and Visualization, Institute

More information

Introduction to ANSYS

Introduction to ANSYS Lecture 3 Introduction to ANSYS Meshing 14. 5 Release Introduction to ANSYS Meshing 2012 ANSYS, Inc. March 27, 2014 1 Release 14.5 Introduction to ANSYS Meshing What you will learn from this presentation

More information

Multiphysics Software Applications in Reverse Engineering

Multiphysics Software Applications in Reverse Engineering Multiphysics Software Applications in Reverse Engineering *W. Wang 1, K. Genc 2 1 University of Massachusetts Lowell, Lowell, MA, USA 2 Simpleware, Exeter, United Kingdom *Corresponding author: University

More information

CITRIS Founding Corporate Members Meeting

CITRIS Founding Corporate Members Meeting Massive Data Exploration Virtual Reality and Visualization Oliver Staadt, Bernd Hamann CIPIC and CS Department, UC Davis CITRIS Founding Corporate Members Meeting Thursday, February 27, 2003 University

More information

Off-line Model Simplification for Interactive Rigid Body Dynamics Simulations Satyandra K. Gupta University of Maryland, College Park

Off-line Model Simplification for Interactive Rigid Body Dynamics Simulations Satyandra K. Gupta University of Maryland, College Park NSF GRANT # 0727380 NSF PROGRAM NAME: Engineering Design Off-line Model Simplification for Interactive Rigid Body Dynamics Simulations Satyandra K. Gupta University of Maryland, College Park Atul Thakur

More information

Interactive simulation of an ash cloud of the volcano Grímsvötn

Interactive simulation of an ash cloud of the volcano Grímsvötn Interactive simulation of an ash cloud of the volcano Grímsvötn 1 MATHEMATICAL BACKGROUND Simulating flows in the atmosphere, being part of CFD, is on of the research areas considered in the working group

More information

An Overview of the Finite Element Analysis

An Overview of the Finite Element Analysis CHAPTER 1 An Overview of the Finite Element Analysis 1.1 Introduction Finite element analysis (FEA) involves solution of engineering problems using computers. Engineering structures that have complex geometry

More information

HistoPyramid stream compaction and expansion

HistoPyramid stream compaction and expansion HistoPyramid stream compaction and expansion Christopher Dyken1 * and Gernot Ziegler2 Advanced Computer Graphics / Vision Seminar TU Graz 23/10-2007 1 2 University of Oslo Max-Planck-Institut fu r Informatik,

More information

TWO-DIMENSIONAL FINITE ELEMENT ANALYSIS OF FORCED CONVECTION FLOW AND HEAT TRANSFER IN A LAMINAR CHANNEL FLOW

TWO-DIMENSIONAL FINITE ELEMENT ANALYSIS OF FORCED CONVECTION FLOW AND HEAT TRANSFER IN A LAMINAR CHANNEL FLOW TWO-DIMENSIONAL FINITE ELEMENT ANALYSIS OF FORCED CONVECTION FLOW AND HEAT TRANSFER IN A LAMINAR CHANNEL FLOW Rajesh Khatri 1, 1 M.Tech Scholar, Department of Mechanical Engineering, S.A.T.I., vidisha

More information

ME6130 An introduction to CFD 1-1

ME6130 An introduction to CFD 1-1 ME6130 An introduction to CFD 1-1 What is CFD? Computational fluid dynamics (CFD) is the science of predicting fluid flow, heat and mass transfer, chemical reactions, and related phenomena by solving numerically

More information

QEM-Filtering: A New Technique For Feature-Sensitive Terrain Mesh Simplification

QEM-Filtering: A New Technique For Feature-Sensitive Terrain Mesh Simplification Volume xx (200y), Number z, pp. 1 5 QEM-Filtering: A New Technique For Feature-Sensitive Terrain Mesh Simplification F. Löffler and H. Schumann University of Rostock / VC 2 G, Germany Abstract Traditionally,

More information

Informatica Universiteit van Amsterdam

Informatica Universiteit van Amsterdam Bachelor Informatica Informatica Universiteit van Amsterdam Volumetric Comparison of Simplified 3D Models Steven Klein June 12, 2012 Supervisor: Robert Belleman (UvA) Abstract In the field of computer

More information

ADAPTIVE MULTI-VALUED VOLUME DATA VISUALIZATION USING DATA-DEPENDENT ERROR METRICS

ADAPTIVE MULTI-VALUED VOLUME DATA VISUALIZATION USING DATA-DEPENDENT ERROR METRICS ADAPTIVE MULTI-VALUED VOLUME DATA VISUALIZATION USING DATA-DEPENDENT ERROR METRICS J.T. Gray L. Linsen B. Hamann K.I. Joy Center for Image Processing and Integrated Computing (CIPIC) Department of Computer

More information

Geometric Constraints

Geometric Constraints Simulation in Computer Graphics Geometric Constraints Matthias Teschner Computer Science Department University of Freiburg Outline introduction penalty method Lagrange multipliers local constraints University

More information

Introduction to the Finite Element Method

Introduction to the Finite Element Method Introduction to the Finite Element Method 09.06.2009 Outline Motivation Partial Differential Equations (PDEs) Finite Difference Method (FDM) Finite Element Method (FEM) References Motivation Figure: cross

More information

Level-of-Detail Visualization of Clustered Graph Layouts

Level-of-Detail Visualization of Clustered Graph Layouts Level-of-Detail Visualization of Clustered Graph Layouts Michael Balzer Oliver Deussen Department of Computer and Information Science University of Konstanz, Germany ABSTRACT The level-of-detail techniques

More information

Clustering & Visualization

Clustering & Visualization Chapter 5 Clustering & Visualization Clustering in high-dimensional databases is an important problem and there are a number of different clustering paradigms which are applicable to high-dimensional data.

More information

FRIEDRICH-ALEXANDER-UNIVERSITÄT ERLANGEN-NÜRNBERG

FRIEDRICH-ALEXANDER-UNIVERSITÄT ERLANGEN-NÜRNBERG FRIEDRICH-ALEXANDER-UNIVERSITÄT ERLANGEN-NÜRNBERG INSTITUT FÜR INFORMATIK (MATHEMATISCHE MASCHINEN UND DATENVERARBEITUNG) Lehrstuhl für Informatik 10 (Systemsimulation) Massively Parallel Multilevel Finite

More information

Mesh Discretization Error and Criteria for Accuracy of Finite Element Solutions

Mesh Discretization Error and Criteria for Accuracy of Finite Element Solutions Mesh Discretization Error and Criteria for Accuracy of Finite Element Solutions Chandresh Shah Cummins, Inc. Abstract Any finite element analysis performed by an engineer is subject to several types of

More information

Parallel Simplification of Large Meshes on PC Clusters

Parallel Simplification of Large Meshes on PC Clusters Parallel Simplification of Large Meshes on PC Clusters Hua Xiong, Xiaohong Jiang, Yaping Zhang, Jiaoying Shi State Key Lab of CAD&CG, College of Computer Science Zhejiang University Hangzhou, China April

More information

Multiphase Flow - Appendices

Multiphase Flow - Appendices Discovery Laboratory Multiphase Flow - Appendices 1. Creating a Mesh 1.1. What is a geometry? The geometry used in a CFD simulation defines the problem domain and boundaries; it is the area (2D) or volume

More information

EECS 556 Image Processing W 09. Interpolation. Interpolation techniques B splines

EECS 556 Image Processing W 09. Interpolation. Interpolation techniques B splines EECS 556 Image Processing W 09 Interpolation Interpolation techniques B splines What is image processing? Image processing is the application of 2D signal processing methods to images Image representation

More information

Consolidated Visualization of Enormous 3D Scan Point Clouds with Scanopy

Consolidated Visualization of Enormous 3D Scan Point Clouds with Scanopy Consolidated Visualization of Enormous 3D Scan Point Clouds with Scanopy Claus SCHEIBLAUER 1 / Michael PREGESBAUER 2 1 Institute of Computer Graphics and Algorithms, Vienna University of Technology, Austria

More information

Development and Evaluation of Point Cloud Compression for the Point Cloud Library

Development and Evaluation of Point Cloud Compression for the Point Cloud Library Development and Evaluation of Point Cloud Compression for the Institute for Media Technology, TUM, Germany May 12, 2011 Motivation Point Cloud Stream Compression Network Point Cloud Stream Decompression

More information

Visualization of 2D Domains

Visualization of 2D Domains Visualization of 2D Domains This part of the visualization package is intended to supply a simple graphical interface for 2- dimensional finite element data structures. Furthermore, it is used as the low

More information

A Multiresolution Approach to Large Data Visualization

A Multiresolution Approach to Large Data Visualization A Multiresolution Approach to Large Data Visualization John Clyne 1 Abstract Numerical simulations of turbulent flow, which are fundamental to the study of weather, climate, oceanography, astrophysics,

More information

Interactive Level-Set Deformation On the GPU

Interactive Level-Set Deformation On the GPU Interactive Level-Set Deformation On the GPU Institute for Data Analysis and Visualization University of California, Davis Problem Statement Goal Interactive system for deformable surface manipulation

More information

Visualization of Adaptive Mesh Refinement Data with VisIt

Visualization of Adaptive Mesh Refinement Data with VisIt Visualization of Adaptive Mesh Refinement Data with VisIt Gunther H. Weber Lawrence Berkeley National Laboratory VisIt Richly featured visualization and analysis tool for large data sets Built for five

More information

H.Calculating Normal Vectors

H.Calculating Normal Vectors Appendix H H.Calculating Normal Vectors This appendix describes how to calculate normal vectors for surfaces. You need to define normals to use the OpenGL lighting facility, which is described in Chapter

More information

Interactive 3D Medical Visualization: A Parallel Approach to Surface Rendering 3D Medical Data

Interactive 3D Medical Visualization: A Parallel Approach to Surface Rendering 3D Medical Data Interactive 3D Medical Visualization: A Parallel Approach to Surface Rendering 3D Medical Data Terry S. Yoo and David T. Chen Department of Computer Science University of North Carolina Chapel Hill, NC

More information

A HYBRID GROUND DATA MODEL TO SUPPORT INTERACTION IN MECHANIZED TUNNELING

A HYBRID GROUND DATA MODEL TO SUPPORT INTERACTION IN MECHANIZED TUNNELING A HYBRID GROUND DATA MODEL TO SUPPORT INTERACTION IN MECHANIZED TUNNELING F. HEGEMANN P. MANICKAM K. LEHNER M. KÖNIG D. HARTMANN Department of Civil and Environmental Engineering, Ruhr-University of Bochum,44780

More information

Express Introductory Training in ANSYS Fluent Lecture 1 Introduction to the CFD Methodology

Express Introductory Training in ANSYS Fluent Lecture 1 Introduction to the CFD Methodology Express Introductory Training in ANSYS Fluent Lecture 1 Introduction to the CFD Methodology Dimitrios Sofialidis Technical Manager, SimTec Ltd. Mechanical Engineer, PhD PRACE Autumn School 2013 - Industry

More information

Visualization Technology for the K computer

Visualization Technology for the K computer Technology for the K computer Atsuji Ogasa Hiroyuki Maesaka Kiyotaka Sakamoto Sadanori Otagiri technology makes images or videos from the results of numerical computations performed by supercomputers.

More information

Big Data: Rethinking Text Visualization

Big Data: Rethinking Text Visualization Big Data: Rethinking Text Visualization Dr. Anton Heijs anton.heijs@treparel.com Treparel April 8, 2013 Abstract In this white paper we discuss text visualization approaches and how these are important

More information

Recent Advances and Future Trends in Graphics Hardware. Michael Doggett Architect November 23, 2005

Recent Advances and Future Trends in Graphics Hardware. Michael Doggett Architect November 23, 2005 Recent Advances and Future Trends in Graphics Hardware Michael Doggett Architect November 23, 2005 Overview XBOX360 GPU : Xenos Rendering performance GPU architecture Unified shader Memory Export Texture/Vertex

More information

CONVERGE Features, Capabilities and Applications

CONVERGE Features, Capabilities and Applications CONVERGE Features, Capabilities and Applications CONVERGE CONVERGE The industry leading CFD code for complex geometries with moving boundaries. Start using CONVERGE and never make a CFD mesh again. CONVERGE

More information

Curves and Surfaces. Goals. How do we draw surfaces? How do we specify a surface? How do we approximate a surface?

Curves and Surfaces. Goals. How do we draw surfaces? How do we specify a surface? How do we approximate a surface? Curves and Surfaces Parametric Representations Cubic Polynomial Forms Hermite Curves Bezier Curves and Surfaces [Angel 10.1-10.6] Goals How do we draw surfaces? Approximate with polygons Draw polygons

More information

Introduction to Visualization with VTK and ParaView

Introduction to Visualization with VTK and ParaView Introduction to Visualization with VTK and ParaView R. Sungkorn and J. Derksen Department of Chemical and Materials Engineering University of Alberta Canada August 24, 2011 / LBM Workshop 1 Introduction

More information

Visualization and Feature Extraction, FLOW Spring School 2016 Prof. Dr. Tino Weinkauf. Flow Visualization. Image-Based Methods (integration-based)

Visualization and Feature Extraction, FLOW Spring School 2016 Prof. Dr. Tino Weinkauf. Flow Visualization. Image-Based Methods (integration-based) Visualization and Feature Extraction, FLOW Spring School 2016 Prof. Dr. Tino Weinkauf Flow Visualization Image-Based Methods (integration-based) Spot Noise (Jarke van Wijk, Siggraph 1991) Flow Visualization:

More information

Efficient Simplification of Point-Sampled Surfaces

Efficient Simplification of Point-Sampled Surfaces Efficient Simplification of Point-Sampled Surfaces Mark Pauly Markus Gross Leif P Kobbelt ETH Zürich ETH Zürich RWTH Aachen Figure 1: Michelangelo s David at different levels-of-detail From left to right,

More information

AN ALGORITHM FOR CENTRELINE EXTRACTION USING NATURAL NEIGHBOUR INTERPOLATION

AN ALGORITHM FOR CENTRELINE EXTRACTION USING NATURAL NEIGHBOUR INTERPOLATION AN ALGORITHM FOR CENTRELINE EXTRACTION USING NATURAL NEIGHBOUR INTERPOLATION Darka Mioc, François Anton and Girija Dharmaraj Department of Geomatics Engineering University of Calgary 2500 University Drive

More information

Virtual Resection with a Deformable Cutting Plane

Virtual Resection with a Deformable Cutting Plane Virtual Resection with a Deformable Cutting Plane Olaf Konrad-Verse 1, Bernhard Preim 2, Arne Littmann 1 1 Center for Medical Diagnostic Systems and Visualization, Universitaetsallee 29, 28359 Bremen,

More information

Polyhedral Mesh Generation for CFD-Analysis of Complex Structures

Polyhedral Mesh Generation for CFD-Analysis of Complex Structures Faculty of Civil Engineering and Geodesy Chair for Computation in Engineering Prof. Dr. rer. nat. Ernst Rank Polyhedral Mesh Generation for CFD-Analysis of Complex Structures Georgios Balafas Master s

More information

The Essentials of CAGD

The Essentials of CAGD The Essentials of CAGD Chapter 2: Lines and Planes Gerald Farin & Dianne Hansford CRC Press, Taylor & Francis Group, An A K Peters Book www.farinhansford.com/books/essentials-cagd c 2000 Farin & Hansford

More information

SCATTERED DATA VISUALIZATION USING GPU. A Thesis. Presented to. The Graduate Faculty of The University of Akron. In Partial Fulfillment

SCATTERED DATA VISUALIZATION USING GPU. A Thesis. Presented to. The Graduate Faculty of The University of Akron. In Partial Fulfillment SCATTERED DATA VISUALIZATION USING GPU A Thesis Presented to The Graduate Faculty of The University of Akron In Partial Fulfillment of the Requirements for the Degree Master of Science Bo Cai May, 2015

More information

CUBE-MAP DATA STRUCTURE FOR INTERACTIVE GLOBAL ILLUMINATION COMPUTATION IN DYNAMIC DIFFUSE ENVIRONMENTS

CUBE-MAP DATA STRUCTURE FOR INTERACTIVE GLOBAL ILLUMINATION COMPUTATION IN DYNAMIC DIFFUSE ENVIRONMENTS ICCVG 2002 Zakopane, 25-29 Sept. 2002 Rafal Mantiuk (1,2), Sumanta Pattanaik (1), Karol Myszkowski (3) (1) University of Central Florida, USA, (2) Technical University of Szczecin, Poland, (3) Max- Planck-Institut

More information

Introduction to CFD Analysis

Introduction to CFD Analysis Introduction to CFD Analysis 2-1 What is CFD? Computational Fluid Dynamics (CFD) is the science of predicting fluid flow, heat and mass transfer, chemical reactions, and related phenomena by solving numerically

More information

Computer Graphics. Geometric Modeling. Page 1. Copyright Gotsman, Elber, Barequet, Karni, Sheffer Computer Science - Technion. An Example.

Computer Graphics. Geometric Modeling. Page 1. Copyright Gotsman, Elber, Barequet, Karni, Sheffer Computer Science - Technion. An Example. An Example 2 3 4 Outline Objective: Develop methods and algorithms to mathematically model shape of real world objects Categories: Wire-Frame Representation Object is represented as as a set of points

More information

Algebra 1 2008. Academic Content Standards Grade Eight and Grade Nine Ohio. Grade Eight. Number, Number Sense and Operations Standard

Algebra 1 2008. Academic Content Standards Grade Eight and Grade Nine Ohio. Grade Eight. Number, Number Sense and Operations Standard Academic Content Standards Grade Eight and Grade Nine Ohio Algebra 1 2008 Grade Eight STANDARDS Number, Number Sense and Operations Standard Number and Number Systems 1. Use scientific notation to express

More information

DESIGN, TRANSFORMATION AND ANIMATION OF HUMAN FACES

DESIGN, TRANSFORMATION AND ANIMATION OF HUMAN FACES DESIGN, TRANSFORMATION AND ANIMATION OF HUMAN FACES N.Magnenat-Thalmann, H.T.Minh, M.de Angelis, D.Thalmann Abstract Creation of new human faces for synthetic actors is a tedious and painful task. The

More information

CCTech TM. ICEM-CFD & FLUENT Software Training. Course Brochure. Simulation is The Future

CCTech TM. ICEM-CFD & FLUENT Software Training. Course Brochure. Simulation is The Future . CCTech TM Simulation is The Future ICEM-CFD & FLUENT Software Training Course Brochure About. CCTech Established in 2006 by alumni of IIT Bombay. Our motive is to establish a knowledge centric organization

More information

A NEW METHOD OF STORAGE AND VISUALIZATION FOR MASSIVE POINT CLOUD DATASET

A NEW METHOD OF STORAGE AND VISUALIZATION FOR MASSIVE POINT CLOUD DATASET 22nd CIPA Symposium, October 11-15, 2009, Kyoto, Japan A NEW METHOD OF STORAGE AND VISUALIZATION FOR MASSIVE POINT CLOUD DATASET Zhiqiang Du*, Qiaoxiong Li State Key Laboratory of Information Engineering

More information

AN INTRODUCTION TO NUMERICAL METHODS AND ANALYSIS

AN INTRODUCTION TO NUMERICAL METHODS AND ANALYSIS AN INTRODUCTION TO NUMERICAL METHODS AND ANALYSIS Revised Edition James Epperson Mathematical Reviews BICENTENNIAL 0, 1 8 0 7 z ewiley wu 2007 r71 BICENTENNIAL WILEY-INTERSCIENCE A John Wiley & Sons, Inc.,

More information

In mathematics, there are four attainment targets: using and applying mathematics; number and algebra; shape, space and measures, and handling data.

In mathematics, there are four attainment targets: using and applying mathematics; number and algebra; shape, space and measures, and handling data. MATHEMATICS: THE LEVEL DESCRIPTIONS In mathematics, there are four attainment targets: using and applying mathematics; number and algebra; shape, space and measures, and handling data. Attainment target

More information

Hardware design for ray tracing

Hardware design for ray tracing Hardware design for ray tracing Jae-sung Yoon Introduction Realtime ray tracing performance has recently been achieved even on single CPU. [Wald et al. 2001, 2002, 2004] However, higher resolutions, complex

More information

Back to Elements - Tetrahedra vs. Hexahedra

Back to Elements - Tetrahedra vs. Hexahedra Back to Elements - Tetrahedra vs. Hexahedra Erke Wang, Thomas Nelson, Rainer Rauch CAD-FEM GmbH, Munich, Germany Abstract This paper presents some analytical results and some test results for different

More information

Customer Training Material. Lecture 2. Introduction to. Methodology ANSYS FLUENT. ANSYS, Inc. Proprietary 2010 ANSYS, Inc. All rights reserved.

Customer Training Material. Lecture 2. Introduction to. Methodology ANSYS FLUENT. ANSYS, Inc. Proprietary 2010 ANSYS, Inc. All rights reserved. Lecture 2 Introduction to CFD Methodology Introduction to ANSYS FLUENT L2-1 What is CFD? Computational Fluid Dynamics (CFD) is the science of predicting fluid flow, heat and mass transfer, chemical reactions,

More information

Modelling 3D Avatar for Virtual Try on

Modelling 3D Avatar for Virtual Try on Modelling 3D Avatar for Virtual Try on NADIA MAGNENAT THALMANN DIRECTOR MIRALAB UNIVERSITY OF GENEVA DIRECTOR INSTITUTE FOR MEDIA INNOVATION, NTU, SINGAPORE WWW.MIRALAB.CH/ Creating Digital Humans Vertex

More information

Four-dimensional Mathematical Data Visualization via Embodied Four-dimensional Space Display System

Four-dimensional Mathematical Data Visualization via Embodied Four-dimensional Space Display System Original Paper Forma, 26, 11 18, 2011 Four-dimensional Mathematical Data Visualization via Embodied Four-dimensional Space Display System Yukihito Sakai 1,2 and Shuji Hashimoto 3 1 Faculty of Information

More information

Visualisatie BMT. Introduction, visualization, visualization pipeline. Arjan Kok Huub van de Wetering (h.v.d.wetering@tue.nl)

Visualisatie BMT. Introduction, visualization, visualization pipeline. Arjan Kok Huub van de Wetering (h.v.d.wetering@tue.nl) Visualisatie BMT Introduction, visualization, visualization pipeline Arjan Kok Huub van de Wetering (h.v.d.wetering@tue.nl) 1 Lecture overview Goal Summary Study material What is visualization Examples

More information

OpenFOAM Optimization Tools

OpenFOAM Optimization Tools OpenFOAM Optimization Tools Henrik Rusche and Aleks Jemcov h.rusche@wikki-gmbh.de and a.jemcov@wikki.co.uk Wikki, Germany and United Kingdom OpenFOAM Optimization Tools p. 1 Agenda Objective Review optimisation

More information

Computer Graphics CS 543 Lecture 12 (Part 1) Curves. Prof Emmanuel Agu. Computer Science Dept. Worcester Polytechnic Institute (WPI)

Computer Graphics CS 543 Lecture 12 (Part 1) Curves. Prof Emmanuel Agu. Computer Science Dept. Worcester Polytechnic Institute (WPI) Computer Graphics CS 54 Lecture 1 (Part 1) Curves Prof Emmanuel Agu Computer Science Dept. Worcester Polytechnic Institute (WPI) So Far Dealt with straight lines and flat surfaces Real world objects include

More information

Computational Modeling of Wind Turbines in OpenFOAM

Computational Modeling of Wind Turbines in OpenFOAM Computational Modeling of Wind Turbines in OpenFOAM Hamid Rahimi hamid.rahimi@uni-oldenburg.de ForWind - Center for Wind Energy Research Institute of Physics, University of Oldenburg, Germany Outline Computational

More information

Avizo Inspect New software for industrial inspection and materials R&D

Avizo Inspect New software for industrial inspection and materials R&D Avizo Inspect New software for industrial inspection and materials R&D Reduce your design cycle, inspection times, and meet higher-level quality standards at a lower cost. Avizo Inspect software streamlines

More information

How To Make A Texture Map Work Better On A Computer Graphics Card (Or Mac)

How To Make A Texture Map Work Better On A Computer Graphics Card (Or Mac) Improved Alpha-Tested Magnification for Vector Textures and Special Effects Chris Green Valve (a) 64x64 texture, alpha-blended (b) 64x64 texture, alpha tested (c) 64x64 texture using our technique Figure

More information