Acessibilidade / Reportar erro

Smooth surface reconstruction from noisy clouds

Abstract

We describe a new method for surface reconstruction and smoothing based on unorganized noisy point clouds without normals. The output of the method is a refined triangular mesh that approximates the original point cloud while preserving the salient features of the underlying surface. The method has five steps: noise removal, clustering, data reduction, initial reconstruction, and mesh refinement. We also present theoretical justifications for the heuristics used in the reconstruction step.


Smooth surface reconstruction from noisy clouds

Boris Mederos; Luiz Velho; Luiz Henrique de Figueiredo

IMPA-Instituto de Matemática Pura e Aplicada, Estrada Dona Castorina 110, 22461-320 Rio de Janeiro, RJ, Brazil boris@impa.br, lvelho@impa.br, lhf@impa.br

ABSTRACT

We describe a new method for surface reconstruction and smoothing based on unorganized noisy point clouds without normals. The output of the method is a refined triangular mesh that approximates the original point cloud while preserving the salient features of the underlying surface. The method has five steps: noise removal, clustering, data reduction, initial reconstruction, and mesh refinement. We also present theoretical justifications for the heuristics used in the reconstruction step.

1 Introduction

We consider the problem of surface reconstruction and approximation from noisy scattered data points. Several algorithms are known for this important problem when the data are noise-free [1, 2, 3, 4, 6, 7, 5, 14, 11, 12, 8], including a number of recent algorithms with theoretical guarantees [1, 2, 3, 4, 6]. Those algorithms use a 3D Delaunay triangulation of the original point cloud to compute a triangular surface mesh. Computing the Delaunay triangulation can be slow for large point clouds and susceptible to numerical errors.

Gopi et al. [12] proposed an algorithm based on differential geometry that projects the neighborhood of each sample point on a tangent plane, computes the 2D Delaunay triangulation of this projected neighborhood, and lifts it to 3D.

Hoppe et al. [14] estimate a tangent plane at each sample point using its k-nearest neighbors and use the distance to the plane of the nearest sample as an estimative of the signed distance function to the surface. The zero set of this distance function is extracted using the marching cubes algorithm. This approach behaves well with noisy data.

Other algorithms [6, 5, 8] use a greedy approach. The ball pivoting algorithm [5] rolls a ball over the sample points; it requires the normal to the surface at each sample point, but it can create artifacts. Boissonnat [7] starts by finding an initial edge pq in the triangulated reconstruction; then he computes a tangent plane around the edge, projects the k-nearest neighbors of both vertices onto this plane, and determines the point r that maximizes the angle /-p-r-q (where the bar represents projected points on the tangent plane). This point r determines a surface triangle prq. The procedure is repeated for each border edge, resulting in a triangulated surface. Boyer [8] proposes an incremental algorithm over the 3D Delaunay triangulation of the samples and relies on regular interpolants.

Our algorithm uses a different approach: it starts by performing a robust smoothing of the given point cloud, followed by a data reduction step that extracts from the smoothed point cloud a set of representative points near the underlying surface. A rough surface approximation is reconstructed from these representative points using a new incremental algorithm based on k-nearest neighbors. This is step somewhat similar to what is done in other greedy algorithms [7, 5, 8, 9, 13]: For each border edge, the algorithm uses angle criteria to select a point to make a triangle with the edge. The initial triangulation is refined using a method based on a novel projection operator [15] that is able to approximate points to the point cloud in a robust way. Our algorithm does not need Delaunay triangulations and it can handle surfaces with borders and noisy point clouds.

A different approach to surface reconstruction is to use implicit formulations. Recent work along this line includes the work of Ohtake et al. [16] on partitions of unity with piecewise quadratics and the work of Xie et al. [18] on local implicit quadric regression, which also handles noisy data.

Section 2 describes in detail the five steps of our method: smoothing, clustering, reduction, triangulation, and refinement. Section 3 gives theoretical justifications for the heuristics used in the reconstruction step. Finally, Section 4 discusses several examples of the method in action.

2 Our Method

Starting from a possibly noisy point cloud P⊂ R3 that samples an unknown C1 surface S, our method produces a refined mesh approximating S. The method has five steps:

  1. Smoothing: Smooth the original point cloud based on a robust projection procedure.

  2. Clustering: Split the new point cloud into a set of clusters.

  3. Reduction: Compute a representative point of each cluster near the unknown surface S.

  4. Triangulation: Build a triangulated surface over the set of representative points.

  5. Refinement: Refine the initial mesh into a finer mesh that is adapted to the geometry of S.

We shall now describe each of these steps in detail.

2.1 Smoothing

Starting from a possibly noisy point cloud P near a surface S, the goal of this step is to eliminate the noise in the data while trying to preserve the salient features of the underlying surface. The new point cloud Q is obtained by applying a new robust smoothing operator Q to each point p eP. We shall give a short description of the operator Q; for details, see [15].

Each sample point p ∈P is transformed into a new point Q(p) = p + t*n*, where n* is an estimated normal vector for the surface S near p and t* is a displacement along n*. The optimal values for t* and n* are computed by the robust fitting of a hyperplane H, passing through the point p + tn and orthogonal to n, in a neighborhood N(p) of the point p. The optimal hyperplane is found by minimizing a cost functional with respect to t and n, subject to the restriction //n// = 1:

Σ F(t,n) = p(hq)w(// q-p//),q ∈ N (p)

(For details about the numerical method used to solve this minimization problem and its convergence, see [15].)

-x2σ2p - x2σ2w- p(x) = 1 - e and w(x)=e

The new position Q(p) can be seen as the projection of p onto a local linear approximation H of the surface S.

The estimation of this approximating hyperplane H is robust to gross deviation of the points q ∈ N(p): the influence of each point in N(p) is controlled by a robust error norm p, which penalizes points with large heights, and by a Gaussian weight function w, which gives less influence to points far away from p. The sensitivity of the cost functional to outliers is controlled by user-supplied parameters σp and σw.

The result of this step is a smoothed point cloud Q = {Q(p) : p ∈P} in which the salient features of the original data have been preserved. (Having no precise definition of what a feature is, we rely on visual inspection here.) See Figure 1.


2.2 Clustering

The goal of this first step is to partition the smoothed point cloud Q into a finite set of clusters, such that the curvature of S varies little within each cluster. Since S is not known, its curvature must be estimated from the sample points in Q.

We use a hierarchical clustering method based on a BSP tree. (This method has been used in several recent algorithms; see, for instance, [17].) Each node in the BSP tree contains a subset N = {p1,,...,pn} of Q. To decide whether or not to subdivide the node, we use a covariance analysis of the points in N, that is, we look at the eigenvalues of the covariance matrix C of N:

Since C is a symmetric, positive semi-definite, 3 x 3 matrix, its three eigenvalues are real and we can order them: λ1< λ2< λ3. These eigenvalues measure the variation of the points in N along the directions of their corresponding eigenvectors v1, v2, v3.

The eigenvectors v2 and v3 define the directions of highest variation and define a regression plane Π for N. The eigenvector v1 is normal to Π and its eigenvalue λ1 measures the variation of the points in N with respect to the plane Π. So, small values of λ1 mean that all points in N are approximately on Π. Hence, the ratio

λ1 σ = λ-+-λ--+-λ-1 2 3

is naturally a good measure of the flatness of the point set N and can be used as an estimate for the curvature of S around N. We use this flatness measure as one subdivision criterion for the BSP tree.

More precisely, a node is divided in two when both conditions below are satisfied:

1. The ratio σ is larger than a user-defined tolerance σ max;

2. The number n of points in N is larger than a user-defined value nmin.

The nodes are divided by classifying the points of N with respect to the regression plane n. The points of N that are on the same side of n will form a new node. The leaves of the BSP tree are the clusters we seek. See Figure 2.


2.3 Reduction

The goal of this step is to find a small set of points to be the vertices of a triangulated surface that will be a rough, initial approximation of the surface S. We do this by selecting a representative point for each cluster found in the previous step, thus effectively reducing the size of the original point cloud while capturing the overall geometry of the underlying surface.

To find a representative point for each cluster, we use the robust projection procedure Q, already used in Section 2.1. We start with the centroid of the points in a cluster N:

c =-1- Σ q. |N| q∈N

This point is not necessarily near S, due to the influence of small curvature in the cluster and to the presence of noise in the original data. In order to move c towards S, we project c onto the point cloud Q using the robust projector procedure Q, as described in Section 2.1. The point Q(c) is the representative of the cluster N. See Figure 2.

2.4 Triangulation

The next step is to build a triangulated surface over the set R of representative points found in the previous step. The goal is to find a rough approximation of the surface S, which will be refined later. We use an incremental triangulation algorithm that introduces new features in the basic framework of previous incremental algorithms [7, 5, 8].

The main idea behind the algorithm is to determine incrementally triangles in the restricted Delaunay triangulation of R (also called restricted Delaunay triangles), because these triangles form a piecewise linear manifold homeomorphic to the original surface [2].

The algorithm computes a sequence of triangulated surfaces with border. At each step, it chooses a border edge, finds a new triangle associated to this edge, and updates the current surface. The algorithm maintains a half-edge data structure H that represents the current surface and a list L of half-edges that represents the current boundary. (We used CGAL [19] for these data structures.) Algorithm 1 is a summary of the main steps:


We start by building a 3d-tree on R. This tree is used to identify efficiently the set K(p) of the k-nearest neighbors of any point p ∈R.

The initial surface contains a single triangle. This triangle is inserted into H and all its edges are inserted into L. To find the initial triangle, we select a point p ∈R and determine its nearest neighbor q ∈R. These two points define the first border edge, pq. We then find the point r ∈ K(p) that maximizes the angle /prq. The initial triangle is the triangle pqr, which is in the Delaunay triangulation of K(p).

Once the initial surface has been found, we continue by removing border edges from L until it is empty. For each such edge uv, we select a point q ∈ K(u) to create a new triangle uqv, which is then added to H and L.

The number of edges of uqv inserted in L varies: it is zero when the triangle uqv fills a hole in H; it is one when uq or vq are consecutive edges of uv in the border of the current surface; otherwise, it is two. When q is already in H, we have to join two connected components of the border or to split one component in two new connected components. We determine the point q using Algorithm 2. Here, θ, ε1, and ε2 are user-defined tolerances.


Condition (i) in Algorithm 2 is based on the following theorem, which we prove in Section 3:

Theorem 1 Let P be a β, r-sampling of a surface S with r < 14. Then the angle between two adjacent triangles sharing an edge in the restricted Delaunay triangulation of P is at least Π-2( 2r 1-4r+arcsin(√3r1--r)).

This theorem shows that the dihedral angle between two adjacent restricted Delaunay triangles converges to n as the sampling density increases (that is, as r →0). We start with an initial region [Π - θ,Π + θ] with small θ to determine the set of points Cθ in this region that satisfy criteria (ii) and (iii). If Cθ is not empty, we find the point q ∈ C. with maximum angle /uq v; otherwise, we increase θ by ε2. and repeat the procedure ü2 until we find such a point q or θ gets too large.

Condition (ii) is used to eliminate candidate points t that would violate the topology of the current reconstructed surface if they were selected. We proceed in the following way: For each point q ∈ K that is on the boundary of the current surface we compute the tangent plane nq using the star of q. Then we check whether the projection of the triangle uvt and the projection of the star of q onto nq intersect at anything different from a vertex or an edge: in that case we reject the point t as producing a topological violation.

Condition (iii) and (iv) are used to determine border edges. Condition (iii) is based on the following theorem, which is proved in Section 3:

Theorem 2 Let P be a β,r-sampling of a surface S with r < 13. Let T1 and T2 be two adjacent triangles sharing an edge uv in the restricted Delaunay triangulation of P. Then:

  • The length of the longest edge of T

    2 is at most 2β 1

    -3

    rd, where d = min{d

    u,d

    v} and d

    u (respectively, d

    v) is the distance of u (respectively, v) to its nearest neighbor.

  • If s is a sample point not on the same connected component as v, then the distance between s and v is larger than

    1

    rd

    u.

This theorem shows that there is little variation between the length of the edges of two restricted Delaunay triangles adjacent to an interior edge. In our experiments we observed that the length of edges of the adjacent of the candidate triangles to a boundary edge are very different. The theorem also gives a lower bound on the length of a candidate edge joining two points on different connected components. Based on this bound, condition (iii) guarantees that, for a sufficiently dense sampling, the algorithm never joins points from separate components.

Condition (iv) gives a bound for the angles adjacent to the edge uv of a restricted Delaunay triangle and is based on the following theorem, which is proved in Section 3:

Theorem 3 Let P be a β,r-sampling of a surface S. Let T be a triangle in the restricted Delaunay triangulation of P. Then the angles in T are less than 2arccos(1-r 2β).

In practice, we have no way to estimate β and r, and so we use a user-selected value ε1 as the constant 2β 1-3r and a user-selected angle φ instead of 2arccos(1-βr) (we got good results with β = 140 , for sufficiently dense samplings). A point t is eliminated if max{d(u,t),d(v,t)}> ε1dm|n or if one of the angles /uv t and /uv t is at least φ. If Cθ is empty, then the edge uv is a candidate border edge. If C is empty for all 9 tested, then uv is a border edge.

If Cθ is not empty, we compute the subset C'θ of points q with maximum angle /-uq v. We justify this criterion as follows: In R2, given a Delaunay triangle uvs, its adjacent Delaunay triangle uvq is the one with maximum angle /-uq v. Although this is a criterion for R2, we use it for surfaces because the surface normal varies little in the surface neighborhood of a point u containing the vertex of the restricted Delaunay triangulation (see [1, 2, 3, 4]); in other words, we may consider this neighborhood as flat.

This triangulation algorithm is fast (timings are given in Section 4). Figure 3 shows the triangulated surfaces over the set of representatives shown in Figure 2.


2.5 Refinement

The goal of this step is to refine the initial coarse triangulation, built in the previous step, into a finer triangulation adapted to the geometry of the unknown surface S. The refinement is done by refining each edge in the initial triangulation, until there are no more edges to be refined.

We propose the following method to refine an edge uv: We start with the middle point of the edge. If this point is too far from the point cloud Q, then it is projected onto Q and a new edge is added to each adjacent triangle of the edge uv, dividing each triangle into two new triangles. We repeat this procedure for each edge in the original triangulation. The details are discussed below.

More precisely, for each edge uv we compute its midpoint m and its normal nm:

m = u+-v, nm = -nu-+-nv-, 2 //nu + nv//

where nu and nv are the normals of u and v respectively, computed using the local triangulation (star) of each vertex.

Using the set K = K(m) of k-nearest neighbors of m in the point cloud Q, we minimize the following functional with respect to t:

Σ θ (t)= //p-m+t·nm//2.p∈K

This is interpreted as finding the point on the line through m in the direction of nm that is closest to the original surface S. The minimum of O(t) occurs at

1 Σ α = ---(p-m).nm.k p∈K

We use a as a measure of the need for refinement. If a is smaller than a fixed, user-defined tolerance ε, then we do not refine the edge; otherwise, we project the point m + a . nm onto the smoothed point cloud Q using the robust projection operator Q described in Section 2.1, producing the new point -m = Q(m + a. nm).

Then we replace the triangles adjacent to uv, say auv and buv, with the new triangles u-ma, v-ma and u-mb, vm-b, respectively. If the ratio between the length of the minimum edge and the maximum edge of the triangles auv or buv is too small, we do not divide the triangles.

This procedure is applied to all the old edges for which a is larger than s. In the resulting mesh, we flip the diagonals of each quadrilateral formed by the pairs of adjacent triangles if the length of one diagonal (the common edge) is larger than the length of the other diagonal (the segment joining the opposite vertex).

The final result is a refined triangulated surface near the original point cloud that captures its salient features. Figure 4 shows two refinement steps of the initial triangulation shown in Figure 3.


3 Theory

We now prove the theorems that justify the heuristics used in the reconstruction algorithm explained in Section 2.4. We start with a short introduction to the related theory.

Amenta et al. [2] defined the local feature size lfs(x) of a sample point x as the distance of x to the medial axis of the surface S. They also defined the concept of r-sample:

Definition 1 A set P⊆S is an r-sample if we have B(p,r lfs(p)) ∩P/= for all p∈Π.

Here, and in the sequel, B(p,r) is the ball centered at p with radius r. We shall adopt a different sampling criterion, proposed by Dey et al. [10]:

Definition 2 A set P⊆S is a β,r-sample, for β > 1, if the following two conditions are valid:

1. B(x,r . lfs(x)) ∩P /= for all x∈Σ.

2. B(p,rβ. Ifs(p)) ∩P = {p}for all p∈P.

The Voronoi diagram of a set of samples P⊂S induces a decomposition on the surface S called the restricted Voronoi diagram. The restricted Voronoi cell associated to a point p∈P is Vp = Vp∩S, where Vp is the Voronoi cell of p in the Voronoi diagram of P. The restricted Delaunay triangulation is the dual of the restricted Voronoi diagram, obtained in the following way: pq is an edge of the restricted Delaunay triangulation if Vp∩Vq/= ∅; pqr is a face of the restricted Delaunay triangulation if Vp∩ Vq∩ V r/= .

Amenta et al. [2] proved that the polyhedron defined by the restricted Delaunay triangulation is homeomorphic to the original surface for sufficiently dense r-samplings (r < 0.1).

The following two lemmas were proved by Amenta et al. [2]. The first lemma bounds the angle between the normals of points sufficiently close. The second lemma bounds the angle between the normal to a restricted Delaunay triangle and the surface normal at the vertex with angle at least Π 3.

Lemma 1 If r < 13, then, for any two points p,q ∈P with d(p,q) r< r·min{lfs(p),lfs(q)}, the angle between the normals np and nq is at most 1-r3r

Lemma 2 If T is a restricted Delaunay triangle and s is a vertex of T with angle at least Π 3, then the angle between the normal of S at s and the normal of T is at most arcsin(√3r1-r).

These two lemmas are used to prove Theorem 1, which bounds the angle between two adjacent restricted Delaunay triangles:

Theorem 1 Let P be a β,r-sampling of a surface S with r <14. Then the angle between two adjacent triangles sharing an edge in the restricted Delaunay triangulation of P is at least Π-2( 2r 1-4r+arcsin(3r 1--r)).

Proof: Let T1 = p1p2p3 and T2 = p1p2q3 be two restricted Delaunay triangles sharing an edge p1p2 and let s = V p1∩ V p2∩ Vp3 . Because the points of P nearest to s are p1 , p2 , and p3 , we have d(s,p ) < r· lfs(s) (i = 1,2,3). Since lfs(s) < d(s,pi) + lfs(pi) and d(s,p.) < r· lfs(s), we obtain lfs(s) < -1- 1-r lfs(pi.), which implies

d(s,p ) <--r—min{lfs(s),lfs(p)}. i 1- r i

It follows from Lemma 1 that the angle between the normals ns and npi is less than 1-r4r Hence, the angle between the two normals npi and npj is less than -2r- 1-4r We assume without lost of generality that p3 is a vertex with angle at least Π 3. Applying Lemma 2, we conclude that the angle between the normal of the surface at p3 and the normal of the triangle T1 is less than arcsin(√3r 1-r). Combining these inequalities, we get:

/ (n ,T ) < /-(n ,n )+ / (n ,T ) pi 1 pi p3 p√3 1 < -2r--+ arcsin(--3r-). 1- 4r 1 - r

In particular, /(np ,T1) < 12-r4r + arcsin(√- 13-rr). Analogously, we get /(np1 ,T2) < 12-r4r + arcsin(-13-rr), Hence, the angle between T1 and T2 is at least n - 2(12-r4r + arcsin(√- 13-rr)), as stated.

Note that β was not used in the proof and so this theorem is valid in the more general case of an r-sampling.

The next two results are used in the proof of Theorem 2. They are also from Amenta et al. [2], but do not appear explicitly as lemmas. We include them here for completeness.

Lemma 3 Let P be an r-sampling of S with r < 1. Then the distance between two adjacent vertices uv in the restricted Delaunay triangulation of P is less than -2r 1-r lfs(u).

Proof: Let T = uvw be a restricted Delaunay triangle and let s be its dual restricted Voronoy vertex. Then d(u,v) < 2d(u,s) < 2r·lfs(s). On the other hand, since d(u,s) < r·λfs(s) and lfs(s) < d(u,s) + lfs(u), we obtain lfs(s) <11-r lfs(u). Hence, d(u,v) < 12-rr lfs(u), as claimed.

Lemma 4 The radius of the Voronoi ball circumscribing a restricted Delaunay triangle T is less than 1r-r lfs(x), where x is any of the vertices of T.

Proof: Let c be the restricted Voronoi vertex that is the center of the ball circumscribing T. Then the radius of the ball is d(c,x) and d(c,x) < r·lfs(c). Since lfs(c) < d(c,x) + lfs(x), we conclude that lfs(c) < -1- 1 lfs(x).

Hence, d(c,x) < 1 lfs(x).

We can now prove Theorem 2, which defines the criterion used to determine border edges and guarantees that points in different connected components are never joined by an edge.

Theorem 2 Let P be β,r-sampling of a surface S with r <13. Let T1 and T2 be two adjacent triangles sharing an edge uv in the restricted Delaunay triangulation of P. Then:

  • The length of the longest edge of T

    2 is at most

    12-

    β3rd where d = min{d

    u,d

    v} and d

    u (respectively, d

    v) is the distance of u (respectively, v) to its nearest neighbor.

  • If s is a sample point not on the same connected component as v, then the distance between s and v is larger than 1

    rd

    u.

Proof: a) Since lfs(v) < d(u,v) + lfs(u) and d(u,v) < -2r 1-r lfs(v) by Lemma 3, we have that

2r 1- 3r lfs(u) > lfs(v)------lfs(v) =------lfs(v). 1 - r 1- r

By symmetry, and because 1-13rr-> 1, we conclude

lfs(y) > 1--3r-lfs(x) 1 - r

for x,y ∈{u,v}. Now du > rβ lfs(u) and dv > rβ lfs(v). Hence,

d = min{du,dv} > r(1--3r)lfs(x), β(1 - r)

for x = u,v. On the other hand, any edge of the triangle T2 is inside the Voronoi ball with center at c = Vu∩Vv nVt. By Lemma 4, the diameter of this Voronoi ball is less than 12-rr lfs(x) for x = u,v. Thus, the length of the longest edge of T2 is at most -2r- 1-r lfs(x) < 2p-- 1- 3rd.

b) Because s is on a different connected component we have that d(s,v) > lfs(v) since the segment joining s and v has to intersect the medial axis. On the other hand, we have that du < r· lfs(v) and the inequality follows.

Our last theorem bounds the internal angles of a restricted Delaunay triangle:

Theorem 3 Let P be a β, r-sampling of a surface S. Let T be a triangle in the restricted Delaunay triangulation of P. Then the angles in T are less than 2arccos(12-βr).

Proof: Let T = uvt be a restricted Delaunay triangle and let s be its dual restricted Voronoi vertex. Let a1 = /uv s and a2 = /sv t. Then /uv s < a1 + a2. Let us concentrate on a1 for the moment. Because T1 = uvr is an isosceles triangle, a1 is acute and

d(u,v)-1--r-cos(α1)=2d(s,v) > 2β,

because d(u,v) > rβ lfs(v) and d(s,v)< -r-1-r · lfs(v) by Lemma 4. Analogously, cos(a2) >1-r 2β. Hence, /uv s < a1 + α2< 2arccos(1-2rβ), as stated.

4 Results

We tested our algorithm on several data sets available on the Internet [20, 21]. These data were contaminated with noise by disturbing each point a small fraction of the diagonal of the bounding box of the point cloud. The results appear in Figures 5-8, which show the noisy data, the initial triangulation and the final triangulation after two refinement steps. (The pictures in this paper are available in full size and color at http://www.impa.br/~boris/Research.html.)


Table 1 shows the times (in seconds) taken in each step of the algorithm and the sizes (points and triangles) of the result models. Note that the smoothing step dominates the total time. Table 2 shows the parameters used in each case; σp and σw are given as a fraction of h, the mean separation between sample points. The Knot model required two smoothing passes; the second pass used σp = 2.5h and σw = 1.5h.

5 Conclusion

We have presented a complete framework for surface reconstruction in the presence of noise, giving as output a refined triangular mesh with points near the original point cloud. This framework combines a method for removing noise from the data [15] with a method for surface reconstruction that first triangulates a simplified point cloud and then refines it. The simplification step partitions the original point cloud into clusters of approximately coplanar points and then selects one representative point from each cluster to form the simplified point cloud. The triangulation algorithm does not need to compute 3D Delaunay triangulations, which in the worst case requires quadratic time and which is prone to numerical errors. The refinement method is fast and gives a fine triangular mesh adapted to the geometry of the underling surface.

Our method is controlled by several parameters that can be selected by the user to suit the data. Parameters in the range of those used in Section 4 seem to work well for data sets similar to those presented here. The selection of a smaller set of parameters and the automatic determination of those parameters are open issues left for future work.

We have provided some theoretical results that motivated the heuristics used in the reconstruction step. We say heuristics because in practice it is not possible to verify that the assumptions needed to prove those theorems hold, specially for noisy data. In particular, it is not possible to verify the sampling conditions used originally by Amenta et al. [2] and Dey et al. [10], because neither the underlying surface nor the sampling process are known. Nonetheless, based on several tests with noisy data, we believe that the smoothing step does preserve the salient features of the data and that the heuristics used in the reconstruction step, which are motivated by similar theoretical results, do preserve the topological and geometric information required for surface reconstruction.

Acknowledgments. The authors are partially supported by CNPq research grants. The authors are members of Visgraf, the computer graphics laboratory at IMPA, which is sponsored by CNPq, FAPERJ, FINEP, and IBM Brasil. This work is part of Boris Mederos's doctoral thesis at IMPA.

  • 1
    Amenta N., Bern M., Kanvisellis M.: A new Voronoi based surface algorithm. SIGGRAPH'98, pp. 415-421, 1998.
  • 2
      Amenta N., Bern M.: Surface reconstruction by Voronoi filtering, Discrete and Computational Geometry 22(4):481-504, 1999.
  • 3
      Amenta N., Choi S.: One-pass Delaunay filtering for homeomorphic 3D surface reconstruction. Technical Report TR99-08, University of Texas at Austin, 1999.
  • 4
      Amenta N., Choi S., Kolluri R.: The power crust. Proc. 6th ACM Symp. on Solid Modeling, pp. 249-260, 2001.
  • 5
      Bernardini F., Mittelman J., Rushmeier H., Silva C., Taubin G.: The ball-pivoting algorithm for surface reconstruction. IEEE Transactions on Visualization and Computer Graphics 5(4):349-359, 1999.
  • 6
      Boissonnat J.-D., Cazals F.: Smooth surface reconstruction via natural neighbor interpolation of distance function. Computational Geometry 22(1-3):185-203, 2002.
  • 7
      Boissonnat J.-D.: Geometric structures for three-dimensional shape reconstruction. ACM Transactions on Graphics 3(4):266-289, 1984.
  • 8
      Boyer E., Petitjean S.: Curve and surface reconstruction from regular and non regular point sets. Computational Geometry 19(2-3):101-126, 2001.
  • 9
      Crossno P., Angel E.: Spiraling edge: fast surface reconstruction from partially organized sample points. Proc. Visualization'99, pp. 317-324, 1999.
  • 10
      Dey T. K., Giesen J., Goswami S., Zhao W.: Shape dimension and approximation from samples. Discrete and Computational Geometry 29(3):419-434, 2003.
  • 11
      Freedman D.: Efficient simplicial reconstruction of manifolds from their samples. IEEE Transaction on Pattern Analysis and Machine Intelligence 24(10):1349-1357, 2002.
  • 12
      Gopi M., Krishnan S., Silva C.: Surface reconstruction based on lower dimensional localized Delaunay triangulation. Computer Graphics Forum 19(3):C467-C478, 2000.
  • 13
      Gopi M., Krishnan S.: A fast and efficient projection-based approach for surface reconstruction. Proc. SIBGRAPI 2002, pp. 179-186.
  • 14
      Hoppe H., DeRose T., Duchamp T., McDonald J., Stuetzle W.: Surface reconstruction from unorganized points. Proc. SIGGRAPH'92, pp. 71-78, 1992.
  • 15
      Mederos B., Velho L., Figueiredo L. H.: Robust smoothing of noisy point clouds. To appear in Proc. SIAM Conference on Geometric Design and Computing 2003, 2004.
  • 16
      Ohtake Y., Belyaev A., Alexa M., Turk G.: Multi-level partition of unity implicits. Proc. SIGGRAPH'03, pp. 463-470, 2003.
  • 17
      Pauly M., Gross M., Kobbelt L.: Efficient simplification of point-sampled surfaces. Proc. Visualization'02, pp. 163-170,2002.
  • 18
      Xie H., Wang J., Hua J., Qin H., Kaufman A.: Piecewise C1 continuous surface reconstruction of noisy point clouds via local implicit quadric regression. Proc. Visualization'03, pp. 91-98, 2003.
  • 19
      Computational Geometry Algorithms Library. http://www.cgal.org
  • 20
      Large Geometric Model Archive. http://www.cc.gatech.edu/projects/large models
  • 21
      Hugues Hoppe's home page. http://research.microsoft.com/~hoppe/

Publication Dates

  • Publication in this collection
    25 May 2010
  • Date of issue
    Apr 2004
Sociedade Brasileira de Computação Sociedade Brasileira de Computação - UFRGS, Av. Bento Gonçalves 9500, B. Agronomia, Caixa Postal 15064, 91501-970 Porto Alegre, RS - Brazil, Tel. / Fax: (55 51) 316.6835 - Campinas - SP - Brazil
E-mail: jbcs@icmc.sc.usp.br