+ All Categories
Home > Documents > Surface from Scattered Points - cs.jhu.edumisha/Fall13b/Papers/Schall05.pdfbased methods [2, 9, 11,...

Surface from Scattered Points - cs.jhu.edumisha/Fall13b/Papers/Schall05.pdfbased methods [2, 9, 11,...

Date post: 23-Apr-2018
Category:
Upload: doanquynh
View: 214 times
Download: 1 times
Share this document with a friend
10
Surface from Scattered Points A Brief Survey of Recent Developments Oliver Schall Max-Planck-Institut f ¨ ur Informatik [email protected] http://www.mpi-sb.mpg.de/˜schall Marie Samozino INRIA - Sophia Antipolis [email protected] http://www-sop.inria.fr/geometrica/team/Marie.Samozino Abstract The paper delivers a brief overview of recent developments in the field of surface reconstruc- tion from scattered point data. The focus is on computational geometry methods, implicit surface interpolation techniques, and shape learning approaches. Keywords: surface reconstruction, scattered data 1 Introduction In the mid-1980s the problem of surface recon- struction from scattered data was probably first ad- dressed by Boissonnat [17]. Further attraction was lead to surface reconstruction from point cloud data by the research of Hoppe et al. [39]. Since then surface reconstruction became an active re- search field with two main surface reconstruction approaches. One important research direction are Delaunay- based methods [2, 9, 11, 13, 16, 24, 27, 31] which usually involve the computation of a Delaunay complex or of dual structures using the scattered data. The surface is usually reconstructed by ex- traction from the previously computed Delaunay complex. Detailed surveys on computational ge- ometry methods for surface reconstruction can be found in [22, 26]. A short survey is presented in [23]. The second important research direction are vol- umetric methods [14, 20, 56, 66]. Those approx- imate the scattered data by a 3D function. The surface can then be explicitly reconstructed by ex- tracting it as the zero-level set of the computed function. A survey can be found in [53]. Re- cent research trends include Moving Least Squares (MLS) surfaces [1, 4, 5, 12] defined implicitly by the MLS projection operator. Furthermore, different methods like zippering meshes obtained from range images [67] and sta- tistical learning [41, 42, 73] have been developed. Recent research in surface reconstruction from scattered data is also focused on reconstruction from scattered polygonal data [43, 64]. As point cloud data acquired from real world objects us- ing for instance range scanners is always corrupted with noise, the reconstruction from noisy point data was recently addressed in [21, 28, 47, 58] as well as the processing of uncertain data in [12, 59]. Furthermore, point cloud data can be undersam- pled in regions of low visibility for the scanning device. Therefore, the problem of surface re- construction from incomplete data is addressed in [25, 43, 63, 68]. A very comprehensive, yet preliminary, survey of surface reconstruction techniques can be found in [3]. We contribute to [3] by testing several surface reconstruction software tools and revealing their strengths and weaknesses. We also demonstrate that surface reconstruction results can be drastically improved if an appropriate preliminary filtering method [62] is applied to original scattered data. 1
Transcript

Surface from Scattered PointsA Brief Survey of Recent Developments

Oliver SchallMax-Planck-Institut fur Informatik

[email protected]://www.mpi-sb.mpg.de/˜schall

Marie SamozinoINRIA - Sophia Antipolis

[email protected]://www-sop.inria.fr/geometrica/team/Marie.Samozino

AbstractThe paper delivers a brief overview of recentdevelopments in the field of surface reconstruc-tion from scattered point data. The focus is oncomputational geometry methods, implicit surfaceinterpolation techniques, and shape learningapproaches.

Keywords: surface reconstruction, scattereddata

1 IntroductionIn the mid-1980s the problem of surface recon-struction from scattered data was probably first ad-dressed by Boissonnat [17]. Further attraction waslead to surface reconstruction from point clouddata by the research of Hoppe et al. [39]. Sincethen surface reconstruction became an active re-search field with two main surface reconstructionapproaches.

One important research direction are Delaunay-based methods [2, 9, 11, 13, 16, 24, 27, 31] whichusually involve the computation of a Delaunaycomplex or of dual structures using the scattereddata. The surface is usually reconstructed by ex-traction from the previously computed Delaunaycomplex. Detailed surveys on computational ge-ometry methods for surface reconstruction can befound in [22, 26]. A short survey is presentedin [23].

The second important research direction are vol-umetric methods [14, 20, 56, 66]. Those approx-

imate the scattered data by a 3D function. Thesurface can then be explicitly reconstructed by ex-tracting it as the zero-level set of the computedfunction. A survey can be found in [53]. Re-cent research trends include Moving Least Squares(MLS) surfaces [1, 4, 5, 12] defined implicitly bythe MLS projection operator.

Furthermore, different methods like zipperingmeshes obtained from range images [67] and sta-tistical learning [41, 42, 73] have been developed.

Recent research in surface reconstruction fromscattered data is also focused on reconstructionfrom scattered polygonal data [43, 64]. As pointcloud data acquired from real world objects us-ing for instance range scanners is always corruptedwith noise, the reconstruction from noisy pointdata was recently addressed in [21, 28, 47, 58] aswell as the processing of uncertain data in [12,59].Furthermore, point cloud data can be undersam-pled in regions of low visibility for the scanningdevice. Therefore, the problem of surface re-construction from incomplete data is addressedin [25, 43, 63, 68].

A very comprehensive, yet preliminary, surveyof surface reconstruction techniques can befound in [3]. We contribute to [3] by testingseveral surface reconstruction software tools andrevealing their strengths and weaknesses. We alsodemonstrate that surface reconstruction resultscan be drastically improved if an appropriatepreliminary filtering method [62] is applied tooriginal scattered data.

1

The rest of this report is organized as follows. InSection 2 Delaunay-based methods are considered.Section 3 gives an overview of approaches com-puting an implicit surface. Learning-based meth-ods are reviewed in Section 4. Finally, a filteringand denoising method is described in Section 5.

2 Delaunay-based Methods

In this section we are presenting an overviewof Delaunay-based surface reconstruction ap-proaches from scattered data. After reviewingideas and properties of some approved methodswe will present algorithms for the reconstructionof noisy point data being part of the most recentresearch.

Delaunay-based surface reconstruction ap-proaches were mainly developed in the field ofcomputational geometry. These methods arebased on the idea that computing a surface fromscattered point data P demands the exploration ofthe neighborhood of all samples in all directions tofind possible neighbors for every sample point. Asthis is accomplished by the Delaunay triangulationit is predestinated for surface reconstruction. Tofind the final surface some methods computea subset of the Delaunay triangulation. Thosealgorithms are usually referred to as restrictedDelaunay-based methods. Two famous algorithmsfrom this group are the Crust and the Coconealgorithm which will be described in the followingsection.

2.1 Crust & Cocone

The Crust algorithm for surface reconstructionwas designed by Amenta and Bern [7] from theCrust algorithm for curve reconstruction [8]. Thealgorithm works as follows. Assuming we aregiven a point set P sampling an unknown smoothsurface S the Crust algorithm first computes theVoronoi diagram V (P ) of P . Then it determinesthe set of poles Q of the Voronoi diagram.

Let Vp be the Voronoi cell of the sample pointp in the Voronoi diagram. Then the positive polep+ is defined as the farthest Voronoi vertex of Vp

from p. The pole vector np is defined as the vec-tor pointing from the sample point p to p+. Thepole vector is a good approximation for the sur-face normal at p. The negative pole p− is definedas the Voronoi vertex of Vp farthest from p in theopposite direction of the positive pole meaning thevector from p to p− and the pole vector np enclosean angle of more than π

2(see left image of Figure

2). The poles provide a good approximation forthe medial axis of the surface sampled by P .

Figure 1: 2D example of the Delaunay triangu-lation D(P ∪ Q) of the sample pointsP (black) and their Voronoi poles Q(white). The Crust is indicated by solidlines.

After this the Crust algorithm computes the De-launay triangulation D(P ∪Q). To extract the can-didate triangles of the surface that should be re-constructed from the computed Delaunay triangu-lation, the algorithm discards all triangles havingnot all vertices in P . The idea behind choosingthe surface as a restriction of the Delaunay com-plex D(P ∪ Q) is that all triangles crossing themedial axis of the sampled surface S are removed(see Figure 1). The candidate triangles form ingeneral not the resulting surface but they containa surface that is homeomorphic to S if the sam-pling P is dense enough. Therefore, a manifoldextraction stage is applied to find the final surfacecalled the Crust.

The Crust algorithm was one of the first surfacereconstruction methods that could provide guar-antees. Amenta and Bern showed using a resultof Edelsbrunner and Shah [32] that if P is an ε-sample for ε ≤ 0.06 then it is guaranteed that thecandidate triangles contain the restricted Delaunaytriangulation DS(P ) which is the Delaunay trian-gulation D(P ) restricted to the sampled surface S.Although it is impossible to detect the triangles ofDS(P ) in the set of candidate triangles withoutknowing S this information is used in the mani-fold extraction step to compute an approximationof S.

The Crust algorithm demands the computationof two Delaunay triangulations being D(P ) andD(P ∪ Q) determining the runtime and memorycomplexity being O(||P ∪ Q||2).

The Cocone algorithm was developed byAmenta, Choi, Dey and Leekha [10] from theCrust algorithm. It computes similar to the Crustalgorithm a set of candidate triangles containingthe restricted Delaunay triangulation DS(P ) if thegiven sampling is dense enough. This is done by

2

p−

p+

SS p

p

np

Vp

Figure 2: Left: Voronoi cell Vp of sample p inter-secting surface S. The positive pole p+,the pole vector np and the negative polep− are illustrated. Right: Cocone illus-tration. Adapted from [26].

first computing the Voronoi diagram V (P ) to findthe pole vectors for every sample point. Then a co-cone Cp for every sample point p is defined as thecomplement of the double cone with the apex at p,the pole vector np as axis and an opening angle of3π4

. The cocone Cp is clipped inside the Voronoicell Vp. As the pole vector np approximates thesurface normal at p the cocone determines a neigh-borhood around the tangent plane at p (see rightimage of Figure 2). After this the algorithm detectsall Voronoi edges in Vp being intersected by the co-cone Cp for every point p. The dual Delaunay tri-angles then build the candidate triangle set. Afterthe whole candidate triangle set is determined themanifold extraction is performed to find the result-ing surface. The cocone has the same guaranteeslike the Crust algorithm. It is proven that the re-stricted Delaunay triangulation DS(P ) is part ofthe candidate triangle set if P is an ε-sample withε ≤ 0.06.

The Cocone algorithm demands in contrastto the Crust algorithm only the computation ofthe Delaunay triangulation D(P ). Thus theruntime and memory complexity is reduced toO(||D(P )||2).

Important extensions of the presented methodsare algorithms that produce watertight surfaces.These methods belong usually to the class of in-side/outside labeling algorithms. They first com-pute a Delaunay triangulation of the scattered data.Then the resulting tetrahedra are labeled inside oroutside depending whether the tetrahedron is in-side the solid bounded by the scattered data or out-side. After all tetrahedra are labeled the resulting

Figure 3: Power Crust (top) and Tight Cocone(bottom) reconstructions of the Dragonusing samples from the VRIP files takenfrom the Stanford Scanning Repository.

surface can be extracted by retaining only trianglesthat are shared by one inside and one outside tetra-hedron. As there is no remaining path from theinside of the bounded solid to the outside not pass-ing a retained triangle the resulting mesh is wa-tertight. Two important methods generating wa-tertight reconstructions are Power Crust developedby Amenta, Choi and Kolluri [11] and Tight Co-cone of Dey and Goswami [27]. Reconstructionsof both algorithms are illustrated in Figure 3.

2.2 Recent DevelopmentsThe presented computational geometry methodsare supported by rigorous mathematical results andprovide guarantees under the presented conditions.Unfortunately, the precondition that P is an ε-sampling with small ε does not often hold in prac-tice. Therefore, computational geometry methodsface difficulties while dealing with noisy data andundersampling (see top row of Figure 6). To over-come these problems recent research is focused onthis area.

Dey and Goswami [28] present the Robust Co-cone algorithm which applies an observation used

3

in the Power Crust algorithm. It was observedthat the polar balls (balls surrounding the polesand touching the nearest samples) approximate thesolid bounded by the sampled surface. If the ballsof adjacent tetrahedra intersect deeply both tetra-hedra belong to the same component being eitherinside or outside. On the other hand if balls in-tersect shallowly they belong to different compo-nents. Dey and Goswami showed that this mightnot be true for noisy regions. They also show thatthe polar balls in these regions have a small radiusand can thus be detected. Robust Cocone only pre-serves the samples on the outer Delaunay balls andreconstructs a watertight surface only using them.

Kolluri et al. [47] introduce the Eigen Crustalgorithm. The method computes a watertightsurface reconstruction from noisy scattered datawith outliers using spectral graph partitioning. Tocompute the surface the idea is again to labeleach tetrahedron of the Delaunay triangulation (orequivalently each Voronoi vertex) inside or out-side. The Eigen Crust algorithm labels the Voronoivertices in two steps. The first stage constructs apole graph, whose nodes represent the poles. Theedges of the pole graph are weighted according tothe likelihood that pairs of tetrahedra are on thesame side of the surface. This weighted graph isrepresented by the pole matrix. Finally, the small-est eigenvalue of the pole matrix is computed to di-vide the graph in two subgraphs containing insideand outside poles. To label also tetrahedra that arenot duals of poles the Eigen Crust algorithm buildsa second graph from the Voronoi vertices that arenot poles. As the labeling of the non-pole verticesis more ambiguous the algorithm classifies them inorder to produce a smooth surface with low genus.

3 Implicit Surface Interpolation

Given a set of points X = xi ⊂ IR3 scat-tered over a surface, the main idea behind most ofthe implicit surface interpolation techniques con-sists of building a function y = f(x) whose zerolevel set Z(f) = x : f(x) = 0 approxi-mates / interpolates X . Usually y = f(x) is con-structed as a composition (weighted sum) of sim-ple primitives.

3.1 Radial Basis Functions (RBF)

Radial Basis Function (RBF) techniques are nowstandard tools for geometric data analysis [33,53] in pattern recognition [44], statistical learn-ing [36], and neural networks [37]. Properties ofRBFs are widely studied in mathematical litera-ture [18, 30, 40, 71]. (See also references therein.)

Given a scattered point dataset, we interpolateor approximate it by the zero level-set of a com-posite function f : IR3 → IR defined as a linearcombination of relatively simple primitives

f(x) =m∑

i=1

αiΦ(x, ci) (1)

where Φ(., ci) : IR3 → IR are functions centeredat ci and αi are the unknown weights [35].

We want to constrain the solution to be stableto translation and rotation of the point set. Thefunctions Φ are thus given by:

Φ(x, ci) = φ(‖x − ci‖), (2)

where ‖.‖ denotes the Euclidian distance and φ :IR+ → IR.

Relations between the RBF and varia-tional approaches to scattered data interpola-tion / approximation are analyzed in [30, 37].

Reconstruction using Radial Basis Functionsgives a smooth implicit interpolating or approxi-mating surface, since both the implicit solution andits zero level set have the same continuity proper-ties as the ones of the basis functions Φ.

Let F = fi be a set of n values of a function fat some scattered distinct points X = xi ∈ IR3.We want to find a function f : IR3 → IR such that∀i = j, . . . , n

f(xj) =

m∑

i=1

αiφ(‖xj − ci‖) = fj (3)

The reconstruction problem thus boils down to de-termining the vector α = α1, . . . , αn by solv-ing a linear system of equations given by the con-straints (3). Since all constraints are located on thesurface, all fis are valued zero. In order to avoidthe trivial solution α =

−→0 , we add interior and

exterior constraints where the function is non zeroand assign them the values −d and d, respectively.We compute the weights α = [αi] using (3), anddenoting [φ(‖xi−xj‖)] = AX,Φ, we have to solvethe following linear system:

AX,Φ · α = F. (4)

In order to obtain a unique solution the matrixAX,Φ is required to be invertible, at least onthe subspace of ~α vectors where the solution issearched. A common solution is to use the sub-space such as:

∀α ∈ IRn

n∑

i=1

αip(xi) = 0 ∀p ∈ IPq

(5)

4

where IPq is the set of polynomials of order up toq. With this condition, the functions φ are condi-tionally positive definite [18]. Furthermore, to re-cover the right number of variables and unknowns,a polynomial p ∈ IPq will be added to (1)

f(x) =

m∑

i=1

αiΦ(x, ci) + p(x) (6)

Some conventional radial basis functions are:φ : IR+ → IR

biharmonic RBF φ(r) = r with a linear polyno-mial

pseudo-cubic RBF φ(r) = r3 with a linear poly-nomial

triharmonic RBF φ(r) = r3 with a quadraticpolynomial

thin plate RBF φ(r) = r2 log(r) with a linearpolynomial

All functions listed above have an unboundedsupport. The corresponding equations lead to adense linear system, therefore recovering a solu-tion is tractable only for small data sets. To over-come this problem Morse et al. [55] use Gaus-sian as Compactly Supported RBFs to obtain asparse interpolation matrix. More generally, a lotof other Compactly Supported RBFs (CSRBF) canbe used for reconstruction as proposed in [69, 72]but they are not well-suited for reconstruction fromincomplete data. To handle large and incom-plete data sets two strategies have been proposed.One approach uses polyharmonic RBF (i.e. non-compactly supported functions) [19], reduces thenumber of centers by a greedy selection procedureand performs fast evaluation using the so-calledFast Multipole Method (FMM). Another approachconsists of using locally supported functions [65],where the partition of unity is used for blending,and the function support is computed locally forall centers, as described in [58]. A multiresolutionversion of this approach has been proposed in [57].

We can notice that radially symmetric functionsare not suited for piecewise smooth surface recon-struction. Dinh et al. [29] have presented a methodusing anisotropic basis functions to overcome thisissue.

3.2 Partition of Unity (PU)”Divide and conquer” is the main idea behind thePartition of Unity approach. The main idea con-sists of breaking the domain into smaller subdo-mains where the problem can be solved locally.The data is first approximated on each subdomain

separately, and the local solutions are blent to-gether using a weighted sum of local subdomainapproximations. The weights are smooth functionsand sum up to one everywhere on the domain.

Tobor et al. [65] combine the Partition of Unitymethod and the radial basis functions. Ohtake etal. [56] use weighted sums of different kinds ofpiecewise quadratic functions in order to capturethe local shape of the surface. This way implicitsurfaces from very large scattered point sets canbe reconstructed.

Consider a global bounded domain Ω in an Eu-clidian space. Divide Ω into M mildly overlap-ping subdomains Ωii=1,...,M with Ω ⊆ ∪iΩi.”Mildly overlapping” herein means that the in-tersection of two incident subdomains contains atmost one data point. Together with this coveringwe construct a Partition of Unity, i.e. a familyof non-negative continuous compactly supportedfunctions wii=1,...,M such that Supp(wi) ⊆ Ωi

and∑M

i=1wi = 1 everywhere. Let X = xi ∈

IR3 be a set of n points on the surface. For eachcell Ωi, a set Xi = x ∈ X/x ∈ Ωi is built, andthe surface is approximated on each subdomain bya local approximant fi. The global function is thendefined as a combination of the local functions as:

f(x) =

n∑

i=1

wi(x)fi(x). (7)

The condition∑M

i=1wi = 1 can be obtained from

any other set of smooth functions Wi by a normal-ization process:

wi(x) =Wi(x)∑n

j=1Wj(x)

. (8)

The weighting function Wi determines the con-tinuity of the global reconstruction function f . Wecan generate these functions using local geometryof the corresponding cell (distance function, centerand radius of cell, etc.).

For domain decomposition, in general, spacesubdivision based trees are proposed (binary trees,octrees, etc.). The cells can have different shapessuch as as axis-aligned bounding boxes, balls oraxis-aligned ellipsoids. The degree of subdivisioncan be adapted to both local sample density anddesired smoothness. The choice of the local fittingmethod is another degree of freedom: Radial BasisFunctions are used in [65, 70], while quadrics areused in [56]. Furthermore, one can adapt the fit-ting strategy for each cell according to the numberof points and distribution of associated normals.Reconstructing sharp features is this way possibleas described in [56].

An interesting combination of the RBF and PUapproaches was recently proposed in [58] where a

5

Figure 4: RBF+PU reconstruction of the StanfordHappy Buddha model from its originalregistered scans.

partition of unity is used to obtain an initial roughapproximation of given scattered data and thenRBFs are used to refine the PU approximation. Anexample of such PU+RBF reconstruction is shownin Figure 4.

3.3 Moving Least Squares (MLS)Moving-least squares (MLS) surfaces have beenintroduced by Levin [48, 49]. The work of Alexaet al. [4, 5] first used MLS surfaces in point-basedgraphics. MLS surfaces are defined by a projec-tion operator which projects points from a tubularneighborhood onto the surface. The neighborhoodis usually defined by a union of balls centered atthe input points pi. The traditional projection op-erator is computational expensive because of anassociated non-linear optimization problem. A de-tailed survey of point-based techniques includinga short description of the traditional projection op-erator can be found in [45].

Adamson and Alexa [1] propose a simpler pro-jection technique for the definition of an im-plicit surface from point cloud data. They itera-tively project a point x onto a plane defined by aweighted average of neighboring points

a(x) =

∑j Φ(||x − pj ||)pj∑

j Φ(||x − pj ||)

and the normal n(x). If normals nj for inputpoints are given n(x) can be computed by aver-

aging the input normals

n(x) =

∑j Φ(||x − pj ||)nj

||∑

j Φ(||x − pj ||)nj ||,

otherwise n(x) is determined by the normal of theweighted least-squares fitting plane of the pointspj . After convergence the point x reaches a posi-tion on the MLS surface.

Recent work of Amenta and Kil [12] analysesthe stability of the original projection operator forpoints that are not sufficiently close to the MLSsurface. Furthermore, they present an explicit defi-nition of MLS surfaces in terms of critical points ofthe energy function EMLS along lines determinedby a vector field.

4 Learning-based MethodsLearning-based methods used in surface recon-struction have their origin in the work of Kohonen[46] where Self-Organizing Maps (SOMs) wereintroduced. Later Fritzke [34] defined a special-ized class of SOMs called the Growing Cell Struc-tures (GCSs). Both neural networks have beenused for surface reconstruction. Barhak and Fis-cher [15] use SOMs for grid fitting. GCSs are ap-plied by Hoffmann and Varady [38] to free-fromsurface reconstruction. Yu [73] uses SOMs for sur-face reconstruction from scattered data. In this re-port we will focus on recent publications by Ivris-simtzis et al. [41, 42] using GCSs for the recon-struction of point cloud data.

The Growing Cell Structure presented by Ivris-simtzis et al. is an incrementally expanding neu-ral network with triangle mesh connectivity (neu-ral mesh) growing by splitting and removing ver-tices depending on their activity. The idea of thealgorithm is to randomly sample the given inputpoint set P and to use these samples as a trainingset for the initial neural mesh which is usually cho-sen as a tetrahedron. By processing samples theneural mesh M learns the geometry and the topol-ogy of the surface represented by the input pointset. Geometry learning is accomplished by ran-domly choosing a sample s ∈ P and moving thenearest vertex v ∈ M towards s. After each up-date the 1-ring neighborhood of v is smoothed. Toimprove the connectivity and to allow growing ofM the algorithm can introduce new vertices to theneural mesh by splitting the most active vertex aswell as removing the least active vertex. The activ-ity of all vertices is measured by a signal counter.The counter of the nearest vertex v to the samples is increased by one to assign v a higher activ-ity value. The signal counter of all other verticesis multiplied with a positive number α < 1 to re-

6

Figure 5: Neural mesh reconstruction (500K ver-tices) of the Atlas model with samplesobtained from VRIP files in the DigitalMichelangelo Archive [50].

move gradually the effect of old activity. Topol-ogy learning is achieved by triangle removal andboundary merging to allow the adaptation of Mto boundaries and handles. As the growing of theneural mesh depends on the sampling density of Plarge triangles occur in regions of M approximat-ing parts of the surface with a low sampling den-sity. When the sampling density becomes insignif-icant such that the area of the corresponding trian-gles is over a defined threshold, they are removedand a boundary is created. If two boundaries arenear to each other measured with an approxima-tion of the Hausdorff distance the two boundariesare merged to create a handle.

The latest works of Ivrissimtzis et al. focus onthe improvement of topological learning. One ideaof [42] is to create an ensemble of neural meshes.An ensemble is a set of neural meshes with a com-bined output which has a smaller statistical errorthan any of its elements. To create a combinedneural mesh from meshes with different connec-tivity a volumetric method is used.

Due to the sampling-based reconstruction thepresented algorithm is able to process large data(see Figure 5). Furthermore, learning-based meth-ods are well-suited for the reconstruction of noisydata. One drawback of the reviewed method is the

reconstruction time complexity depending on thenumber of vertices of the neural mesh.

5 Filtering and DenoisingThe performance of surface reconstruction ap-proaches is usually reduced if the input data isnoisy. One approach to overcome this problem isto filter and denoise the input before it is used forsurface reconstruction [52, 54, 62].

Schall et al. [62] propose a method for deal-ing with uncertain and noisy surface scattereddata. Given a set of noisy input points P =p1, . . . ,pN the method computes for every in-put point pi a local uncertainty function measur-ing the contribution of pi to the smooth surfaceS which is supposed to be reconstructed. The lo-cal functions are composed to a global uncertaintyfunction whose local minima are determined. Thecomputed minima are approximation centers of thesampled surface S and form a sparse set of pointswhich are used as vertices of a mesh. The meshcan be reconstructed using an arbitrary meshingtechnique. The presented method robustly pro-duces accurate smooth meshes with minimal topo-logical noise. The top images of Figure 6 showreconstructions of the Stanford Bunny model fromits original scans using Power Crust (left) andTight Cocone (right). The bottom row of Figure 6demonstrates reconstruction results created usingthe same Power Crust and Tight Cocone methodsfrom the approximation centers generated accord-ing to [62].

6 Discussion and ConclusionIn this survey we presented several surface recon-struction methods. These methods are mainly ei-ther Delaunay-based and use a subset of a com-puted Delaunay complex to reconstruct the surfaceor represent the surface implicitly by the zero-levelset of a defined function. Other techniques arelearning-based or filter and denoise the input data.

The area of surface reconstruction is still a fieldwith many open problems and research directions.Recent research trends focus on reconstruction ofscattered polygonal data and noisy point clouddata. Furthermore, other methods avoid surface re-construction but visualize the surface representedby the point cloud data directly by for instance ray-tracing Point Set Surfaces or using surface splat-ting techniques.

One of the recent approaches to processing scat-tered 3D point data consists of using point-basedrendering primitives, as first suggested by Levoyand Whitted [51]. Efficient implementations of the

7

Figure 6: Reconstructions of the Stanford Bunnyusing Power Crust (left) and Tight Co-cone (right) directly from the range scans(top row) and from the approximationcenters (bottom row).

approach were presented in [60, 61] and in manysubsequent works (see Figure 7). See the recentsurveys [6, 45].

AcknowledgementsWe would like to thank Tamal Dey, Nina Amentaand Szymon Rusinkiewicz for making their soft-ware available. Furthermore, we thank YutakaOhtake for providing us his software and IoannisIvrissimtzis for images from his papers. We aregrateful to the anonymous reviewers of this paperfor their constructive comments and useful sug-gestions. The Atlas and St. Matthew datasets arecourtesy of the Digital Michelangelo Project. TheBunny, Dragon and Buddha datasets are courtesyof the Stanford 3D scanning repository. This re-search was supported in part by the European FP6NoE grant 506766 (AIM@SHAPE).

References[1] A. Adamson and M. Alexa. Approximating and

intersecting surfaces from points. Symposium onGeometry Processing 2003, pages 245–254, 2003.

[2] U. Adamy, J. Giesen, and M. John. Surface re-construction using umbrella filters. ComputationalGeometry, 21(1-2):63–86, 2002.

[3] Aim@Shape. Survey acquisition and reconstruc-tion. Technical report, 2004.

[4] M. Alexa, J. Behr, D. Cohen-Or, S. Fleishman,D. Levin, and C. T. Silva. Computing and ren-

Figure 7: QSplat rendering of the St. Matthewmodel.

dering point set surfaces. IEEE TVCG, 9(1):3–15,2003.

[5] M. Alexa, J. Behr, D. Cohen-Or, S. Fleishman, andC. T. Silva. Point set surfaces. IEEE Visualization2001, pages 21–28, October 2001.

[6] M. Alexa, M. Gross, M. Pauly, H. Pfister, M. Stam-minger, and M. Zwicker. Point-Based Com-puter Graphics. SIGGRAPH’04 Course Notes #6,SIGGRAPH-ACM publication, 2004.

[7] N. Amenta and M. Bern. Surface reconstruction byvoronoi filtering. Discr. Comput. Geom., 22:481–504, 1999.

[8] N. Amenta, M. Bern, and D. Eppstein. The crustand the β-skeleton: combinatorial curve recon-struction. Graphical Models and Image Process-ing, 60:125–135, 1998.

[9] N. Amenta, M. Bern, and M. Kamvysselis. A newVoronoi-based surface reconstruction algorithm.In Proceedings of ACM SIGGRAPH 1998, pages415–421, 1998.

[10] N. Amenta, S. Choi, T. K. Dey, and N. Leekha.A simple algorithm for homeomorphic surface re-construction. Internat. J. Comput. Geom. & Appl.,12:125–141, 2002.

[11] N. Amenta, S. Choi, and R. Kolluri. The powercrust. In Proceedings of 6th ACM Symposium onSolid Modeling, pages 249–260, 2001.

[12] N. Amenta and Y. J. Kil. Defining point-set sur-faces. ACM Transactions on Graphics, 23(3):264–270, August 2004. Proceedings of SIGGRAPH2004.

[13] M. Attene and M. Spagnuolo. Automatic surfacereconstruction from point sets in space. ComputerGraphics Forum, 19(3):457–465, 2000. Proceed-ings of EUROGRAPHICS 2000.

8

[14] C. L. Bajaj, F. Bernardini, and G. Xu. Automaticreconstruction of surfaces and scalar fields from3D scans. In Proceedings of ACM SIGGRAPH 95,pages 109–118, August 1995.

[15] J. Barhak and A. Fischer. Adaptive reconstructionof freeform objects with 3D SOM neural networkgrids. In Pacific Graphics 01, Conference Pro-ceedings, pages 97–105, 2001.

[16] F. Bernardini, J. Mittleman, H. Rushmeier,C. Silva, and G. Taubin. The ball-pivoting al-gorithm for surface reconstruction. IEEE Trans-actions on Visualization and Computer Graphics,5(4):349–359, 1999.

[17] J.-D. Boissonnat. Geometric structures for three-dimensional shape representation. ACM Transac-tions on Graphics, 3(4):266–286, October 1984.

[18] M. D. Buhman. Radial basis functions: theory andimplementations, volume 12. Cambridge mono-graphs on applied and computational mathematicsedition, 2003.

[19] J. Carr, W. Fright, and R. Beatson. Surface in-terpolation with radial basis functions for medicalimaging. IEEE Transactions Med. Imag., 16(1),1997.

[20] J. C. Carr, R. K. Beatson, J. B. Cherrie, T. J.Mitchell, W. R. Fright, B. C. McCallum, and T. R.Evans. Reconstruction and representation of 3Dobjects with radial basis functions. In Proceedingsof ACM SIGGRAPH 2001, pages 67–76, August2001.

[21] J. C. Carr, R. K. Beatson, B. C. McCallum, W. R.Fright, T. J. McLennan, and T. J. Mitchell. Re-construction and representation of 3D objects withradial basis functions. In Proceedings of ACMGRAPHITE 2003, pages 119–126, Melbourne,Australia, February 2003.

[22] F. Cazals and J. Giesen. Delaunay triangula-tion based surface reconstruction: Ideas and algo-rithms. Technical report, INRIA, November 2004.Rapport de recherche 5393.

[23] F. Cazals, J. Giesen, and M. Yvinec. Delaunaytriangulation based surface reconstruction: a shortsurvey. Technical report, INRIA, November 2004.Rapport de recherche 5394.

[24] D. Cohen-Steiner and F. Da. A greedy Delaunay-based surface reconstruction algorithm. Techni-cal report, INRIA, September 2002. Rapport derecherche 4564.

[25] J. Davis, S. R. Marschner, M. Garr, and M. Levoy.Filling holes in complex surfaces using volumetricdiffusion. In First International Symposium on 3DData Processing, Visualization, and Transmission,Padua, Italy, June 2002.

[26] T. K. Dey. Curve and surface reconstruction. CRCPress, 2nd edition, 2004.

[27] T. K. Dey and S. Goswami. Tight cocone: A water-tight surface reconstructor. In Proc. 8th ACM Sym-pos. Solid Modeling Applications, pages 127–134,2003.

[28] T. K. Dey and S. Goswami. Provable surface re-construction from noisy samples. In Proc. 20thACM Sympos. Comput. Geom., 2004.

[29] H. Q. Dinh, G. Turk, and G. Slabaugh. Re-constructing surfaces using anisotropic basis func-tions. In International Conference on ComputerVision (ICCV) 2001, volume 2, pages 606–613,2001.

[30] J. Duchon. Spline minimizing rotation-invariantsemi-norms in Sobolev spaces. In W. Schempp andK. Zeller, editors, Constructive Theory of Func-tions of Several Variables, volume 571 of LectureNotes in Mathematics, pages 85–100, 1977.

[31] H. Edelsbrunner and E. Mucke. Three-dimensional alpha shapes. ACM Transactions onGraphics, 13(1):43–72, January 1994.

[32] H. Edelsbrunner and N. Shah. Triangulating topo-logical spaces. Internat. J. Comput. Geom. &Appl., 7:365–378, 1997.

[33] R. Franke and G. Nielson. Smooth interpola-tion of large sets of scattered data. InternationalJournal for Numerical Methods in Engineering,15(11):1691–1704, 1980.

[34] B. Fritzke. Growing cell structures - a self-organizing network for unsupervised and super-vised learning. Technical Report ICSTR-93-026,International Computer Science Institute, Berke-ley, 1993.

[35] F. Girosi, M. Jones, and T. Poggio. Priors stabi-lizers and basis functions: From regularization toradial, tensor and additive splines. Technical Re-port AIM-1430, 1993.

[36] H. Hastie, R. Tibshirani, and J. H. Friedman. TheElements of Statistical Learning. Springer, 2001.

[37] S. Haykin. Neural Networks: A ComprehensiveFoundation. Prentice Hall, New Jersey, USA,1999.

[38] M. Hoffmann and L. Varady. Free-form model-ing surfaces for scattered data by neural networks.Journal for Geometry and Graphics, 1:1–6, 1998.

[39] H. Hoppe, T. DeRose, T. Duchamp, J. McDon-ald, and W. Stuetzle. Surface reconstruction fromunorganized points. In Proceedings of ACM SIG-GRAPH 1992, pages 71–78, 1992.

[40] A. Iske. Multiresolution Methods in ScatteredData Modelling. Springer-Verlag, Heidelberg,Germany, 2004.

[41] I. Ivrissimtzis, W.-K. Jeong, and H.-P. Seidel. Us-ing growing cell structures for surface reconstruc-tion. In Shape Modeling International 2003, pages78–86, 2003.

[42] I. Ivrissimtzis, Y. Lee, S. Lee, W.-K. Jeong, andH.-P. Seidel. Neural mesh ensembles. In Y. Aloi-monos and G. Taubin, editors, 3DPTV 2004, LosAlamitos, USA, 2004. IEEE.

[43] T. Ju. Robust repair of polygonal models. ACMTransactions on Graphics, 23(3), August 2004.Proceedings of SIGGRAPH 2004.

9

[44] M. Kirby. Geometric Data Analysis. John Wiley& Sons, 2001.

[45] L. Kobbelt and M. Botsch. A survey of point-basedtechniques in computer graphics. Computers &Graphics, 28(4):801–814, 2004.

[46] T. Kohonen. Self-organized formation of topolog-ically correct feature maps. In Biological Cyber-netics 43, pages 59–69, 1982.

[47] R. Kolluri, J. R. Shewchuk, and J. F. O’Brien.Spectral surface reconstruction from noisy pointclouds. In Symposium on Geometry Processing,pages 11–21. ACM Press, July 2004.

[48] D. Levin. The approximation power of mov-ing least-squares. Math. Comput., 67(224):1517–1531, 1998.

[49] D. Levin. Geometric Modeling for Scientific Visu-alization, chapter Mesh-independent surface inter-polation, pages 37–49. Springer-Verlag, 2003.

[50] M. Levoy, K. Pulli, B. Curless, S. Rusinkiewicz,D. Koller, L. Pereira, M. Ginzton, S. Anderson,J. Davis, J. Ginsberg, J. Shade, and D. Fulk.The Digital Michelangelo Project: 3D scanning oflarge statues. In Proceedings of ACM SIGGRAPH2000, pages 131–144, July 2000.

[51] M. Levoy and M. Whitted. The use of points as adisplay primitive. Technical Report 85-022, Com-puter Science Department, University of NorthCarolina at Chapel Hill, January 1985.

[52] L. Linsen. Point cloud representation. Technicalreport, Fakultat fur Informatik, Universitat Karl-sruhe, 2001. 2001-3.

[53] S. K. Lodha and R. Franke. Scattered data tech-niques for surfaces. In Dagstuhl ’97, Scientific Vi-sualization, pages 181–222. IEEE Computer Soci-ety, 1999.

[54] B. Mederos, L. Velho, and L. H. de Figueiredo.Smooth surface reconstruction from noisy clouds.Journal of the Brazilian Computing Society, 2004.

[55] B. S. Morse, T. S. Yoo, D. T. Chen, P. Rhein-gans, and K. R. Subramanian. Interpolating im-plicit surfaces from scattered surface data usingcompactly supported radial basis functions. In SMI’01: Proceedings of the International Conferenceon Shape Modeling & Applications, pages 89–98.IEEE Computer Society, 2001.

[56] Y. Ohtake, A. Belyaev, M. Alexa, G. Turk, and H.-P. Seidel. Multi-level partition of unity implicits.ACM Transactions on Graphics, 22(3):463–470,July 2003. Proceedings of SIGGRAPH 2003.

[57] Y. Ohtake, A. G. Belyaev, and H.-P. Seidel. Amulti-scale approach to 3D scattered data interpo-lation with compactly supported basis functions.In Shape Modeling International 2003, pages 153–161, Seoul, Korea, May 2003.

[58] Y. Ohtake, A. G. Belyaev, and H.-P. Seidel. 3Dscattered data approximation with adaptive com-pactly supported radial basis functions. In ShapeModeling International 2004, Genova, Italy, June2004.

[59] M. Pauly, N. J. Mitra, and L. J. Guibas. Uncer-tainty and variability in point cloud surface data. InEurographics Symposium on Point-Based Graph-ics, pages 77–84, Zurich, Switzerland, June 2004.

[60] H. Pfister, M. Zwicker, J. van Baar, and M. Gross.Surfels: Surface elements as rendering primitives.In Proceedings of ACM SIGGRAPH 2000, pages335–342, July 2000.

[61] S. Rusinkiewicz and M. Levoy. QSplat: a multires-olution point rendering system for large meshes.In Proceedings of ACM SIGGRAPH 2000, pages343–352, 2000.

[62] O. Schall, A. G. Belyaev, and H.-P. Seidel. Sparsemeshing of uncertain and noisy surface scattereddata. Research Report MPI-I-2005-4-002, Max-Planck-Institut fur Informatik, February 2005.

[63] A. Sharf, M. Alexa, and D. Cohen-Or. Context-based surface completion. ACM Transactions onGraphics, 23(3):878–887, August 2004. Proceed-ings of SIGGRAPH 2004.

[64] C. Shen, G. F. O’Brien, and J. R. Shewchuk. Inter-polating and approximating implicit surfaces frompolygon soup. ACM Transactions on Graphics,23(3), August 2004. Proceedings of SIGGRAPH2004.

[65] I. Tobor, P. Reuter, and C. Schilck. Efficient re-construction of large scattered geometric datasetsusing the partition of unity and radial basis func-tions. Journal of WSCG 2004, 12:467–474, 2004.

[66] G. Turk, H. Q. Dinh, J. O’Brien, and G. Yngve.Implicit surfaces that interpolate. In Shape Mod-elling International 2001, pages 62–71, Genova,Italy, May 2001.

[67] G. Turk and M. Levoy. Zippered polygon meshesfrom range images. In Proceedings of ACM SIG-GRAPH 1994, pages 311–318, July 1994.

[68] J. Verdera, V. Caselles, M. Bertalmıo, andG. Sapiro. Inpainting surface holes. In IEEE Inter-national Conference on Image Processing (ICIP2003), Barcelona, Spain, September 2003.

[69] H. Wendland. Piecewise polynomial, positivedefinite and compactly supported radial functionsof minimal degree. Advances in ComputationalMathematics, 4:389–396, 1995.

[70] H. Wendland. Fast evaluation of radial basis func-tions: Methods based on partition of unity. Ap-proximation Theory X: Wavelets, Splines, and Ap-plications, pages 473–483, 2002.

[71] H. Wendland. Scattered Data Approximation.Cambridge Monographs on Applied and Compu-tational Mathematics (No. 17). Cambridge Univer-sity Press, 2004.

[72] Z. Wu. Compactly supported positive definite ra-dial functions. Advances in Computational Math-ematics, 4:283–292, 1995.

[73] Y. Yu. Surface reconstruction from unorganizedpoints using self-organizing neural networks. InProc. of IEEE Visualization ’99, pages 61–64,1999.

10


Recommended