0% found this document useful (0 votes)
38 views10 pages

Carr Et Al - 2001 - Reconstruction and Representation of 3D Objects With Radial Basis Functions

Carr et al - 2001 - Reconstruction and Representation of 3D Objects With Radial Basis Functions

Uploaded by

MSL1131
Copyright
© © All Rights Reserved
We take content rights seriously. If you suspect this is your content, claim it here.
Available Formats
Download as PDF, TXT or read online on Scribd
0% found this document useful (0 votes)
38 views10 pages

Carr Et Al - 2001 - Reconstruction and Representation of 3D Objects With Radial Basis Functions

Carr et al - 2001 - Reconstruction and Representation of 3D Objects With Radial Basis Functions

Uploaded by

MSL1131
Copyright
© © All Rights Reserved
We take content rights seriously. If you suspect this is your content, claim it here.
Available Formats
Download as PDF, TXT or read online on Scribd
You are on page 1/ 10

Reconstruction and Representation of 3D Objects with Radial Basis

Functions
J. C. Carr1,2 R. K. Beatson2 J. B. Cherrie1 T. J. Mitchell1,2 W. R. Fright1 B. C. McCallum1
T. R. Evans1

1 Applied Research Associates NZ Ltd ∗


2 University of Canterbury†

(a) (b)

Figure 1: (a) Fitting a Radial Basis Function (RBF) to a 438,000 point-cloud. (b) Automatic mesh repair using the biharmonic RBF.

Abstract 1 Introduction
We use polyharmonic Radial Basis Functions (RBFs) to reconstruct Interpolating incomplete meshes (hole-filling) and reconstructing
smooth, manifold surfaces from point-cloud data and to repair in- surfaces from point-clouds derived from 3D range scanners are
complete meshes. An object’s surface is defined implicitly as the ubiquitous problems in computer graphics and Computer Aided
zero set of an RBF fitted to the given surface data. Fast methods for Design (CAD). Smoothly blending between surfaces and ensuring
fitting and evaluating RBFs allow us to model large data sets, con- surfaces are manifold, and therefore manufacturable, are related
sisting of millions of surface points, by a single RBF—previously problems in CAD. Similarly, smoothing and remeshing existing
an impossible task. A greedy algorithm in the fitting process re- noisy surfaces are important problems in both CAD and computer
duces the number of RBF centers required to represent a surface and graphics. These problems have mostly been considered indepen-
results in significant compression and further computational advan- dent from one another and received much attention in the litera-
tages. The energy-minimisation characterisation of polyharmonic ture (see [8] and the references therein). In this paper we propose
splines result in a “smoothest” interpolant. This scale-independent that the implicit representation of object surfaces with Radial Basis
characterisation is well-suited to reconstructing surfaces from non- Functions (RBFs) simplifies many of these problems and offers a
uniformly sampled data. Holes are smoothly filled and surfaces unified framework that is simple and elegant. An RBF offers a com-
smoothly extrapolated. We use a non-interpolating approximation pact functional description of a set of surface data. Interpolation
when the data is noisy. The functional representation is in effect a and extrapolation are inherent in the functional representation. The
solid model, which means that gradients and surface normals can RBF associated with a surface can be evaluated anywhere to pro-
be determined analytically. This helps generate uniform meshes duce a mesh at the desired resolution. Gradients and higher deriva-
and we show that the RBF representation has advantages for mesh tives are determined analytically and are continuous and smooth,
simplification and remeshing applications. Results are presented depending on the choice of basic function. Surface normals are
for real-world rangefinder data. therefore reliably calculated and iso-surfaces extracted from the im-
CR Categories: I.3.5 [Computer Graphics]: Computational Ge-
ometry and Object Modeling—Curve, surface, solid, and object
representations;
Keywords: Variational implicit surfaces, Radial Basis Function,
RBF, mesh repair, point-cloud surfacing, surface reconstruction,
geometry compression, solid modeling.
∗ Applied Research Associates NZ Ltd, PO Box 3894, Christchurch,

New Zealand. Email: [j.carr,j.cherrie,r.fright,b.mccallum]@aranz.com


Web: www.aranz.com
† Dept. Mathematics and Statistics, University of Canterbury,
Christchurch, New Zealand, Email: [email protected]
plicit RBF model are manifold (i.e., they do not self-intersect). molecules [9] and has generally been believed to be infeasible for
The benefits of modeling surfaces with RBFs have been recog- real-world objects acquired by 3D scanners. Turk & O’Brien [23]
nised by Savchenko [19], Carr et al. [10] and by Turk & have tried modeling laser scan data with RBFs. However they have
O’Brien [23, 22]. However, this work was restricted to small prob- been restricted to blobby approximations derived from small sub-
lems by the O (N 2 ) storage and O (N 3 ) arithmetic operations of di- sets of data consisting of a few hundred to a thousand surface points.
rect methods. For example, direct fitting of the dragon in Fig. 1(a) More recent work [25] has focussed on simplifying larger data sets
would have required 3,000GB just to store the corresponding ma- to make them computationally manageable. However, the ability
trix. Consequently, fitting RBFs to real-world scan data has not to represent complicated objects of arbitrary topology and model
been regarded as computationally feasible for large data sets. The the detail obtainable with modern laser scanners, is compromised.
fast fitting and evaluation methods introduced in this paper mean Carr et al. [10] used RBFs to reconstruct cranial bone surfaces from
modeling surface data from large data sets and complicated objects 3D CT scans. Data surrounding large irregular holes in the skull
is now feasible. In this paper we: were interpolated using the thin-plate spline RBF. Titanium plate
was then molded into the shape of the fitted surface to form a cra-
• describe the computational advantages offered by new fast nial prosthesis. That paper exploited the interpolation and extrap-
methods for fitting and evaluating RBFs. olation characteristics of RBFs as well as the underlying physical
properties of the thin-plate spline basic function. However, the ap-
• introduce RBF center reduction for implicit surface model- proach is restricted to modeling surfaces which can be expressed
ing. This results in significant data compression and speed explicitly as a function of two variables. In this paper we demon-
improvements. strate that by using new fast methods, RBFs can be fitted to 3D data
sets consisting of millions of points without restrictions on surface
• demonstrate that modeling very large data sets and topologi-
topology—the kinds of data sets typical of industrial applications.
cally complicated objects is possible.
Our method involves three steps:
• introduce RBF approximation for the problem of reconstruct-
ing smooth surfaces from noisy data. • Constructing a signed-distance function.

• apply RBFs to the problem of mesh repair (hole-filling) and • Fitting an RBF to the resulting distance function.
point-cloud surface fitting.
• Iso-surfacing the fitted RBF.

1.1 Implicit surfaces Section 2 of this paper describes how we formulate the surface
fitting problem as a scattered data interpolation problem. Section 3
The surface representation or reconstruction problem can be ex- introduces RBFs and Section 4 describes the use of new fast meth-
pressed as ods which overcome problems that have prevented the use of RBFs
in the past. Section 5 introduces RBF center reduction which re-
Problem 1.1. Given n distinct points {(xi , yi , zi )}ni=1 on a surface
sults in a compact surface representation as well as faster fitting
M in R3 , find a surface M 0 that is a reasonable approximation to and evaluation times. Section 6 introduces RBF approximation as a
M. means of smoothing noisy surface data and demonstrates this by re-
constructing smooth surfaces from noisy LIDAR (laser rangefinder)
Our approach is to model the surface implicitly with a function
data. Section 7 describes iso-surface extraction. Section 8 demon-
f (x, y, z). If a surface M consists of all the points (x, y, z) that satisfy
strates the abilities of RBFs to reconstruct non-trivial surfaces from
the equation
point-clouds and interpolate incomplete meshes. Section 9 draws
f (x, y, z) = 0, (1)
conclusions and discusses future work.
then we say that f implicitly defines M. Describing surfaces im-
plicitly with various functions is a well-known technique [9]. off-surface ‘normal’ points
In Constructive Solid Geometry (CSG) an implicit model is
formed from simple primitive functions through a combination of
Boolean operations (union, intersection etc) and blending func-
tions. CSG techniques are more suited to the design of objects in
CAD rather than their reconstruction from sampled data. Piece-
wise low-order algebraic surfaces, sometimes referred to as im-
plicit patches or semi-algebraic sets, have also been used to define
surfaces implicitly. These are analogous to piecewise parametric
splines except that the surface is implicitly defined by low degree surface points
polynomials over a piecewise tetrahedral domain. An introduction
to these techniques and further references can be found in [9].
The distinction between our approach and these well-known Figure 2: A signed-distance function is constructed from the sur-
techniques is that we wish to model the entire object with a single face data by specifying off-surface points along surface normals.
function which is continuous and differentiable. A single functional These points may be specified on either or both sides of the surface,
description has a number of advantages over piecewise parametric or not at all.
surfaces and implicit patches. It can be evaluated anywhere to pro-
duce a particular mesh, i.e., a faceted surface representation can
be computed at the desired resolution when required. Sparse, non- 2 Fitting an implicit function to a surface
uniformly sampled surfaces can be described in a straightforward
manner and the surface parameterization problem, associated with We wish to find a function f which implicitly defines a surface M 0
piecewise fitting of cubic spline patches, is avoided. and satisfies the equation
The representation of objects with single functions has pre-
viously been restricted to modeling “blobby” objects such as f (xi , yi , zi ) = 0, i = 1, . . . , n,
(a) (b) (c)

Figure 3: Reconstruction of a hand from a cloud of points with and without validation of normal lengths.

where {(xi , yi , zi )}ni=1 are points lying on the surface. In order been chosen to lie a fixed distance from the surface. The result-
to avoid the trivial solution that f is zero everywhere, off-surface ing surface, where f is zero, is distorted in the vicinity of the fin-
points are appended to the input data and are given non-zero val- gers where opposing normal vectors have intersected and generated
ues. This gives a more useful interpolation problem: Find f such off-surface points with incorrect distance-to-surface values, both in
that sign and magnitude. In Fig. 3(a) & (b) validation of off-surface dis-
tances and dynamic projection has ensured that off-surface points
f (xi , yi , zi ) = 0, i = 1, . . . , n (on-surface points), produce a distance field consistent with the surface data. Fig. 4 is a
f (xi , yi , zi ) = di 6= 0, i = n + 1, . . . , N (off -surface points). cross section through the fingers of the hand. The figure illustrates
how the RBF function approximates a distance function near the
This still leaves the problem of generating the off-surface points object’s surface. The approximately equally spaced iso-contours at
{(xi , yi , zi )}N +1, 0 and −1 in the top of the figure and the corresponding function
i=n+1 and the corresponding values di .
An obvious choice for f is a signed-distance function, where profile below, illustrate how the off-surface points have generated
the di are chosen to be the distance to the closest on-surface point. a function with a gradient magnitude close to 1 near the surface
Points outside the object are assigned positive values, while points (which corresponds to the zero-crossings in the profile shown).
inside are assigned negative values. Similar to Turk & O’Brien [23],
these off-surface points are generated by projecting along surface
normals. Off-surface points may be assigned either side of the sur-
face as illustrated in Fig. 2.
Experience has shown that it is better to augment a data point
with two off-surface points, one either side of the surface. In
Fig. 3(a) surface points from a laser scan of a hand are shown in
green. Off-surface points are color coded according to their dis-
tance from their associated on-surface point. Hot colors (red) rep-
resent positive points outside the surface while cold colors (blue) lie
inside. There are two problems to solve; estimating surface normals
and determining the appropriate projection distance.
If we have a partial mesh, then it is straightforward to define off-
surface points since normals are implied by the mesh connectivity
at each vertex. In the case of unorganised point-cloud data, nor-
mals may be estimated from a local neighbourhood of points. This
requires estimating both the normal direction and determining the
sense of the normal. We locally approximate the point-cloud data
with a plane to estimate the normal direction and use consistency
and/or additional information such as scanner position to resolve
the sense of the normal. In general, it is difficult to robustly es-
timate normals everywhere. However, unlike other methods [16]
which also rely on forming a signed-distance function, it is not crit-
ical to estimate normals everywhere. If normal direction or sense Figure 4: Cross section through the fingers of a hand reconstructed
is ambiguous at a particular point then we do not fit to a normal at from the point-cloud in Fig. 3. The iso-contours corresponding to
that point. Instead, we let the fact that the data point is a zero-point +1, 0 and -1 are shown (top) along with a cross sectional profile of
(lies on the surface) tie down the function in that region. the RBF (bottom) along the line shown.
Given a set of surface normals, care must be taken when pro-
jecting off-surface points along the normals to ensure that they
do not intersect other parts of the surface. The projected point is 3 Radial Basis Function interpolation
constructed so that the closest surface point is the surface point
that generated it. Provided this constraint is satisfied, the recon- Given a set of zero-valued surface points and non-zero off-surface
structed surface is relatively insensitive to the projection distance points we now have a scattered data interpolation problem: we want
|di |. Fig. 3(c) illustrates the effect of projecting off-surface points to approximate the signed-distance function f (x) by an interpolant
inappropriate distances along normals. Off-surface points have s(x). The problem can be stated formally as follows,
Problem 3.1. Given a set of distinct nodes X = {xi }N 3
i=1 ⊂ R and More generally, if the polynomial in Equation (6) is of degree m
a set of function values { fi }N ⊂ R, find an interpolant s : R 3→R then the side conditions imposed on the coefficients are
i=1
such that N
s(xi ) = fi , i = 1, . . . , N. (2)
∑ λi q(xi ) = 0, for all polynomials q of degree at most m. (7)
Note that we use the notation x = (x, y, z) for points x ∈ R3 . i=1

The interpolant will be chosen from BL(2) (R3 ), the Beppo-Levi These side conditions along with the interpolation conditions of
space of distributions on R3 with square integrable second deriva- Equation (2) lead to a linear system to solve for the coefficients
tives. This space is sufficiently large to have many solutions to that specify the RBF.
Problem 3.1, and therefore we can define the affine space of inter- Let {p1 , . . . , p` } be a basis for polynomials of degree at most m
polants: and let c = (c1 , . . . , c` ) be the coefficients that give p in terms of this
basis. Then Equations (2) and (7) may be written in matrix form as
S = {s ∈ BL(2) (R3 ) : s(xi ) = fi , i = 1, . . . , N}. (3)
λ λ
      
A P f
The space BL(2) (R3 ) is equipped with the rotation invariant semi- = B = , (8)
PT 0 c c 0
norm defined by
where
2 2 2
∂2 s(x) ∂2 s(x) ∂2 s(x)
Z   
ksk2 = + + Ai, j = φ(|xi − x j |), i, j = 1, . . . , N,
R3 ∂x2 ∂y2
∂z2
2 2 2 Pi, j = p j (xi ), i = 1, . . . , N, j = 1, . . . , `.
∂ s(x) ∂ s(x) ∂ s(x)
 2  2  2
+2 +2 +2 dx. (4) In the specific case of the biharmonic spline in 3D, if it is assumed
∂x∂y ∂x∂z ∂y∂z
that the polynomial part of the RBF in Equation (5) has the form
This semi-norm is a measure of the energy or “smoothness” of func- p(x) = c1 + c2 x + c3 y + c4 z, then
tions: functions with a small semi-norm are smoother than those
with a large semi-norm. Duchon [12] showed that the smoothest Ai, j = |xi − x j |, i, j = 1, . . . , N,
interpolant, i.e.,
s? = arg min ksk, P is the matrix with ith row (1, xi , yi , zi ), λ = (λ1 , . . . , λN )T and
s∈S c = (c1 , c2 , c3 , c4 )T .
has the simple form Solving the linear system (8) determines λ and c, and hence s(x).
However, the matrix B in Equation (8) typically has poor condi-
N
s? (x) = p(x) + ∑ λi |x − xi |,
tioning as the number of data points N gets larger. This means that
(5)
i=1
substantial errors will easily creep into any standard numerical so-
lution.
where p is a linear polynomial, the coefficients λi are real numbers On initial inspection, the essentially local nature of the Gaus-
and | · | is the Euclidean norm on R3 . sian, inverse multiquadric (φ(r) = (r2 + c2 )−1/2 ) and compactly
This function is a particular example of a radial basis function supported basic functions appear to lead to more desirable prop-
(RBF). In general, an RBF is a function of the form erties in the RBF. For example, the matrix B now has special struc-
N ture (sparsity) which can be exploited by well-known methods and
s(x) = p(x) + ∑ λi φ(|x − xi |), (6) evaluation of Equation (6) only requires that the sum be over nearby
i=1 centers instead of all N centers. However, non-compactly supported
basic functions are better suited to extrapolation and interpolation
where p is a polynomial of low degree and the basic function φ of irregular, non-uniformly sampled data. Indeed, numerical exper-
is a real valued function on [0, ∞), usually unbounded and of non- iments using Gaussian and compactly supported piecewise polyno-
compact support (see, e.g., Cheney & Light [11]). In this context mials for fitting surfaces to point-clouds have shown that these basic
the points xi are referred to as the centers of the RBF. functions yield surfaces with many undesirable artifacts in addition
Popular choices for the basic function φ include the thin-plate to the lack of extrapolation across holes.
spline φ(r) = r2 log(r) (for fitting smooth functions of two vari- The energy minimisation properties of biharmonic splines make
ables), the Gaussian φ(r) = exp(−cr√2 ) (mainly for neural net- them well suited to the representation of 3D objects. Since the
works), and the multiquadric φ(r) = r2 + c2 (for various appli- corresponding basic function φ(r) = r is not compactly supported
cations, in particular fitting to topographical data). For fitting and grows arbitrarily large as r tends to infinity, the correspond-
functions of three variables, good choices include the biharmonic ing matrix B of Equation (8) is not sparse and, except for symme-
(φ(r) = r, i.e., Equation (5)) and triharmonic (φ(r) = r3 ) splines. try, has no obvious structure that can be exploited in solving the
RBFs are popular for interpolating scattered data as the associ- system. Storing the lower triangle of matrix B requires space for
ated system of linear equations is guaranteed to be invertible under N(N + 1)/2 real numbers. Solution via a symmetric solver will re-
very mild conditions on the locations of the data points [11, 18]. quire N 3 /6 + O (N 2 ) flops. For a problem with 20, 000 data points
For example, the biharmonic spline of Equation (5) only requires this is a requirement for approximately 1.6 × 109 bytes (1.5GB)
that the data points are not co-planar, while the Gaussian and mul- of core memory, and 1013 flops, which is impractical. Further-
tiquadric place no restrictions on the locations of the points. In par- more, ill-conditioning of the matrix B is likely to make any solution
ticular, RBFs do not require that the data lie on any sort of regular one gets from such a direct computation highly unreliable. Thus,
grid. it is clear that direct methods are inappropriate for problems with
An arbitrary choice of coefficients λi in Equation (5) will yield N & 2, 000. Moreover, a single direct evaluation of Equation (6)
a function s? that is not a member of BL(2) (R3 ). The requirement requires O (N) operations. These factors have led many authors to
that s? ∈ BL(2) (R3 ) implies the orthogonality or side conditions conclude that, although RBFs are often the interpolant of choice,
they are only suitable for problems with at most a few thousand
N N N N
∑ λi = ∑ λi xi = ∑ λi yi = ∑ λi zi = 0. points [13, 14, 20]. The fast methods described in the following
section demonstrate that this is no longer the case.
i=1 i=1 i=1 i=1
Figure 6: A greedy algorithm iteratively fits an RBF to a point cloud resulting in fewer centers in the final function. In this case the 544,000
point cloud is represented by 80,000 centres to a relative accuracy of 5 × 10−4 in the final frame.

give a brief outline of the method.


The FMM makes use of the simple fact that when computations
are performed, infinite precision is neither required nor expected.
Once this is realised, the use of approximations is allowed. For
the evaluation of an RBF, the approximations of choice are far- and
near-field expansions. With the centers clustered in a hierarchical
manner, far- and near-field expansions are used to generate an ap-
proximation to that part of the RBF due to the centers in a particular
cluster. A judicious use of approximate evaluation for clusters “far”
fitting accuracies from an evaluation point and direct evaluation for clusters “near” to
an evaluation point allows the RBF to be computed to any prede-
interpolation nodes evaluation accuracy
termined accuracy and with a significant decrease in computation
output evaluation points fitted RBF time compared with direct evaluation.
output surface These fast evaluation methods, when used together with fitting
methods particular to RBFs [2, 6], greatly reduce the storage and
Figure 5: Illustration of the fast fitting and evaluation parameters. computational costs of using RBFs. They reduce the cost of evalu-
ating s(x) at M points from O (MN) to O (M + N log N) operations.
Direct methods Fast methods The cost of simultaneously computing the gradient ∇s(x) with s(x)
Fitting is approximately twice that of computing s(x) alone. Table 1 sum-
storage required N(N + 1)/2 O (N) marises the gains of fast methods over direct methods.
flops to solve system N 3 /6 + O (N 2 ) O (N log N) Fig. 5 illustrates two parameters introduced by fast methods: a
Evaluation fitting accuracy and an evaluation accuracy. The fitting accuracy
flops per evaluation O (N) O (1) after specifies the maximum allowed deviation of the fitted RBF value
O (N log N) setup from the specified value at the interpolation nodes. If desired, a dif-
ferent fitting accuracy may be specified at each data point, as illus-
Table 1: Comparison of direct and fast methods. trated by the varying error bars in Fig. 5. The evaluation accuracy
specifies the precision with which the fitted RBF is then evaluated.
4 Fast methods Fig. 5 shows an RBF evaluated at regular intervals lying between
the dashed evaluation accuracy bands either side of the actual func-
Fast evaluation of RBF’s is performed via the Fast Multipole tion. It is sensible to choose the evaluation accuracy to be numeri-
Method (FMM) of Greengard & Rokhlin [15]. The FMM was de- cally smaller than the fitting accuracy. The resulting dotted curve is
signed for the fast evaluation of potentials (harmonic RBF’s) in two an approximation to the smooth and continuous RBF.
and three dimensions. However Beatson et al. [7] have adapted the
expansion and translation theory for the potential to higher order
polyharmonic RBFs. Note that polyharmonic RBFs include the bi- 5 RBF center reduction
harmonic spline of Equation (5). The FMM may also be used with
polyharmonic splines in two [5] and four dimensions [3]. Conventionally, an RBF approximation uses all the input data
A full description of the FMM is beyond the scope of this paper points (the xi ’s in Equation (2)) as nodes of interpolation, and as
and the interested reader is directed towards the introductory short centers of the RBF. However, the same input data may be able to
course [4] for an expository treatment of the FMM. However, we be approximated to the desired accuracy using significantly fewer
Equation (5), but now the coefficient vector (λT , cT )T is the solu-
tion to
λ
    
A − 8NπρI P f
T = , (10)
P 0 c 0
where the matrices A and P are as in Equation (8). The parameter ρ
can be thought of as the stiffness of the RBF s(x). The system (10)
can also be solved using fast methods.
In Fig. 8 we illustrate RBF approximation (also known as spline
RBF centers reduced subset smoothing) in the context of reconstructing a surface from 3D LI-
of RBF centers DAR data. LIDAR data is often noisy and irregular due to limited
range resolution and misregistration between scans taken at differ-
Figure 7: Illustration of center reduction. ent scanner positions. Restricted physical viewing angles for the
scanner mean increased susceptibility to occlusion and therefore re-
centers, as illustrated in Fig. 7. A greedy algorithm can therefore be gions of incomplete data. Elsewhere, due to overlapping scans, the
used to iteratively fit an RBF to within the desired fitting accuracy. data may contain redundancy. Consequently, LIDAR scans repre-
sent one of the more difficult surface fitting problems. In this exam-
A simple greedy algorithm consists of the following steps:
ple a smooth surface has been automatically fitted to LIDAR scans
1. Choose a subset from the interpolation nodes xi and fit an RBF of a fountain in Santa Barbara using an RBF approximation. The
only to these. statue is approximately 2m×5m and was scanned using a CYRAX
2400 scanner. The data set consists of 350,000 points imaged from
2. Evaluate the residual, εi = fi − s(xi ), at all nodes. several viewpoints in front of the statue. Three spheres apparent on
top of and beside the statue correspond to landmarks added to the
3. If max{|εi |} < fitting accuracy then stop. scene in order to align the scans. Fig. 8(a) is the point-cloud taken
from several scanner positions in front of the statue. Note the large
4. Else append new centers where εi is large. occluded regions where no data has been recorded. Fig. 8(b) is the
automatically fitted RBF surface. Fig. 8(c) is a detailed view of the
5. Re-fit RBF and goto 2. fitted surface which illustrates how the smoothness constraint inher-
ent in the biharmonic RBF has correctly preserved the gap between
If a different accuracy δi is specified at each point, then the condi- the arm and the rest of the statue, despite having no data in these
tion in step 3 may be replaced by |εi | < δi . regions. Along the cut-away planes in this figure we show the mag-
Center reduction is not essential when using the fast methods nitude of the RBF. Lighter colored points have smaller magnitudes,
described in Section 4. For example, no reduction was used when i.e., they are “closer” to the zero-surface than darker points.
fitting to the LIDAR example of Fig. 8. However, reducing the Fig. 9 illustrates the affect of varying ρ on a detailed portion of
number of RBF centers results in smaller memory requirements and the surface in Fig. 8. Fig. 9(a) is an exact fit to the raw data (ρ = 0),
faster evaluation times, without a loss in accuracy. Fig. 6 illustrates Fig. 9(b) is the value of ρ corresponding to Fig. 8(b) and Fig. 9(c)
the fitting process with center reduction. As more centers are added illustrates increased smoothing with a larger value for ρ.
to the RBF, the zero-surface more closely approximates the entire In this example a global value for ρ has been chosen, however,
set of data points. In this case, a laser scan of a Buddha figurine, by dividing Equation (9) by ρ it is possible to specify a particular
consisting of 544,000 points, has been approximated by an RBF smoothing parameter ρi for each data point or group of points.
with 80,000 centers to a relative accuracy of 1.4 × 10−4 (achieved
at all the data points).
The greedy algorithm often results in a net faster fitting time, 7 Surface evaluation
even with a moderate reduction in the number of centers. This
is due to the efficiencies associated with solving and evaluating a An RBF fitted to a set of surface data forms a solid model of an ob-
similar system at each iteration and the fact that initial iterations ject. The surface of the object is the locus of points where the RBF
involve solving much smaller problems. The results presented in is zero. This surface can be visualised directly using an implicit
Section 8 are typical of our experience and show that dense laser ray-tracer [9], or an intermediate explicit representation, such as a
scan data can be represented by significantly fewer centers than the mesh of polygons, can be extracted. In the latter case, well-known
total number of data points. iso-surfacing algorithms such as Marching Cubes [17] can be used
to polygonize the surface. However, conventional implementations
are optimised for visualising a complete volume of data sampled on
6 RBF approximation of noisy data a regular voxel grid. The cost associated with evaluating an RBF
means that an efficient surface-following algorithm is desirable.
In Section 3 we looked for an interpolant that minimized a measure In this paper a marching tetrahedra variant, optimised for surface
of smoothness. However, if there is noise in the data, the interpola- following, has been used to polygonize surfaces. A mesh optimisa-
tion conditions of Equation (2) are too strict and we would prefer to tion scheme adapted from [21] results in fewer triangles with better
place more emphasis on finding a smooth function, where smooth- aspect ratios, i.e., thin and elongated triangles are avoided. A typ-
ness is measured by Equation (4). Thus, consider the problem ical output mesh from this algorithm is illustrated in Fig. 10(b).
Wavefronts of facets spread out from seed points across the surface
N until they meet or intersect the bounding box. For clarity, a wave-
1

2
min ρksk2 + s(xi ) − fi , (9) front from a single seed is shown in red in Fig. 10(a) spreading over
s∈BL(2) (R3 ) N i=1 the surface of the Buddha figurine during iso-surfacing. Surface-
following is initiated from seed points corresponding to RBF cen-
where ρ ≥ 0 and k · k is defined in Equation (4). The parame- ters. By design, many centers will lie on, or very near, the surface.
ter ρ balances smoothness against fidelity to the data. It can be In the case of off-surface centers, the RBF gradient is used to search
shown [24] that the solution s? to this problem also has the form of for the nearest zero-crossing. Convergence is rapid because the
(a) (b) (c)

Figure 8: RBF approximation of noisy LIDAR data. (a) 350,000 point-cloud, (b) the smooth RBF surface approximates the original point-
cloud data, (c) cut-away view illustrating the RBF distance field and the preservation of the gap between the arm and the torso.

(a) (b) (c)

Figure 9: (a) Exact fit, (b) medium amount of smoothing applied (the RBF approximates at data points), (c) increased smoothing.

gradient is approximately constant near the surface. Local minima ted. Two off-surface points were generated for every second point
have not been observed in our experience, but this is not surprising in the original surface data, hence the number of interpolation nodes
since we deliberately constructed the function in Section 2 to have to which an RBF is fitted is approximately twice the number of sur-
these properties. In any case, only a small subset of centers is re- face points. Center reduction was used throughout, except in the
quired to seed the surface, one for each distinct surface section. The LIDAR example, where the number of RBF centers consequently
surface-following strategy avoids the conventional requirement for equals the number of interpolation nodes. Fitting and evaluation
a 3D array of sample points and therefore minimises the number of was performed on a 550MHz PIII Pentium with 512MB RAM.
RBF evaluations. Consequently, the computational cost increases Figs. 1(a), 3, 6, 12, 13 and 14 illustrate fitting surfaces to point-
with the square of the resolution, rather than the cube, as it would if clouds while Figs. 1(b) and 11 illustrate fitting to partial meshes.
a complete volume were sampled. Memory overhead is also min- Fig. 8 demonstrates approximation with an RBF in the context of
imised since it is only necessary to retain the sample vertices as- fitting a smooth surface to noisy LIDAR data.
sociated with the advancing wavefronts. Quadrilateral meshes can
The dragon in Fig. 1(a), the Buddha figurine (Fig. 6) and the
also be produced in this manner. Surfacing ambiguities can be re-
skeleton hand (Fig. 12) demonstrate the ability of fast methods to
solved easily due to the ability to analytically evaluate the gradient
model large complicated data sets to high accuracy and the com-
of the RBF.
pact nature of the RBF representation. The dragon data was derived
from a mesh consisting of 438,000 vertices and 871,000 faces, the
Buddha from 544,000 vertices and 1,087,000 faces. Normals were
8 Results computed at vertices from the adjacent faces. Direct methods would
inevitably fail on these problems. For example, a direct approach
Table 2 quantifies the fitting and evaluation times for the figures to fitting the Buddha data would require 4,700GB of storage just
presented in this paper. In all cases the biharmonic spline was fit- to store the matrix of the interpolation system (8). The peak core
(a) (b)

Figure 10: Iso-surfacing an RBF. (a) Surface-following from a single seed, (b) example of an optimised mesh.

Figure Number of Number of inter- Number of Peak RAM Fitting Surfacing Relative
surface points -polation nodes RBF centers (MB) time time accuracy
Face 14,806 29,074 3,564 29 68s 27s 7 ×10−4
Hand 13,348 26,696 4,299 29 97s 32s 1 ×10−3
Dragon 437,645 872,487 72,461 306 2:51:09 0:04:40 8 ×10−4
Buddha 543,652 1,086,194 80,518 291 4:03:26 0:04:07 5 ×10−4
Cherub statue 331,135 662,269 83,293 187 3:09:06 0:06:41 4 ×10−4
Skeleton hand 327,323 654,645 85,468 188 3:08:44 0:04:04 3 ×10−4
LIDAR statue 345,910 518,864 518,864 390 3:08:21 0:25:39 6 ×10−3

Table 2: Comparison of RBF fitting and evaluation times on a 550MHz PIII with 512MB RAM.

memory requirements of the new fast methods in Table 2 are par- data that an RBF representation offers. We have also listed the size
ticularly noteworthy in this respect. of the meshes derived from evaluating the RBF at a comparable
Fig. 1(b) and Fig. 11 illustrate the application of RBFs to mesh resolution to the original data. It appears from initial results that a
repair. In Fig. 1(b) an RBF is fitted to a partial mesh obtained from a promising application of RBFs is the remeshing of existing meshes.
laser scanner. This figure demonstrates the ability of the biharmonic Fitting an RBF not only fills holes, but a more uniform (and hence
spline to smoothly interpolate across large irregular holes, for ex- more compact) mesh can be derived from it.
ample under the chin, and smoothly extrapolate a surface far from
the data. In Fig. 11 an RBF has been fitted to a large statue data
set. Although carefully scanned, the statue contains many small
holes and larger holes corresponding to occluded regions between
the embracing figures. The fitted RBF has automatically filled all
the holes and generated a water-tight model of the statue without Finally, for the doubting reader, we demonstrate in Figure 14 that
the user having to specify any parameters other than the desired fit- a single RBF can model an extremely complicated surface with a
ting accuracy. Note how the fragment of shoulder data on the right high genus. In this case 594,000 centers were required to model
figurine has been extrapolated to reconstruct the missing chest data. the turbine blade to 10−4 accuracy. The fast evaluation methods
Fig. 13 illustrates the reconstruction of the asteroid Eros from described in Section 4 are essential for working with RBFs of this
scattered range data. This is a good example of non-uniformly size. The RBF has reproduced intricate internal structure along with
distributed data, often difficult to reconstruct using other methods. surface detail present in the original data. The point-cloud data
Furthermore, in this example the accuracy associated with the range were only available as a Marching Cubes (MC) mesh derived from
measurements varies at each point. X-ray CT data. However, if the CT data were available, then we
Table 3 compares the size of the original meshes in the dragon, would fit an RBF directly to the CT values. Specifically, we would
Buddha and skeletal hand data sets with the size of the equivalent fit to a subset of the data with values in the vicinity of the threshold
RBF representation. The uncompressed mesh sizes were derived used by Marching Cubes to iso-surface the data. This would result
by assigning 3 floats (12 bytes) to each vertex and 3 integers (12 in a smaller fitting problem since the MC mesh contains extraneous
bytes) to each triangular facet. The uncompressed RBF file size vertices and the construction of a signed-distance function, which
corresponds to representing each center with 3 floats (12 bytes) and requires adding off-surface points, would be avoided. Smooth RBF
each coefficient (λi ) with a double precision number (8 bytes). It is interpolation of the CT data would also be preferable to the linear
likely that single precision would be adequate, which would result interpolation used in the MC algorithm, particularly between CT
in more compression, but we have not yet quantified the effect of slices, which are usually spaced further apart relative to the pixel
coefficient precision on the evaluated surface. This table demon- resolution within a slice. An approximating spline could also be
strates the significant compression of both point-cloud and mesh used to reduce noise in the CT data.
Original mesh New mesh RBF representation
Figure # vertices # facets Storage # vertices # facets Storage RBF centers Storage
Dragon 437,645 847,414 15.4MB 126,998 254,016 4.5MB 72,461 1.4MB
Buddha 543,652 1,086,798 19.6MB 96,766 193,604 3.5MB 80,518 1.6MB
Skeleton hand 327,323 654,666 11.8MB 81,829 163,698 2.9MB 85,468 1.7MB

Table 3: Comparison of storage requirements for RBF representations and derived meshes.

Figure 11: An RBF has automatically filled small holes and extrap- Figure 13: RBF reconstruction of the asteroid Eros from non-
olated across occluded regions in the scan data (left), to produce uniformly distributed range data (top). Photograph and model from
a closed, water-tight model (right). The complex topology of the a similar view (bottom).
statue has been preserved.

a series of Boolean unions and intersections with other objects in


a manner similar to how simpler geometric primitives are currently
used to construct more complicated objects.
RBFs are also relevant to the problem of visualising volume data
acquired on an irregular grid, as can occur in medical imaging and
geophysical data. Here an RBF can be fitted to the sampled data
in order to approximate the underlying scalar distribution. Vector
fields can be modeled easily if the components are independent.
In that case, an RBF can be fitted to each field component. This
does not require much extra computation time since the matrix in
Equation (8) depends only on the location of the interpolation nodes
Figure 12: With sufficient sampling, complicated objects can be and is therefore common to each component RBF.
represented with RBFs. Planned future work includes improving the performance of
the reduction algorithm presented in Section 5. We have already
achieved better reductions in the number of centers than those given
9 Summary and future work in Table 2 but at the cost of slower fitting times. For example, the
dragon has been modeled by as few as 32,000 centers and the Bud-
Fast methods make it computationally possible to represent com- dha by 42,000 centers, to the same fitting accuracy. This improve-
plicated objects of arbitrary topology by RBFs. The scale- ment was achieved by simply adding fewer centers to the RBF at
independent, “smoothest interpolator” characterisation of polyhar- each iteration. The global nature of the RBF representation implies
monic splines make RBFs particularly suited to fitting surfaces to RBFs inherit the drawbacks of any global model when manipula-
non-uniformly sampled point-clouds and partial meshes that con- tion of part of that model or ray-tracing is required. However, we
tain large irregular holes. The smoothest surface, most consistent believe that it should be straightforward to decompose a global RBF
with the input data, is produced. Details are resolved, provided they description into a piecewise mesh of implicit surface patches in the
are adequately sampled. The functional nature of the RBF represen- spirit of [1] to facilitate local manipulation and ray-tracing. Future
tation offers new possibilities for surface registration algorithms, speed improvements in computing and evaluating RBFs are likely
mesh simplification, compression and smoothing algorithms. to come from the inherent suitability of the algorithms to parallel
Within a Constructive Solid Geometry (CSG) framework the processing and by tailoring to particular applications. In particular,
RBF offers a new way of modeling real-world (scanned) objects we believe that significant speed improvements are likely if the data
since it is inherently a solid model. It can be manipulated through lie on a grid, albeit an incompletely sampled grid.
Figure 14: Solid and semi-transparent renderings of an RBF model of a turbine blade containing intricate internal structure. The RBF has
594,000 centers.

10 Acknowledgements [11] E. W. Cheney and W. A. Light. A Course in Approximation Theory. Brooks


Cole, Pacific Grove, 1999.
This research has been supported by FRST contracts DRFX-9902, [12] J. Duchon. Splines minimizing rotation-invariant semi-norms in Sobolev spaces.
DRFX-0001 and ARA-801. We are grateful to Stanford Computer In W. Schempp and K. Zeller, editors, Constructive Theory of Functions of Sev-
Graphics Laboratory for the Buddha and Dragon data, to Cornell eral Variables, number 571 in Lecture Notes in Mathematics, pages 85–100,
University and NASA for the Eros data, to Georgia Institute of Berlin, 1977. Springer-Verlag.
Technology and the Large Geometric Models Archive for the tur- [13] N. Dyn, D. Levin, and S. Rippa. Numerical procedures for surface fitting of
bine and skeleton data, to Allen Instruments and Supplies, USA, scattered data by radial functions. SIAM J. Sci. Stat. Comput., 7(2):639–659,
for the LIDAR data and Polhemus FastSCAN for all other data. 1986.
[14] J. Flusser. An adaptive method for image registration. Pattern Recognition,
References 25(1):45–54, 1992.
[15] L. Greengard and V. Rokhlin. A fast algorithm for particle simulations. J. Com-
[1] C. Bajaj, J. Chen, and G. Xu. Modeling with cubic a-patches. ACM Transactions
put. Phys, 73:325–348, 1987.
on Computer Graphics, 14(2):103–133, 1995.
[16] H. Hoppe, T. DeRose, T. Duchamp, J. McDonald, and W. Stuetzle. Surface re-
[2] R. K. Beatson, J. B. Cherrie, and C. T. Mouat. Fast fitting of radial basis func-
constuction from unorganized points. Computer Graphics (SIGGRAPH’92 pro-
tions: Methods based on preconditioned GMRES iteration. Advances in Compu-
ceedings), 26(2):71–78, July 1992.
tational Mathematics, 11:253–270, 1999.
[17] W. E. Lorensen and H. E. Cline. Marching cubes: A high resolution 3D surface
[3] R. K. Beatson, J. B. Cherrie, and D. L. Ragozin. Fast evaluation of radial basis
construction algorithm. Computer Graphics, 21(4):163–169, July 1987.
functions: Methods for four-dimensional polyharmonic splines. SIAM J. Math.
Anal., 32(6):1272–1310, 2001. [18] C. A. Micchelli. Interpolation of scattered data: Distance matrices and condi-
[4] R. K. Beatson and L. Greengard. A short course on fast multipole methods. tionally positive definite functions. Constr. Approx., 2:11–22, 1986.
In M. Ainsworth, J. Levesley, W.A. Light, and M. Marletta, editors, Wavelets, [19] V. V. Savchenko, A. A. Pasko, O. G. Okunev, and T. L. Kunii. Function rep-
Multilevel Methods and Elliptic PDEs, pages 1–37. Oxford University Press, resentation of solids reconstructed from scattered surface points and contours.
1997. Computer Graphics Forum, 14(4):181–188, 1995.
[5] R. K. Beatson and W. A. Light. Fast evaluation of radial basis functions: Methods [20] R. Sibson and G. Stone. Computation of thin-plate splines. SIAM J. Sci. Stat.
for two-dimensional polyharmonic splines. IMA Journal of Numerical Analysis, Comput., 12(6):1304–1313, 1991.
17:343–372, 1997.
[21] G. M. Treece, R. W. Prager, and A. H. Gee. Regularised marching tetrahedra: im-
[6] R. K. Beatson, W. A. Light, and S. Billings. Fast solution of the radial basis proved iso-surface extraction. Computers and Graphics, 23(4):583–598, 1999.
function interpolation equations: Domain decomposition methods. SIAM J. Sci.
Comput., 22(5):1717–1740, 2000. [22] G. Turk and J. F. O’Brien. Shape transformation using variational implicit sur-
faces. In SIGGRAPH’99, pages 335–342, Aug 1999.
[7] R. K. Beatson, A. M. Tan, and M. J. D. Powell. Fast evaluation of radial basis
functions: Methods for 3-dimensional polyharmonic splines. In preparation. [23] G. Turk and J. F. O’Brien. Variational implicit surfaces. Technical Report GIT-
GVU-99-15, Georgia Institute of Technology, May 1999.
[8] F. Bernardini, C. L. Bajaj, J. Chen, and D. R. Schikore. Automatic reconstruction
of 3D CAD models from digital scans. Int. J. on Comp. Geom. and Appl., 9(4– [24] G. Wahba. Spline Models for Observational Data. Number 59 in CBMS-NSF
5):327, Aug & Oct 1999. Regional Conference Series in Applied Math. SIAM, 1990.
[9] J. Bloomenthal, editor. Introduction to Implicit Surfaces. Morgan Kaufmann, [25] G. Yngve and G. Turk. Creating smooth implicit surfaces from polygonal
San Francisco, California, 1997. meshes. Technical Report GIT-GVU-99-42, Georgia Institute of Technology,
1999.
[10] J. C. Carr, W. R. Fright, and R. K. Beatson. Surface interpolation with radial
basis functions for medical imaging. IEEE Trans. Medical Imaging, 16(1):96–
107, February 1997.

You might also like