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, CA Abstract Unstructured hexahedral grids are widely used in numerical simulations, but remained unconsidered by the visualization community due to the hurdles in overcoming the hanging-node problem. In this paper, we present a multi-resolution approach for unstructured hexahedral grid based on energy-minimizing face collapses. We resolve the hanging-node problem in its general form in order to generate visualizations using cutting-planes computation and isosurface extraction. We circumvent discontinuities in cell boundaries in the case of cutting planes by using general local interpolation schemes and in the case of crack-free isosurfaces by using a dual contouring approach. 1 Introduction Scientific volume data sets are typically defined on structured or unstructured 3D grids. Unstructured grids adapt very 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 most scientific data sets. Though unstructured tetrahedral meshes, for example, have been examined by several scientists, hardly any work has been done on unstructured hexahedral mesh hierarchies, 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 unstructured hexahedral grids. We generate a multiresolution hierarchy of unstructured, rectilinear, hexahedral meshes. The generation of the hierarchy is based on collapsing neighboring hexahedral cells with minimal local variation. This allows us to construct a continuous level-of-detail representation [10]. However, visualization of the resulting data hierarchy is difficult due to the continuity in the levels-of-detail across the grid. Hence, we have developed a cutting plane and an isosurface extraction tool for a general setting, where arbitrary-sized hexahedral building blocks, {sreevals, ahlborn, greenm, hamann}@cs.ucdavis.edu, llinsen@ucdavis.edu. with hanging nodes, are used to discretize a 3D domain. It also helps in preserving the adaptivity 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 the slices and includes neighboring hanging nodes for interpolation. We compare several techniques, namely Shepard s local method, and Sibson method, for the estimation of function values locally. 2 Related Work Although several multi-resolution approaches exist for unstructured tetrahedral meshes, the efforts for hexahedral meshes were restricted to (adaptive) multiresolution approaches of the structured grids [11, 14, 20, 23, 28]. This unequal treatment to tetrahedral and hexahedral grids is because unstructured hexahedral grids generate hanging nodes during the construction of a multi-resolution hierarchy and hanging nodes are generally intractable during visualization. However this does not deter the use of unstructured hexahedral grids in several numerical simulations such as in finite element applications which exploit the adaptive nature of these grids, as in the case of adaptive hp grids. Hexahedral to tetrahedral mesh transformations for resolving the hanging nodes problem are not free from artifacts, as, there is a conflict between the linear interpolation of values on the diagonal (for splitting a hexahedron to 2 tetrahedra) and the underlying trilinear interpolation model in the interior of hexahedron. Since these transformations do not comply with the underlying volumetric data field, they are futile. Construction of mesh hierarchies is done using either bottom-up or top-down strategies. Our problem requires a bottom-up approach retrieving coarser mesh resolution by simplification of the highest resolution [1]. Renze and Oliver used vertex removal for 3D mesh decimation [22]. The re-triangulation is done using Delaunay triangulation of the vertices adjacent to the re-

2 moved vertex. Irregular tetrahedral mesh simplification has been achieved by Trotts et al. [27] using ordering of approximation errors that would result from a tetrahedral cell collapse (implemented via 3 edge collapses). Staadt et al. [26] extend Hoppes Progressive Mesh Algorithm [7] of collapses 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 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 the most optimal triangulation. Desbrun et al. [3] extend this work to obtain intrinsic parametrization by minimization of different distortion measures of the mesh. Levy et al. [9] mention that Dirichlet energy minimizers are harmonic functions and that hierarchical solver will perform well when minimizing a criterion for which the minimum is a harmonic map. These works have inspired us to extend the use of Dirichlet energy minimizers in determining the criterion for a face removal in an unstructured hexahedral 3D mesh. Cutting planes constrain the visualization of 3D data set to an arbitrarily oriented 2D domain. Hence, it is a very useful tool to study changes in the interior of a mesh. For a uniformly resolved mesh, cutting planes can be computed using trilinear interpolation. However, in an adaptive multi-resolution representation, discontinuities along the cell boundaries are inevitable. Hence, we have adopted scattered data interpolation for constructing the slice instead. Isosurfacing is an indispensable tool used in scientific visualization. However hanging nodes pose a problem in the case of adaptively refined grids, as the conventional Marching Cubes (MC) Algorithm approximate the isopoints using linear interpolation on the cell edges. To overcome this problem, we explore the local continuity of the scalar or vector field distribution in the cell interior, and use dual isocontouring techniques. In contrast to the dual contouring methods [5, 8], our algorithm generates vertices lying on the actual isosurface and does not require normal information at vertex locations. We adopt a ray-casting technique to find the points lying in the cell interior. Though use of raycasting techniques is not new in isosurfacing problems, there are differences in the purpose and mechanisms adopted in the previous work and our work. Earlier ray-casting techniques for isosurfacing were used for refining the isosurface generated using the conventional MC Algorithm [2]. Fruhauf [4] pioneered in adopting a ray-casting approach (which usually uses a trilinear interpolation filter) to produce output meshes which were better than ones generated using the MC technique. A number of different interpolation filters have been proposed [6, 15, 17, 18] for more precise computation of the field values and gradients. The advantage of this technique is it allows the adoption of whichever reconstruction filter for interpolation of field values. However its drawbacks are its high time complexity and view-dependence. In our work, we blend ray-casting and dual isocontouring in a view-independent fashion to construct a crack-free isosurface. View-independence is achieved by casting rays along the body diagonals in each cell. 3 Multi-resolution Hierarchy We introduce a novel technique for implementing face removal to build the multi-resolution hierarchy. The underlying fields typically result from physical or chemical simulations, and are approximated using trilinear interpolation in the cell interior. The function is a trivariate harmonic function, as it has continuous second partial derivatives which 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 modulus of the function gradient over the domain. Relative Dirichlet energies of different cells give 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 values, and low gradients indicate smooth variation of the function throughout the cell. Our goal while generating coarser resolution in a multi-resolution hierarchy is to preserve as much information as possible. In order to preserve information about where changes occur, we sort the Dirichlet energy contained in each cell to prioritize the order of face removals. The discrete Dirichlet energy in each cell is computed by the gradient of the function in the cell, i.e., by E = 12 i=1 ( ( fi ) 2 + x ( ) 2 fi + y ( ) ) 2 fi z (1) where f i is the function value along the edge i of a cell. The cells in the grid are then sorted in ascending order of Dirichlet energy functional values. A userdefined minimum number of cells with low Dirichlet energy value is considered. From this reduced set of cells, combinations of two cells are selected, which satisfy the following criteria for collapsing: 1. The cells share a common face. 2. The Dirichlet energy of the resulting collapsed cell should be as low as possible. If the first pass fails, the next batch 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 parameter varies smoothly. We chose this two-pass approach over the straightforward one-pass approach in order to reduce the computational overhead.

3 Once the appropriate set of cells is found, the collapse is implemented by removing the common face and appropriately rearranging the connectivity information of the vertices in the resultant cell. Common face removal results in a new hexahedral cell. Shape properties are favorably preserved after the cell collapse. 4 Cutting planes Cutting planes is a projection of the 3D volume data on an arbitrary 2D plane. This helps us to study the distribution of the parameter in the interior of the grid. Trilinear interpolation of the points on the cutting plane is a very simple and hence a tempting technique to be adopted in this scenario of rectilinear grids. However it fails on a coarse grid with hanging nodes and generates artifacts owing to the inherent discontinuities in the cell boundaries. This makes trilinear interpolation a poor choice for cutting plane visualization in certain cases. Thus we turn to other scattered data interpolation techniques like the Sibson interpolation and Shepard s local method for better results. Sibson interpolation method [25] uses information from voxels in the neighborhood of the point on the cutting plane being evaluated. This method thus addresses the drawback of cracks in the cutting plane evaluation in a coarse grid. However the high computational overhead in this case 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 the distances of the local neighborhood voxels, there is increased user interactivity as opposed to Sibson interpolation. Though we trade off accuracy for lesser time complexity in this case, the results obtained using Shepard s method are good. 5 Isosurfacing The idea of dual isocontouring is inspired mainly from the work by Ju et al. [8] and Greß et al. [5]. In contrast to the Marching Cubes algorithm [12, 13, 16, 19], dual contouring computes the isopoints computed in the cell interior, rather than on the boundaries. The dual approach is desirable in the case of hanging nodes, owing to the discontinuities in the cell boundaries in the grid. However, in our algorithm we still make use of the case look-up table of the Marching Cubes Algorithm in order to distinguish between the different cases. We shoot rays along the body diagonals and find the intersection points with the trilinearly interpolated surfaces in the cell interior using Cardan s solution for cubic equations. The algorithm is divided into 3 parts, namely, Case Identification, Isopoint Computation and Triangulation. 5.1 Case Identification The preprocessing of our novel isosurfacing algorithm involves the use of the case look-up table of the conventional Marching Cubes Algorithm, in order to identify the specific case in the look-up table to which the cell corresponds. Using the information of the case in the look-up table, we can determine: 1. The rays that are to be shot along the body diagonals: Since we are using the minimum number of rays possible for determining the isopoints, the look up table tells us which rays intersects the isosurface. 2. The number of disjoint surfaces to be expected within each cell: The look-up table tells us how many isosurface components are to expected to be found in the cell and how they are connected to the components detected in the neighboring cells. 5.2 Isopoint Computation This involves finding the intersection of the ray and the trilinear interpolation surface for the given isovalue.the ray is represented as: r = r 1 + p( r 2 r 1 ) (2) where r 1 and r 2 are the position vectors of the endpoints of the ray and p is the parameter, such that p [0, 1]. The trilinear interpolation surface is given as: I = (1 s).(1 t).(1 u).f (1 s).(1 t).u.f (1 s).t.(1 u).f (1 s).t.u.f s.(1 t).(1 u).f s.(1 t).u.f s.t.(1 u).f s.t.u.f 111 (3) where s, t, and u are parameters along x, y, and z axes, respectively and f ijk s are field values at the corresponding vertices of the cell, and I is the isovalue. The parametric representation intersection point in (s, t, u) is substituted in terms of p and substituted in Equation 3. The zeros of the cubic equation in p are found using Cardan s solution. Real roots in the range [0,1] give the required intersection points. There may be more than one desired root, which indicates the existence of disconnected multiple surfaces within a cell. However it is ensured that there will be at least one point per cell containing at least one edge with opposite signs at its ends. 5.3 Triangulation The triangulation of all the interior points is determined by the following rules: 1. Edges are constructed from an interior point to points in at most 3 distinct neighboring cells [8]. 2. In case of boundary cells, Marching Cubes algorithm is used to find points on the cell boundaries for terminating the isosurface.

4 3. In case of only two cells being connected then the isosurface is terminated using the intersection points obtained from the Marching Cubes Algorithm, except on the edges shared by both the cells. 4. Points within a cell are not connected to each other. This is required to maintain the number of disconnected surfaces within each cell. 6 Results For developing our isosurfacing algorithm, small test cases have been used. For finding the minimum number of rays to be cast, a test case of one cube is taken and for constructing the isosurface, a test case of eight neighboring cubes is taken. Some of the isosurfaces that are developed for some test values 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 (shown as yellow lines) cast is minimal. The white triangles are the MC isosurfaces and the cyan points are the dual isopoints. Figure 2: (a) shows the comparison of MC isosurface (in white) and dual isosurface (in magenta). (b) shows the octahedron (in white) in MC case and its dual, a cube (edges shown in green) generated using our dual method. We applied our novel technique of multi-resolution hierarchy, cutting planes and isosurfacing on a multiblock data set of flow simulations on an oil-water field at different time steps, with data available on parameters like oil pressure, oil concentration, water saturation and oil velocity, for each point in the grid. The data set consists of 876, 148, 576, 152 and 872 cells in 5 different blocks of the multi-block grid, as shown in Figure 3. Each different block is considered as a grid in our present implementation. Our test case is the oil pressure field of the data set, as shown in Figure 3. On developing the multi-resolution hierarchy, as can be seen in Figures 4 and 5, we observe that after 1000 cell collapses, we do not find much change in the color mapping of the oil pressure field. However after 1500 cell collapses, we observe discontinuities in the color mapping (implemented using Gourard shading). Most of the initial cell collapses occurred in the third grid, where the function varies smoothly. The artifacts in the color mapping in the latter case is due to the Gourard shading. Trilinear, Sibson and Shepard s local interpolation schemes are applied on the dataset to get a slice orthogonal to x-z plane, as shown in Figure 6. Sibson interpolation is more time consuming than Shepard s, though the quality of result is more accurate in former than in other two, where discontinuities can be very obviously seen (Figure 6). However, we weigh the lower time cost in this trade-off between time complexity and accuracy. Hence Shepard s method is more favored than the Sibson. Our isosurfacing algorithm is applied to the oil pressure field. We observe that before performing the cell collapses, our algorithm as well as the Marching Cubes algorithm give similar results (Figure 7). Except in the latter, there is a discontinuity at the boundary between two different blocks. This can be addressed to by treating the boundary cases specifically. 7 Conclusions & Future Work As can be observed from our test study, the three different operations of scientific visualization work as expected. However certain issues that need to be addressed to are : 1. One cell collapse per run of the algorithm is not very economical. The algorithm should improved in order to allow more than one collapse per iteration so that more than one pair of cell with similar energy functional values can be collapsed together. 2. Optimization of the isosurfacing algorithm is needed so that it can be efficient on large-scale data sets too. 3. Isosurfacing needs to be improved upon for cases including more complex isosurfaces, like the tunnels [12]. 4. A formal look-up table for the isosurfacing needs to be made. Specific boundary cases need to be visited again. This is essential for applying the new algorithm on the 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 Men-

5 tal 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 also acknowledge the support of ALSTOM Schilling Robotics and SGI. 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, and the members of the Data Science Group at the Center for Applied Scientific Computing (CASC) at the Lawrence Livermore National Laboratory, Livermore, California. 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. Fruhauf, 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 kd-trees, 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 [17] T. Möller, R. Machiraju, K. Mü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. Möller, R. Machiraju, K. Mü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 [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

6 [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 [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 Figure 5: (a) and (b) show the mesh after 1500 collapses. Note that most of the collapses have occurred in the grid with smooth varying function. [26] O. G. Staadt and M.H.Gross, Progressive tetrahedralization, in Proceedings of IEEE Visualization 1998, IEEE Computer Society, Washington DC, 1998, pp [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: Comparison of (a) Trilinear, (b) Sibson, and (c) Shepard s local interpolation schemes for the cutting plane visualization on grid after 500 collapses. Figure 3: (a) shows the mesh of the oil field, with different colors identifying different blocks. (b) shows the color mapping of the Oil Pressure field. Figure 4: (a) and (b) show the mesh after 1000 collapses. Figure 7: (a) shows the isosurface obtained using MC algorithm and (b) shows the one obtained using our algorithm. The discontinuity in the surface in (b) is due to boundary between 2 different blocks, and not cell boundary discontinuity due to cell collapse.

Constructing Material Interfaces From Data Sets With Volume-Fraction Information

Constructing Material Interfaces From Data Sets With Volume-Fraction Information Constructing Material Interfaces From Data Sets With Volume-Fraction Information Kathleen S. Bonnell Daniel R. Schikore Kenneth I. Joy Mark Duchaineau Bernd Hamann Abstract We present a new algorithm for

More information

USING RAY INTERSECTION FOR DUAL ISOSURFACING

USING RAY INTERSECTION FOR DUAL ISOSURFACING USING RAY INTERSECTION FOR DUAL ISOSURFACING Jaya Sreevalsan-Nair 1 Lars Linsen 2 ernd Hamann 1 1 Institute for Data Analysis and Visualization (IDAV) 2 Department of Mathematics and Computer Science Department

More information

Direct Extraction of Normal Mapped Meshes from Volume Data

Direct Extraction of Normal Mapped Meshes from Volume Data Direct Extraction of Normal Mapped Meshes from Volume Data Mark Barry and Zoë Wood California Polytechnic State University Abstract. We describe a method of directly extracting a simplified contour surface

More information

Direct Extraction of Normal Mapped Meshes from Volume Data

Direct Extraction of Normal Mapped Meshes from Volume Data Direct Extraction of Normal Mapped Meshes from Volume Data Mark Barry and Zoë Wood California Polytechnic State University Figure 1. A human head extracted from a 130 x 128 x 128 volume. All meshes are

More information

Topology Preserving Tetrahedral Decomposition of Trilinear Cell

Topology Preserving Tetrahedral Decomposition of Trilinear Cell Topology Preserving Tetrahedral Decomposition of Trilinear Cell Bong-Soo Sohn Department of Computer Engineering, Kyungpook National University Daegu 702-701, South Korea bongbong@knu.ac.kr http://bh.knu.ac.kr/

More information

Fairing Scalar Fields by Variational Modeling of Contours

Fairing Scalar Fields by Variational Modeling of Contours Fairing Scalar Fields by Variational Modeling of Contours Martin Bertram University of Kaiserslautern, Germany Abstract Volume rendering and isosurface extraction from three-dimensional scalar fields are

More information

Multiresolution View-Dependent Splat Based Volume Rendering of Large Irregular Data

Multiresolution View-Dependent Splat Based Volume Rendering of Large Irregular Data Multiresolution View-Dependent Splat Based Volume Rendering of Large Irregular Data Jeremy Meredith Lawrence Livermore National Laboratory Kwan-Liu Ma University of California, Davis Abstract We present

More information

LAPLACIAN MESH SMOOTHING FOR TETRAHEDRA BASED VOLUME VISUALIZATION 1. INTRODUCTION

LAPLACIAN MESH SMOOTHING FOR TETRAHEDRA BASED VOLUME VISUALIZATION 1. INTRODUCTION JOURNAL OF MEDICAL INFORMATICS & TECHNOLOGIES Vol.4/2002, ISSN 642-6037 Rafał STĘGIERSKI *, Paweł MIKOŁAJCZAK * volume data,triangle mesh generation, mesh smoothing, marching tetrahedra LAPLACIAN MESH

More information

Terrain Modeling Using Voronoi Hierarchies

Terrain Modeling Using Voronoi Hierarchies Terrain Modeling Using Voronoi Hierarchies Martin Bertram 1, Shirley E. Konkle 2, Hans Hagen 1, Bernd Hamann 3,and Kenneth I. Joy 3 1 University of Kaiserslautern, Department of Computer Science, P.O.

More information

Isosurface Rendering. CSC 7443: Scientific Information Visualization

Isosurface Rendering. CSC 7443: Scientific Information Visualization Isosurface Rendering What is Isosurfacing? An isosurface is the 3D surface representing the locations of a constant scalar value within a volume A surface with the same scalar field value Isosurfaces form

More information

Indirect Volume Rendering

Indirect Volume Rendering Indirect Volume Rendering Visualization Torsten Möller Weiskopf/Machiraju/Möller Overview Contour tracing Marching cubes Marching tetrahedra Optimization octree-based range query Weiskopf/Machiraju/Möller

More information

Scalar Visualization

Scalar Visualization Scalar Visualization 5-1 Motivation Visualizing scalar data is frequently encountered in science, engineering, and medicine, but also in daily life. Recalling from earlier, scalar datasets, or scalar fields,

More information

Real-time View-dependent Extraction of Isosurfaces from Adaptively Refined Octrees and Tetrahedral Meshes

Real-time View-dependent Extraction of Isosurfaces from Adaptively Refined Octrees and Tetrahedral Meshes Real-time View-dependent Extraction of Isosurfaces from Adaptively Refined Octrees and Tetrahedral Meshes David C. Fang, Jevan T. Gray, Bernd Hamann, and Kenneth I. Joy Center for Image Processing and

More information

Data Visualization (DSC 530/CIS )

Data Visualization (DSC 530/CIS ) Data Visualization (DSC 530/CIS 60-0) Isosurfaces & Volume Rendering Dr. David Koop Fields & Grids Fields: - Values come from a continuous domain, infinitely many values - Sampled at certain positions

More information

Topology Preserving and Controlled Topology Simplifying Multiresolution Isosurface Extraction

Topology Preserving and Controlled Topology Simplifying Multiresolution Isosurface Extraction Topology Preserving and Controlled Topology Simplifying Multiresolution Isosurface Extraction Thomas Gerstner Department for Applied Mathematics University of Bonn gerstner@iam.uni-bonn.de Renato Pajarola

More information

MATERIAL INTERFACE RECONSTRUCTION

MATERIAL INTERFACE RECONSTRUCTION MAERIAL INERFACE RECONSRUCION Kathleen S. Bonnell 1 Mark A. Duchaineau 2 Daniel R. Schikore 3 Bernd Hamann 4 Kenneth I. Joy 5 Abstract his paper presents an algorithm for material interface reconstruction

More information

Using Isosurface Methods for Visualizing the Envelope of a Swept Trivariate Solid

Using Isosurface Methods for Visualizing the Envelope of a Swept Trivariate Solid Using Isosurface Methods for Visualizing the Envelope of a Swept Trivariate Solid Jason Conkey Kenneth I. Joy Center for Image Processing and Integrated Computing Department of Computer Science University

More information

A Developer s Survey of Polygonal Simplification algorithms. CS 563 Advanced Topics in Computer Graphics Fan Wu Mar. 31, 2005

A Developer s Survey of Polygonal Simplification algorithms. CS 563 Advanced Topics in Computer Graphics Fan Wu Mar. 31, 2005 A Developer s Survey of Polygonal Simplification algorithms CS 563 Advanced Topics in Computer Graphics Fan Wu Mar. 31, 2005 Some questions to ask Why simplification? What are my models like? What matters

More information

Multiresolution Techniques for Interactive Texture-based Rendering of Arbitrarily Oriented Cutting Planes

Multiresolution Techniques for Interactive Texture-based Rendering of Arbitrarily Oriented Cutting Planes Multiresolution Techniques for Interactive Texture-based Rendering of Arbitrarily Oriented Cutting Planes Eric LaMar Mark A. Duchaineau*, Bernd Hamann*, Kenneth I. Joy* Center for Image Processing and

More information

Isosurfaces Over Simplicial Partitions of Multiresolution Grids

Isosurfaces Over Simplicial Partitions of Multiresolution Grids EUROGRAPHICS 2010 / T. Akenine-Möller and M. Zwicker (Guest Editors) Volume 29 (2010), Number 2 Isosurfaces Over Simplicial Partitions of Multiresolution Grids Josiah Manson and Scott Schaefer Texas A&M

More information

FAST METHODS FOR COMPUTING ISOSURFACE TOPOLOGY WITH BETTI NUMBERS

FAST METHODS FOR COMPUTING ISOSURFACE TOPOLOGY WITH BETTI NUMBERS FAST METHODS FOR COMPUTING ISOSURFACE TOPOLOGY WITH BETTI NUMBERS Shirley F. Konkle University of California, Davis konkle@cs.ucdavis.edu Patrick J. Moran NASA Ames Research Center pmoran@nas.nasa.gov

More information

Freeform Shape Representations for Efficient Geometry Processing

Freeform Shape Representations for Efficient Geometry Processing Freeform Shape Representations for Efficient Geometry Processing Leif Kobbelt Mario Botsch Computer Graphics Group RWTH Aachen Abstract The most important concepts for the handling and storage of freeform

More information

Volume visualization. Volume visualization. Volume visualization methods. Sources of volume visualization. Sources of volume visualization

Volume visualization. Volume visualization. Volume visualization methods. Sources of volume visualization. Sources of volume visualization Volume visualization Volume visualization Volumes are special cases of scalar data: regular 3D grids of scalars, typically interpreted as density values. Each data value is assumed to describe a cubic

More information

Adaptive Contouring with Quadratic Tetrahedra

Adaptive Contouring with Quadratic Tetrahedra Adaptive Contouring with Quadratic Tetrahedra Benjamin F. Gregorski 1, David F. Wiley 1, Henry R. Childs 2, Bernd Hamann 1, and Kenneth I. Joy 1 1 Institute For Data Analysis and Visualization University

More information

Efficient Representation and Extraction of 2-Manifold Isosurfaces Using kd-trees

Efficient Representation and Extraction of 2-Manifold Isosurfaces Using kd-trees Efficient Representation and Extraction of 2-Manifold Isosurfaces Using kd-trees Alexander Greß and Reinhard Klein University of Bonn Institute of Computer Science II Römerstraße 164, 53117 Bonn, Germany

More information

Dealing with Massive Volumetric Visualization: Progressive Algorithms and Data Structures

Dealing with Massive Volumetric Visualization: Progressive Algorithms and Data Structures Dealing with Massive Volumetric Visualization: Progressive Algorithms and Data Structures Rita Borgo Visual Computing Group - Consiglio Nazionale delle Ricerche, via G. Moruzzi 1, I-56100 Pisa, Italy,

More information

Scalar Algorithms: Contouring

Scalar Algorithms: Contouring Scalar Algorithms: Contouring Computer Animation and Visualisation Lecture tkomura@inf.ed.ac.uk Institute for Perception, Action & Behaviour School of Informatics Contouring Scaler Data Last Lecture...

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, Vincent E. Beckner 1, Hank Childs 2, Terry J. Ligocki 1, Mark C. Miller 2, Brian Van Straalen 1 and E. Wes Bethel 1 1 Lawrence

More information

Volume Illumination, Contouring

Volume Illumination, Contouring Volume Illumination, Contouring Computer Animation and Visualisation Lecture 0 tkomura@inf.ed.ac.uk Institute for Perception, Action & Behaviour School of Informatics Contouring Scaler Data Overview -

More information

PSP: Progressive Subdivision Paradigm for Large Scale Visualization

PSP: Progressive Subdivision Paradigm for Large Scale Visualization EUROGRAPHICS ITALIAN CHAPTER PSP: Progressive Subdivision Paradigm for Large Scale Visualization R. Borgo, 1 R. Scopigno, 1 P. Cignoni, 1 and V. Pascucci, 2 1 Visual Computing Group, Consiglio Nazionale

More information

Special Topics in Visualization

Special Topics in Visualization Special Topics in Visualization Final Project Report Dual contouring of Hermite Data Submitted By S M Shahed Nejhum 8589-1199 May 19, 2008 Introduction Iso-surface extraction from 3D volumetric data is

More information

SURFACE CONSTRUCTION USING TRICOLOR MARCHING CUBES

SURFACE CONSTRUCTION USING TRICOLOR MARCHING CUBES SURFACE CONSTRUCTION USING TRICOLOR MARCHING CUBES Shaojun Liu, Jia Li Oakland University Rochester, MI 4839, USA Email: sliu2@oakland.edu, li4@oakland.edu Xiaojun Jing Beijing University of Posts and

More information

Contouring and Isosurfaces. Ronald Peikert SciVis Contouring 2-1

Contouring and Isosurfaces. Ronald Peikert SciVis Contouring 2-1 Contouring and Isosurfaces Ronald Peikert SciVis 2007 - Contouring 2-1 What are contours? Set of points where the scalar field s has a given value c: Examples in 2D: height contours on maps isobars on

More information

IN many applications, it is necessary to reconstruct or track

IN many applications, it is necessary to reconstruct or track 500 IEEE TRANSACTIONS ON VISUALIZATION AND COMPUTER GRAPHICS, VOL. 9, NO. 4, OCTOBER-DECEMBER 2003 Material Interface Reconstruction Kathleen S. Bonnell, Member, IEEE Computer Society, Mark A. Duchaineau,

More information

11/1/13. Visualization. Scientific Visualization. Types of Data. Height Field. Contour Curves. Meshes

11/1/13. Visualization. Scientific Visualization. Types of Data. Height Field. Contour Curves. Meshes CSCI 420 Computer Graphics Lecture 26 Visualization Height Fields and Contours Scalar Fields Volume Rendering Vector Fields [Angel Ch. 2.11] Jernej Barbic University of Southern California Scientific Visualization

More information

Visualization. CSCI 420 Computer Graphics Lecture 26

Visualization. CSCI 420 Computer Graphics Lecture 26 CSCI 420 Computer Graphics Lecture 26 Visualization Height Fields and Contours Scalar Fields Volume Rendering Vector Fields [Angel Ch. 11] Jernej Barbic University of Southern California 1 Scientific Visualization

More information

A Framework for Visualizing Hierarchical Computations

A Framework for Visualizing Hierarchical Computations A Framework for Visualizing Hierarchical Computations Terry J. Ligocki 1, Brian Van Straalen 2,JohnM.Shalf 1,GuntherH. Weber 3,4, and Bernd Hamann 1,3 1 Lawrence Berkeley National Laboratory, National

More information

Level Set Extraction from Gridded 2D and 3D Data

Level Set Extraction from Gridded 2D and 3D Data Level Set Extraction from Gridded 2D and 3D Data David Eberly, Geometric Tools, Redmond WA 98052 https://www.geometrictools.com/ This work is licensed under the Creative Commons Attribution 4.0 International

More information

Data Visualization (DSC 530/CIS )

Data Visualization (DSC 530/CIS ) Data Visualization (DSC 530/CIS 60-01) Scalar Visualization Dr. David Koop Online JavaScript Resources http://learnjsdata.com/ Good coverage of data wrangling using JavaScript Fields in Visualization Scalar

More information

Marching Cubes without Skinny Triangles

Marching Cubes without Skinny Triangles Marching Cubes without Skinny Triangles Carlos A. Dietrich, Carlos E. Scheidegger, João L. D. Comba, Luciana P. Nedel and Cláudio T. Silva, Senior Member, IEEE Abstract Most computational codes that use

More information

What is visualization? Why is it important?

What is visualization? Why is it important? What is visualization? Why is it important? What does visualization do? What is the difference between scientific data and information data Cycle of Visualization Storage De noising/filtering Down sampling

More information

Scalar Field Visualization. Some slices used by Prof. Mike Bailey

Scalar Field Visualization. Some slices used by Prof. Mike Bailey Scalar Field Visualization Some slices used by Prof. Mike Bailey Scalar Fields The approximation of certain scalar function in space f(x,y,z). Most of time, they come in as some scalar values defined on

More information

Dealing with Massive Volumetric Visualization: Progressive Algorithms and Data Structures

Dealing with Massive Volumetric Visualization: Progressive Algorithms and Data Structures Dealing with Massive Volumetric Visualization: Progressive Algorithms and Data Structures Rita Borgo Visual Computing Group - Consiglio Nazionale delle Ricerche, via G. Moruzzi 1, I-56100 Pisa, Italy,

More information

Dual Marching Cubes. Gregory M. Nielson. Arizona State University

Dual Marching Cubes. Gregory M. Nielson. Arizona State University Dual Marching Cubes Gregory M. Nielson Arizona State University Figure 1. March Cubes Surface MC-Patch surface, S MC-Dual surface, S. ABSTRACT We present the definition and computational algorithms for

More information

CIS 467/602-01: Data Visualization

CIS 467/602-01: Data Visualization CIS 467/60-01: Data Visualization Isosurfacing and Volume Rendering Dr. David Koop Fields and Grids Fields: values come from a continuous domain, infinitely many values - Sampled at certain positions to

More information

Interactive Visualization of Very Large Medical Datasets using Point-based Rendering

Interactive Visualization of Very Large Medical Datasets using Point-based Rendering Interactive Visualization of Very Large Medical Datasets using Point-based Rendering Christof Nuber, Ralph W. Bruckschen, Bernd Hamann and Kenneth I. Joy Center for Image Processing and Integrated Computing,

More information

Efficient Representation and Extraction of 2-Manifold Isosurfaces Using kd-trees

Efficient Representation and Extraction of 2-Manifold Isosurfaces Using kd-trees Efficient Representation and Extraction of 2-Manifold Isosurfaces Using kd-trees Alexander Greß gress@cs.uni-bonn.de Reinhard Klein rk@cs.uni-bonn.de University of Bonn Institute of Computer Science II

More information

EXPLOITING DATA COHERENCY IN MULTIPLE DATASET VISUALIZATION

EXPLOITING DATA COHERENCY IN MULTIPLE DATASET VISUALIZATION EXPLOITING DATA COHERENCY IN MULTIPLE DATASET VISUALIZATION Gaurav Khanduja and Bijaya B. Karki Department of Computer Science, Louisiana State University Baton Rouge, LA USA gkhand1@lsu.edu and karki@csc.lsu.edu

More information

Voxelization in Common Sampling Lattices

Voxelization in Common Sampling Lattices Voxelization in Common Sampling Lattices Haris Widjaya htw@cs.sfu.ca Torsten Möller torsten@cs.sfu.ca Alireza Entezari aentezar@cs.sfu.ca Abstract In this paper we introduce algorithms to voxelize polygonal

More information

Multiresolution Tetrahedral Framework for Visualizing Regular Volume Data

Multiresolution Tetrahedral Framework for Visualizing Regular Volume Data Multiresolution Tetrahedral Framework for Visualizing Regular Volume Data Yong Zhou, Baoquan Chen, and Arie Kaufman æ Center for Visual Computing and Department of Computer Science State University of

More information

Hierarchical Clustering for Unstructured Volumetric Scalar Fields

Hierarchical Clustering for Unstructured Volumetric Scalar Fields Hierarchical Clustering for Unstructured Volumetric Scalar Fields Christopher S. Co University of California, Davis Bjoern Heckel Plumtree Software, Inc. Hans Hagen University of Kaiserslautern, Germany

More information

coding of various parts showing different features, the possibility of rotation or of hiding covering parts of the object's surface to gain an insight

coding of various parts showing different features, the possibility of rotation or of hiding covering parts of the object's surface to gain an insight Three-Dimensional Object Reconstruction from Layered Spatial Data Michael Dangl and Robert Sablatnig Vienna University of Technology, Institute of Computer Aided Automation, Pattern Recognition and Image

More information

Constructing 3D Elliptical Gaussians for Irregular Data

Constructing 3D Elliptical Gaussians for Irregular Data Constructing 3D Elliptical Gaussians for Irregular Data Wei Hong 1, Neophytos Neophytou 2, Klaus Mueller 3, and Arie Kaufman 4 1 Center for Visual Computing and Department of Computer Science Stony Brook

More information

Extraction of Crack-free Isosurfaces from Adaptive Mesh Refinement Data

Extraction of Crack-free Isosurfaces from Adaptive Mesh Refinement Data Extraction of Crack-free Isosurfaces from Adaptive Mesh Refinement Data Gunther H. Weber,2,3, Oliver Kreylos,3, Terry J. Ligocki 3, John M. Shalf 3,4, Hans Hagen 2, Bernd Hamann,3, and Kenneth I. Joy Center

More information

Visualization Computer Graphics I Lecture 20

Visualization Computer Graphics I Lecture 20 15-462 Computer Graphics I Lecture 20 Visualization Height Fields and Contours Scalar Fields Volume Rendering Vector Fields [Angel Ch. 12] April 15, 2003 Frank Pfenning Carnegie Mellon University http://www.cs.cmu.edu/~fp/courses/graphics/

More information

Visualization. Images are used to aid in understanding of data. Height Fields and Contours Scalar Fields Volume Rendering Vector Fields [chapter 26]

Visualization. Images are used to aid in understanding of data. Height Fields and Contours Scalar Fields Volume Rendering Vector Fields [chapter 26] Visualization Images are used to aid in understanding of data Height Fields and Contours Scalar Fields Volume Rendering Vector Fields [chapter 26] Tumor SCI, Utah Scientific Visualization Visualize large

More information

Introduction to Computer Graphics. Modeling (3) April 27, 2017 Kenshi Takayama

Introduction to Computer Graphics. Modeling (3) April 27, 2017 Kenshi Takayama Introduction to Computer Graphics Modeling (3) April 27, 2017 Kenshi Takayama Solid modeling 2 Solid models Thin shapes represented by single polygons Unorientable Clear definition of inside & outside

More information

Unconstrained Isosurface Extraction on Arbitrary Octrees

Unconstrained Isosurface Extraction on Arbitrary Octrees Eurographics Symposium on Geometry Processing (2007) Alexander Belyaev, Michael Garland (Editors) Unconstrained Isosurface Extraction on Arbitrary Octrees Michael Kazhdan 1, Allison Klein 2, Ketan Dalal

More information

Data Representation in Visualisation

Data Representation in Visualisation Data Representation in Visualisation Visualisation Lecture 4 Taku Komura Institute for Perception, Action & Behaviour School of Informatics Taku Komura Data Representation 1 Data Representation We have

More information

Mesh Repairing and Simplification. Gianpaolo Palma

Mesh Repairing and Simplification. Gianpaolo Palma Mesh Repairing and Simplification Gianpaolo Palma Mesh Repairing Removal of artifacts from geometric model such that it becomes suitable for further processing Input: a generic 3D model Output: (hopefully)a

More information

Parameterization of Triangular Meshes with Virtual Boundaries

Parameterization of Triangular Meshes with Virtual Boundaries Parameterization of Triangular Meshes with Virtual Boundaries Yunjin Lee 1;Λ Hyoung Seok Kim 2;y Seungyong Lee 1;z 1 Department of Computer Science and Engineering Pohang University of Science and Technology

More information

Height Fields and Contours Scalar Fields Volume Rendering Vector Fields [Angel Ch. 12] April 23, 2002 Frank Pfenning Carnegie Mellon University

Height Fields and Contours Scalar Fields Volume Rendering Vector Fields [Angel Ch. 12] April 23, 2002 Frank Pfenning Carnegie Mellon University 15-462 Computer Graphics I Lecture 21 Visualization Height Fields and Contours Scalar Fields Volume Rendering Vector Fields [Angel Ch. 12] April 23, 2002 Frank Pfenning Carnegie Mellon University http://www.cs.cmu.edu/~fp/courses/graphics/

More information

Scientific Visualization Example exam questions with commented answers

Scientific Visualization Example exam questions with commented answers Scientific Visualization Example exam questions with commented answers The theoretical part of this course is evaluated by means of a multiple- choice exam. The questions cover the material mentioned during

More information

Scalar Visualization

Scalar Visualization Scalar Visualization Visualizing scalar data Popular scalar visualization techniques Color mapping Contouring Height plots outline Recap of Chap 4: Visualization Pipeline 1. Data Importing 2. Data Filtering

More information

Intrinsic Morphing of Compatible Triangulations. VITALY SURAZHSKY CRAIG GOTSMAN

Intrinsic Morphing of Compatible Triangulations. VITALY SURAZHSKY CRAIG GOTSMAN International Journal of Shape Modeling Vol. 9, No. 2 (2003) 191 201 c World Scientific Publishing Company Intrinsic Morphing of Compatible Triangulations VITALY SURAZHSKY vitus@cs.technion.ac.il CRAIG

More information

Geometric Representations. Stelian Coros

Geometric Representations. Stelian Coros Geometric Representations Stelian Coros Geometric Representations Languages for describing shape Boundary representations Polygonal meshes Subdivision surfaces Implicit surfaces Volumetric models Parametric

More information

Egemen Tanin, Tahsin M. Kurc, Cevdet Aykanat, Bulent Ozguc. Abstract. Direct Volume Rendering (DVR) is a powerful technique for

Egemen Tanin, Tahsin M. Kurc, Cevdet Aykanat, Bulent Ozguc. Abstract. Direct Volume Rendering (DVR) is a powerful technique for Comparison of Two Image-Space Subdivision Algorithms for Direct Volume Rendering on Distributed-Memory Multicomputers Egemen Tanin, Tahsin M. Kurc, Cevdet Aykanat, Bulent Ozguc Dept. of Computer Eng. and

More information

MULTI-RESOLUTION DUAL CONTOURING FROM VOLUMETRIC DATA

MULTI-RESOLUTION DUAL CONTOURING FROM VOLUMETRIC DATA MULTI-RESOLUTION DUAL CONTOURING FROM VOLUMETRIC DATA Ricardo Uribe Lobello, Florent Dupont, Florence Denis Université de Lyon, CNRS, LIRIS, UMR5205, Villeurbanne F-69622, France {Ricardo.Uribe-lobello,Florent.Dupont,Florence.Denis}@liris.cnrs.fr

More information

Watertight Planar Surface Reconstruction of Voxel Data

Watertight Planar Surface Reconstruction of Voxel Data Watertight Planar Surface Reconstruction of Voxel Data Eric Turner CS 284 Final Project Report December 13, 2012 1. Introduction There are many scenarios where a 3D shape is represented by a voxel occupancy

More information

Data Visualization (CIS/DSC 468)

Data Visualization (CIS/DSC 468) Data Visualization (CIS/DSC 46) Volume Rendering Dr. David Koop Visualizing Volume (3D) Data 2D visualization slice images (or multi-planar reformating MPR) Indirect 3D visualization isosurfaces (or surface-shaded

More information

CSC Computer Graphics

CSC Computer Graphics // CSC. Computer Graphics Lecture Kasun@dscs.sjp.ac.lk Department of Computer Science University of Sri Jayewardanepura Polygon Filling Scan-Line Polygon Fill Algorithm Span Flood-Fill Algorithm Inside-outside

More information

Cubical Marching Squares: Adaptive Feature Preserving Surface Extraction from Volume Data

Cubical Marching Squares: Adaptive Feature Preserving Surface Extraction from Volume Data EUROGRAPHICS 2005 / M. Alexa and J. Marks (Guest Editors) Volume 24 (2005), Number 3 Cubical Marching Squares: Adaptive Feature Preserving Surface Extraction from Volume Data Chien-Chang Ho Fu-Che Wu Bing-Yu

More information

9. Three Dimensional Object Representations

9. Three Dimensional Object Representations 9. Three Dimensional Object Representations Methods: Polygon and Quadric surfaces: For simple Euclidean objects Spline surfaces and construction: For curved surfaces Procedural methods: Eg. Fractals, Particle

More information

Multiresolution Computation of Conformal Structures of Surfaces

Multiresolution Computation of Conformal Structures of Surfaces Multiresolution Computation of Conformal Structures of Surfaces Xianfeng Gu Yalin Wang Shing-Tung Yau Division of Engineering and Applied Science, Harvard University, Cambridge, MA 0138 Mathematics Department,

More information

Visualization Computer Graphics I Lecture 20

Visualization Computer Graphics I Lecture 20 15-462 Computer Graphics I Lecture 20 Visualization Height Fields and Contours Scalar Fields Volume Rendering Vector Fields [Angel Ch. 12] November 20, 2003 Doug James Carnegie Mellon University http://www.cs.cmu.edu/~djames/15-462/fall03

More information

Volume Visualization

Volume Visualization Volume Visualization Part 1 (out of 3) Overview: Volume Visualization Introduction to volume visualization On volume data Surface vs. volume rendering Overview: Techniques Simple methods Slicing, cuberille

More information

Extracting consistent and manifold interfaces from multi-valued volume data sets

Extracting consistent and manifold interfaces from multi-valued volume data sets Extracting consistent and manifold interfaces from multi-valued volume data sets Stephan Bischoff, Leif Kobbelt Lehrstuhl für Informatik 8, RWTH Aachen, 52056 Aachen Email: {bischoff,kobbelt}@informatik.rwth-aachen.de

More information

Detecting Critical Regions in Scalar Fields

Detecting Critical Regions in Scalar Fields Joint EUROGRAPHICS - IEEE TCVG Symposium on Visualization (2003) G.-P. Bonneau, S. Hahmann, C. D. Hansen (Editors) Detecting Critical Regions in Scalar Fields Gunther H. Weber 1,2 Gerik Scheuermann 1 and

More information

Topological Issues in Hexahedral Meshing

Topological Issues in Hexahedral Meshing Topological Issues in Hexahedral Meshing David Eppstein Univ. of California, Irvine Dept. of Information and Computer Science Outline I. What is meshing? Problem statement Types of mesh Quality issues

More information

Volume Visualization. Part 1 (out of 3) Volume Data. Where do the data come from? 3D Data Space How are volume data organized?

Volume Visualization. Part 1 (out of 3) Volume Data. Where do the data come from? 3D Data Space How are volume data organized? Volume Data Volume Visualization Part 1 (out of 3) Where do the data come from? Medical Application Computed Tomographie (CT) Magnetic Resonance Imaging (MR) Materials testing Industrial-CT Simulation

More information

Animating cuts with on-the-fly re-meshing

Animating cuts with on-the-fly re-meshing EUROGRAPHICS 2001 / Jonathan C. Roberts Short Presentations Animating cuts with on-the-fly re-meshing F. Ganovelli and C. O Sullivan Image Synthesis Group, Computer Science Department, Trinity College

More information

Hierarchical Clustering for Volumetric Scalar Fields. CHRISTOPHER S. CO B.S. (University of California, Davis) 2001 THESIS MASTER OF SCIENCE

Hierarchical Clustering for Volumetric Scalar Fields. CHRISTOPHER S. CO B.S. (University of California, Davis) 2001 THESIS MASTER OF SCIENCE Hierarchical Clustering for Volumetric Scalar Fields By CHRISTOPHER S. CO B.S. (University of California, Davis) 2001 THESIS Submitted in partial satisfaction of the requirements for the degree of MASTER

More information

Surface Reconstruction. Gianpaolo Palma

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

More information

Ray Casting Curved-Quadratic Elements

Ray Casting Curved-Quadratic Elements Joint EUROGRAPHICS - IEEE TCVG Symposium on Visualization (004) O. Deussen, C. Hansen, D.A. Keim, D. Saupe (Editors) Ray Casting Curved-Quadratic Elements D. F. Wiley, 1 H. R. Childs, B. Hamann, 1 and

More information

Surface Topology ReebGraph

Surface Topology ReebGraph Sub-Topics Compute bounding box Compute Euler Characteristic Estimate surface curvature Line description for conveying surface shape Extract skeletal representation of shapes Morse function and surface

More information

What is visualization? Why is it important?

What is visualization? Why is it important? What is visualization? Why is it important? What does visualization do? What is the difference between scientific data and information data Visualization Pipeline Visualization Pipeline Overview Data acquisition

More information

CIS 4930/ SCIENTIFICVISUALIZATION

CIS 4930/ SCIENTIFICVISUALIZATION CIS 4930/6930-902 SCIENTIFICVISUALIZATION ISOSURFACING Paul Rosen Assistant Professor University of South Florida slides credits Tricoche and Meyer ADMINISTRATIVE Read (or watch video): Kieffer et al,

More information

5. Volume Visualization

5. Volume Visualization 5. Volume Visualization Scalar volume data Medical Applications: CT, MRI, confocal microscopy, ultrasound, etc. 1 5. Volume Visualization 2 5. Volume Visualization 3 5. Volume Visualization Some possible

More information

Processing 3D Surface Data

Processing 3D Surface Data Processing 3D Surface Data Computer Animation and Visualisation Lecture 12 Institute for Perception, Action & Behaviour School of Informatics 3D Surfaces 1 3D surface data... where from? Iso-surfacing

More information

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

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

More information

MARCHING CUBES AND VARIANTS

MARCHING CUBES AND VARIANTS CHAPTER MARCHING CUBES AND VARIANTS In the introduction, we mentioned four different approaches to isosurface construction. In this chapter, we describe one of those approaches to isosurface construction,

More information

Structured Grid Generation for Turbo Machinery Applications using Topology Templates

Structured Grid Generation for Turbo Machinery Applications using Topology Templates Structured Grid Generation for Turbo Machinery Applications using Topology Templates January 13th 2011 Martin Spel martin.spel@rtech.fr page 1 Agenda: R.Tech activities Grid Generation Techniques Structured

More information

Marching Squares Algorithm. Can you summarize the marching squares algorithm based on what we just discussed?

Marching Squares Algorithm. Can you summarize the marching squares algorithm based on what we just discussed? Marching Squares Algorithm Can you summarize the marching squares algorithm based on what we just discussed? Marching Squares Algorithm Can you summarize the marching squares algorithm based on what we

More information

PAPER Shrink-Wrapped Isosurface from Cross Sectional Images

PAPER Shrink-Wrapped Isosurface from Cross Sectional Images 2070 PAPER Shrink-Wrapped Isosurface from Cross Sectional Images Young Kyu CHOI a), Member and James K. HAHN b), Nonmember SUMMARY This paper addresses a new surface reconstruction scheme for approximating

More information

Realtime view-dependent isosurface visualization for regular volume data

Realtime view-dependent isosurface visualization for regular volume data Realtime view-dependent isosurface visualization for regular volume data Maxim V. Kazakov Moscow Institute of Physics and Technology Dolgoprudny, Russia Abstract The problem of the interactive visualization

More information

Particle tracing in curvilinear grids. David M. Reed, Lawson Wade, Peter G. Carswell, Wayne E. Carlson

Particle tracing in curvilinear grids. David M. Reed, Lawson Wade, Peter G. Carswell, Wayne E. Carlson Particle tracing in curvilinear grids David M. Reed, Lawson Wade, Peter G. Carswell, Wayne E. Carlson Advanced Computing Center for the Arts and Design and Department of Computer and Information Science

More information

Volume Warping for Adaptive Isosurface Extraction

Volume Warping for Adaptive Isosurface Extraction Volume Warping for Adaptive Isosurface Extraction Laurent Balmelli Λ Christopher Morris Gabriel Taubin Fausto Bernardini IBM Research T.J. Watson Center Hawthorne, NY, USA Figure 1: Adaptive isosurface

More information

Interactive Visualization of Very Large Datasets Using an Out-of-Core Point-based Approach

Interactive Visualization of Very Large Datasets Using an Out-of-Core Point-based Approach Interactive Visualization of Very Large Datasets Using an Out-of-Core Point-based Approach Christof Nuber, Ralph W. Bruckschen, Bernd Hamann and Kenneth I. Joy Center for Image Processing and Integrated

More information

implicit surfaces, approximate implicitization, B-splines, A- patches, surface fitting

implicit surfaces, approximate implicitization, B-splines, A- patches, surface fitting 24. KONFERENCE O GEOMETRII A POČÍTAČOVÉ GRAFICE ZBYNĚK ŠÍR FITTING OF PIECEWISE POLYNOMIAL IMPLICIT SURFACES Abstrakt In our contribution we discuss the possibility of an efficient fitting of piecewise

More information

Hierarchical Iso-Surface Extraction

Hierarchical Iso-Surface Extraction Hierarchical Iso-Surface Extraction Ulf Labsik Kai Hormann Martin Meister Günther Greiner Computer Graphics Group University of Erlangen Multi-Res Modeling Group Caltech Computer Graphics Group University

More information