Download Data mining with sparse grids using simplicial basis functions

Survey
yes no Was this document useful for you?
   Thank you for your participation!

* Your assessment is very important for improving the workof artificial intelligence, which forms the content of this project

Document related concepts

Nonlinear dimensionality reduction wikipedia , lookup

Transcript
Data mining with sparse grids
using simplicial basis functions
Jochen Garcke and Michael Griebel
Institut für Angewandte Mathematik
Abteilung für wissenschaftliches Rechnen und numerische Simulation
Universität Bonn
Wegelerstraße 6
D-53115 Bonn, Germany
(garckej, griebel)@iam.uni-bonn.de
ABSTRACT
1.
Recently we presented a new approach [18] to the classification problem arising in data mining. It is based on the
regularization network approach but, in contrast to other
methods which employ ansatz functions associated to data
points, we use a grid in the usually high-dimensional feature
space for the minimization process. To cope with the curse
of dimensionality, we employ sparse grids [49]. Thus, only
d−1
O(h−1
) instead of O(h−d
n n
n ) grid points and unknowns are
involved. Here d denotes the dimension of the feature space
and hn = 2−n gives the mesh size. We use the sparse grid
combination technique [28] where the classification problem
is discretized and solved on a sequence of conventional grids
with uniform mesh sizes in each dimension. The sparse grid
solution is then obtained by linear combination. In contrast
to our former work, where d-linear functions were used, we
now apply linear basis functions based on a simplicial discretization. This allows to handle more dimensions and the
algorithm needs less operations per data point.
We describe the sparse grid combination technique for
the classification problem, give implementational details and
discuss the complexity of the algorithm. It turns out that
the method scales linearly with the number of given data
points. Finally we report on the quality of the classifier built
by our new method on data sets with up to 10 dimensions.
It turns out that our new method achieves correctness rates
which are competitive to that of the best existing methods.
Data mining is the process of finding patterns, relations
and trends in large data sets. Examples range from scientific applications like the post-processing of data in medicine
or the evaluation of satellite pictures to financial and commercial applications, e.g. the assessment of credit risks or
the selection of customers for advertising campaign letters.
For an overview on data mining and its various tasks and
approaches see [5, 12].
In this paper we consider the classification problem arising in data mining. Given is a set of data points in a ddimensional feature space together with a class label. From
this data, a classifier must be constructed which allows to
predict the class of any newly given data point for future decision making. Widely used approaches are, besides others,
decision tree induction, rule learning, adaptive multivariate regression splines, neural networks, and support vector
machines. Interestingly, some of these techniques can be interpreted in the framework of regularization networks [21].
This approach allows a direct description of the most important neural networks and it also allows for an equivalent
description of support vector machines and n-term approximation schemes [20]. Here, the classification of data is interpreted as a scattered data approximation problem with
certain additional regularization terms in high-dimensional
spaces.
In [18] we presented a new approach to the classification
problem. It is also based on the regularization network approach but, in contrast to the other methods which employ
mostly global ansatz functions associated to data points, we
use an independent grid with associated local ansatz functions in the minimization process. This is similar to the
numerical treatment of partial differential equations. Here,
a uniform grid would result in O(h−d
n ) grid points, where d
denotes the dimension of the feature space and hn = 2−n
gives the mesh size. Therefore the complexity of the problem
would grow exponentially with d and we encounter the curse
of dimensionality. This is probably the reason why conventional grid-based techniques are not used in data mining up
to now.
However, there is the so-called sparse grids approach which
allows to cope with the complexity of the problem to some
extent. This method has been originally developed for the
solution of partial differential equations [2, 8, 28, 49] and
Keywords
data mining, classification, approximation, sparse grids, combination technique, simplicial discretization
Permission to make digital or hard copies of all or part of this work for
personal or classroom use is granted without fee provided that copies are
not made or distributed for profit or commercial advantage and that copies
bear this notice and the full citation on the first page. To copy otherwise, to
republish, to post on servers or to redistribute to lists, requires prior specific
permission and/or a fee.
Copyright 2001 ACM X-XXXXX-XX-X/XX/XX ...$5.00.
INTRODUCTION
is now used successfully also for integral equations [14, 27],
interpolation and approximation [3, 26, 39, 42], eigenvalue
problems [16] and integration problems [19]. In the information based complexity community it is also known as ’hyperbolic cross points’ and the idea can even be traced back to
[41]. For a d-dimensional problem, the sparse grid approach
−1 d−1
employs only O(h−1
) grid points in the disn (log(hn ))
cretization. The accuracy of the approximation however is
nearly as good as for the conventional full grid methods, provided that certain additional smoothness requirements are
fulfilled. Thus a sparse grid discretization method can be
employed also for higher-dimensional problems. The curse
of the dimensionality of conventional ’full’ grid methods affects sparse grids much less.
In this paper, we apply the sparse grid combination technique [28] to the classification problem. For that the regularization network problem is discretized and solved on a
certain sequence of conventional grids with uniform mesh
sizes in each coordinate direction. In contrast to [18], where
d-linear functions stemming from a tensor-product approach
were used, we now apply linear basis functions based on a
simplicial discretization. In comparison, this approach allows the processing of more dimensions and needs less operations per data point. The sparse grid solution is then
obtained from the solutions on the different grids by linear combination. Thus the classifier is build on sparse grid
points and not on data points. A discussion of the complexity of the method gives that the method scales linearly
with the number of instances, i.e. the amount of data to be
classified. Therefore, our method is well suited for realistic
data mining applications where the dimension of the feature space is moderately high (e.g. after some preprocessing
steps) but the amount of data is very large. Furthermore
the quality of the classifier build by our new method seems
to be very good. Here we consider standard test problems
from the UCI repository and problems with huge synthetical
data sets in up to 10 dimensions. It turns out that our new
method achieves correctness rates which are competitive to
those of the best existing methods. Note that the combination method is simple to use and can be parallelized in a
natural and straightforward way.
The remainder of this paper is organized as follows: In
Section 2 we describe the classification problem in the framework of regularization networks as minimization of a (quadratic) functional. We then discretize the feature space and
derive the associated linear problem. Here we focus on gridbased discretization techniques. Then, we introduce the
sparse grid combination technique for the classification problem and discuss its properties. Furthermore, we present a
new variant based on a discretization by simplices and discuss complexity aspects. Section 3 presents the results of
numerical experiments conducted with the sparse grid combination method, demonstrates the quality of the classifier
build by our new method and compares the results with
the ones from [18] and with the ones obtained with different
forms of SVMs [33]. Some final remarks conclude the paper.
2.
THE PROBLEM
Classification of data can be interpreted as traditional
scattered data approximation problem with certain additional regularization terms. In contrast to conventional scattered data approximation applications, we now encounter
quite high-dimensional spaces. To this end, the approach of
regularization networks [21] gives a good framework. This
approach allows a direct description of the most important
neural networks and it also allows for an equivalent description of support vector machines and n-term approximation
schemes [20].
Consider the given set of already classified data (the training set)
S = {(xi , yi ) ∈ Rd × R}M
i=1 .
Assume now that these data have been obtained by sampling
of an unknown function f which belongs to some function
space V defined over Rd . The sampling process was disturbed by noise. The aim is now to recover the function f
from the given data as good as possible. This is clearly an
ill-posed problem since there are infinitely many solutions
possible. To get a well-posed, uniquely solvable problem we
have to assume further knowledge on f . To this end, regularization theory [43, 47] imposes an additional smoothness constraint on the solution of the approximation problem and the regularization network approach considers the
variational problem
min R(f )
f ∈V
with
R(f ) =
m
1 X
C(f (xi ), yi ) + λΦ(f ).
M i=1
(1)
Here, C(., .) denotes an error cost function which measures
the interpolation error and Φ(f ) is a smoothness functional
which must be well defined for f ∈ V . The first term enforces closeness of f to the data, the second term enforces
smoothness of f and the regularization parameter λ balances
these two terms. Typical examples are
C(x, y) = |x − y| or C(x, y) = (x − y)2 ,
and
Φ(f ) = ||P f ||22
with
P f = ∇f or P f = ∆f,
with ∇ denoting the gradient and ∆ the Laplace operator.
The value of λ can be chosen according to cross-validation
techniques [13, 22, 37, 44] or to some other principle, such as
structural risk minimization [45]. Note that we find exactly
this type of formulation in the case d = 2, 3 in scattered data
approximation methods, see [1, 31], where the regularization
term is usually physically motivated.
2.1
Discretization
We now restrict the problem to a finite dimensional subspace VN ∈ V . The function f is then replaced by
fN =
N
X
αj ϕj (x).
(2)
j=1
Here the ansatz functions {ϕj }N
j=1 should span VN and preferably should form a basis for VN . The coefficients {αj }N
j=1
denote the degrees of freedom. Note that the restriction to
a suitably chosen finite-dimensional subspace involves some
additional regularization (regularization by discretization)
which depends on the choice of VN .
In the remainder of this paper, we restrict ourselves to the
choice
C(fN (xi ), yi ) = (fN (xi ) − yi )2
and
Φ(fN ) =
||P fN ||2L2
(3)
for some given linear operator P . This way we obtain from
the minimization problem a feasible linear system. We thus
have to minimize
R(fN ) =
1
M
M
X
(fN (xi ) − yi )2 + λkP fN k2L2 ,
(4)
with fN in the finite dimensional space VN . We plug (2)
into (4) and obtain after differentiation with respect to αk ,
k = 1, . . . , N
!
M
N
∂R(fN )
2 X X
αj ϕj (xi ) − yi · ϕk (xi )
0=
=
∂αk
M i=1 j=1
+ 2λ
αj (P ϕj , P ϕk )L2
(5)
j=1
This is equivalent to (k = 1, . . . , N )
"
#
N
M
X
X
αj M λ(P ϕj , P ϕk )L2 +
ϕj (xi ) · ϕk (xi )
j=1
i=1
=
M
X
yi ϕk (xi ).
(6)
i=1
In matrix notation we end up with the linear system
(λC + B · B T )α = By.
(7)
Here C is a square N × N matrix with entries Cj,k = M ·
(P ϕj , P ϕk )L2 , j, k = 1, . . . , N , and B is a rectangular N ×
M matrix with entries Bj,i = ϕj (xi ), i = 1, . . . , M, j =
1, . . . , N . The vector y contains the data labels yi and has
length M . The unknown vector α contains the degrees of
freedom αj and has length N .
Depending on the regularization operator we obtain different minimization problems in VN . For example if we use
the gradient Φ(fN ) = ||∇fN ||2L2 in the regularization expression in (1) we obtain a Poisson problem with an additional term which resembles the interpolation problem. The
natural boundary conditions for such a partial differential
equation are Neumann conditions. The discretization (2)
gives us then the linear system (7) where C corresponds to
a discrete Laplacian. To obtain the classifier fN we now
have to solve this system.
2.2
n
2
X
(fN (x) =)fn (x) =
i=1
N
X
refinement level. In the following we always use the gradient
P = ∇ in the regularization expression (3). Let j denote the
multi-index (j1 , ..., jd ) ∈ Nd . A finite element method with
piecewise d-linear, i.e. linear in each dimension, test- and
trial-functions φn,j (x) on grid Ωn now would give
Grid based discrete approximation
Up to now we have not yet been specific what finitedimensional subspace VN and what type of basis functions
{ϕj }N
j=1 we want to use. In contrast to conventional data
mining approaches which work with ansatz functions associated to data points we now use a certain grid in the attribute
space to determine the classifier with the help of these grid
points. This is similar to the numerical treatment of partial
differential equations.
For reasons of simplicity, here and in the the remainder of
this paper, we restrict ourself to the case xi ∈ Ω = [0, 1]d .
This situation can always be reached by a proper rescaling
of the data space. A conventional finite element discretization would now employ an equidistant grid Ωn with mesh
size hn = 2−n for each coordinate direction, where n is the
n
...
j1 =0
2
X
αn,j φn,j (x)
jd =0
and the variational procedure (4) - (6) would result in the
discrete linear system
(λCn + Bn · BnT )αn = Bn y
n
(8)
d
of size (2 + 1) and matrix entries corresponding to (7).
Note that fn lives in the space
Vn := span{φn,j , jt = 0, .., 2n , t = 1, ..., d}.
The discrete problem (8) might in principle be treated by
an appropriate solver like the conjugate gradient method, a
multigrid method or some other suitable efficient iterative
method. However, this direct application of a finite element
discretization and the solution of the resulting linear system by an appropriate solver is clearly not possible for a
d-dimensional problem if d is larger than four. The numnd
ber of grid points is of the order O(h−d
n ) = O(2 ) and, in
the best case, the number of operations is of the same order.
Here we encounter the so-called curse of dimensionality: The
complexity of the problem grows exponentially with d. At
least for d > 4 and a reasonable value of n, the arising system can not be stored and solved on even the largest parallel
computers today.
2.3
The sparse grid combination technique
Therefore we proceed as follows: We discretize and solve
the problem on a certain sequence of grids Ωl = Ωl1 ,...,ld
with uniform mesh sizes ht = 2−lt in the t-th coordinate
direction. These grids may possess different mesh sizes for
different coordinate directions. To this end, we consider all
grids Ωl with
l1 + ... + ld = n + (d − 1) − q,
q = 0, .., d − 1,
lt > 0. (9)
For the two-dimensional case, the grids needed in the combination formula of level 4 are shown in Figure 1. The finite element approach with piecewise d-linear test- and trialfunctions
φl,j (x) :=
d
Y
φlt ,jt (xt )
(10)
t=1
on grid Ωl now would give
l
fl (x) =
2 1
X
l
...
j1 =0
2 d
X
αl,j φl,j (x)
jd =0
and the variational procedure (4) - (6) would result in the
discrete system
(λCl + Bl · BlT )αl = Bl y
(11)
with the matrices
(Cl )j,k = M · (∇φl,j , ∇φl,k )
lt
and
(Bl )j,i = φl,j (xi ),
jt , kt = 0, ..., 2 , t = 1, ..., d, i = 1, ..., M, and the unknown
vector (αl )j , jt = 0, ..., 2lt , t = 1, ..., d. We then solve these
ppppppppppppppppp
p
p
ppppppppppppppppp ⊕ p
p
ppppppppppppppppp
p
Ω4,1
p
p
p
p
p
p
p
p
p
p
p
p
p
p
p
p
p
p
p
p
p
p
p
p
p
Ω3,2
p
p
p
p
p
p
p
p
p
p
p
p
p
p
p
p
p⊕ p
p
p
p
p
p
p
p p p p p p p p p
p
p
p
p
p
p
p
p
p
p
p
p
p
p p p p p p p p p
p
Ω3,1
p
p
p
p
p
p
p
p
p
p
p
p
p
p
p
p
p
p
p
p
p
p
p
p
p
p
p
p
p
p
p
p
p
pp
p
pp
p
ppp
p
p ⊕ ppp
p
pp
p
pp
p
ppp
p
p
p
p
p
p
p
p
p
p
p
p
p
p
p
p
p
p p
p
p
p
p
p
p
Ω2,3
Ω2,2
pp
pp
ppp
pp
pp
ppp
pp
p
pp
pp
ppp
pp
pp
ppp
pp
p
p
p
p
p
p
p
p
p
p
p
p
p
p
p
p
p
p
p
Ω1,4
Ω1,3
pp p p p p p p p pp p p p p p p p pp
pp p pp p pp
pp p p p pp p p p pp
p p p p p
= pppp p p p pp p p p pppp p p p pp p p p pppp
pp p p p pp p p p pp
pp p pp p pp
pp p p p p p p p pp p p p p p p p pp
Ωc4,4
Figure 1: Combination technique with level n = 4 in
two dimensions
problems by a feasible method. To this end we use here
a diagonally preconditioned conjugate gradient algorithm.
But also an appropriate multigrid method with partial semicoarsening can be applied. The discrete solutions fl are
contained in the spaces
Vl := span{φl,j , jt = 0, ..., 2lt , t = 1, ..., d},
(12)
of piecewise d-linear functions on grid Ωl .
Note that all these problems are substantially reduced in
size in comparison to (8). Instead of one problem with size
nd
dim(Vn ) = O(h−d
n ) = O(2 ), we now have to deal with
n
O(dnd−1 ) problems of size dim(Vl ) = O(h−1
n ) = O(2 ).
Moreover, all these problems can be solved independently,
which allows for a straightforward parallelization on a coarse
grain level, see [23]. There is also a simple but effective static
load balancing strategy available [25].
PFinally we linearly combine the results fl (x) ∈ Vl , fl =
j αl,j φl,j (x), from the different grids Ωl as follows:
!
d−1
X
X
(c)
q d−1
fn (x) :=
(−1)
fl (x).
(13)
q
q=0
|l|1 =n+(d−1)−q
The resulting function
(c)
fn
Vn(s) :=
lives in the sparse grid space
[
Vl .
l1 + ... + ld = n + (d − 1) − q
q = 0, ..., d − 1 lt > 0
(s)
−1 d−1
This space has dim(Vn ) = O(h−1
). It is
n (log(hn ))
spanned by a piecewise d-linear hierarchical tensor product
basis, see [8].
Note that the summation of the discrete functions from
different spaces Vl in (13) involves d-linear interpolation
which resembles just the transformation to a representation
in the hierarchical basis. For details see [24, 28, 29]. How(c)
ever we never explicitly assemble the function fn but keep
instead the solutions fl on the different grids Ωl which arise
in the combination formula. Now, any linear operation F
(c)
on fn can easily be expressed by means of the combination
Figure 2: Two-dimensional sparse grid (left) and
three-dimensional sparse grid (right), n = 5
formula (13) acting directly on the functions fl , i.e.
!
d−1
X
X
(c)
q d−1
F(fl ). (14)
F(fn ) =
(−1)
q
q=0
l1 +...+ld =n+(d−1)−q
Therefore, if we now want to evaluate a newly given set
of data points {x̃i }M̃
i=1 (the test or evaluation set) by
ỹi := fn(c) (x̃i ),
i = 1, ..., M̃
we just form the combination of the associated values for fl
according to (13). The evaluation of the different fl in the
test points can be done completely in parallel, their summation needs basically an all-reduce/gather operation.
For second order elliptic PDE model problems, it was
(c)
proven that the combination solution fn is almost as accurate as the full grid solution fn , i.e. the discretization error
satisfies
(c)
2
−1 d−1
||e(c)
)
n ||Lp := ||f − fn ||Lp = O(hn log(hn )
provided that a slightly stronger smoothness requirement
on f than for the full grid approach holds. We need the
seminorm
2d
∂ f (15)
|f |∞ := Qd
j=1 ∂x2j ∞
to be bounded. Furthermore, a series expansion of the error
is necessary for the combination technique. Its existence was
shown for PDE model problems in [10].
The combination technique is only one of the various methods to solve problems on sparse grids. Note that there exist
also finite difference [24, 38] and Galerkin finite element approaches [2, 8, 9] which work directly in the hierarchical
product basis on the sparse grid. But the combination technique is conceptually much simpler and easier to implement.
Moreover it allows to reuse standard solvers for its different
subproblems and is straightforwardly parallelizable.
2.4
Simplicial basis functions
So far we only mentioned d-linear basis functions based on
a tensor-product approach, this case was presented in detail
in [18]. But on the grids of the combination technique linear
basis functions based on a simplicial discretization are also
possible. For that we use the so-called Kuhn’s triangulation
[15, 32] for each rectangular block, see Figure 3. Now, the
summation of the discrete functions for the different spaces
Vl in (13) only involves linear interpolation.
Table 1: Complexities of the storage, the assembly and the matrix-vector multiplication for the different
matrices arising in the combination method on one grid Ωl for both discretization approaches. Cl and Gl can
be stored together in one matrix structure.
d-linear basis functions
linear basis functions
Cl
Gl := Bl · BlT
Bl
Cl
Gl := Bl · BlT
Bl
storage
O(3d · N )
O(3d · N )
O(2d · M )
O((2 · d + 1) · N )
O(2d · N )
O((d + 1) · M )
assembly
O(3d · N ) O(d · 22d · M ) O(d · 2d · M ) O((2 · d + 1) · N ) O((d + 1)2 · M ) O((d + 1) · M )
mv-multiplication O(3d · N )
O(3d · N )
O(2d · M )
O((2 · d + 1) · N )
O(2d · N )
O((d + 1) · M )
(1,1,1)
(0,0,0)
Figure 3:
Kuhn’s triangulation
dimensional unit cube
of
a
three-
The theroetical properties of this variant of the sparse grid
technique still has to be investigated in more detail. However the results which are presented in section 3 warrant its
use. We see, if at all, just slightly worse results with linear
basis functions than with d-linear basis functions and we
believe that our new approach results in the same approximation order.
Since in our new variant of the combination technique the
overlap of supports, i.e. the regions where two basis functions are both non-zero, is greatly reduced due to the use of a
simplicial discretization, the complexities scale significantly
better. This concerns both the costs of the assembly and
the storage of the non-zero entries of the sparsely populated
matrices from (8), see Table 1. Note that for general operators P the complexities for Cl scale with O(2d · N ). But for
our choice of P = ∇ structural zero-entries arise, which need
not to be considered, and which further reduce the complexities, see Table 1 (right), column Cl . The actual iterative
solution process (by a diagonally preconditioned conjugate
gradient method) scales independent of the number of data
points for both approaches.
Note however that both the storage and the run time
complexities still depend exponentially on the dimension d.
Presently, due to the limitations of the memory of modern
workstations (512 MByte - 2 GByte), we therefore can only
deal with the case d ≤ 8 for d-linear basis functions and
d ≤ 11 for linear basis functions. A decomposition of the
matrix entries over several computers in a parallel environment would permit more dimensions.
3.
NUMERICAL RESULTS
We now apply our approach to different test data sets.
Here we use both synthetical data and real data from practical data mining applications. All the data sets are rescaled
to [0, 1]d . To evaluate our method we give the correctness
rates on testing data sets, if available, or the ten-fold crossvalidation results otherwise. For further details and a criti-
Figure 4: Spiral data set, sparse grid with level 5
(top left) to 8 (bottom right)
cal discussion on the evaluation of the quality of classification algorithms see [13, 37].
3.1
Two-dimensional problems
We first consider synthetic two-dimensional problems with
small sets of data which correspond to certain structures.
3.1.1
Spiral
The first example is the spiral data set, proposed by Alexis
Wieland of MITRE Corp [48]. Here, 194 data points describe two intertwined spirals, see Figure 4. This is surely
an artificial problem which does not appear in practical applications. However it serves as a hard test case for new
data mining algorithms. It is known that neural networks
can have severe problems with this data set and some neural
networks can not separate the two spirals at all [40].
In Table 2 we give the correctness rates achieved with the
leave-one-out cross-validation method, i.e. a 194-fold crossvalidation. The best testing correctness was achieved on
level 8 with 89.18% in comparison to 77.20% in [40].
In Figure 4 we show the corresponding results obtained
with our sparse grid combination method for the levels 5
to 8. With level 7 the two spirals are clearly detected and
resolved. Note that here 1281 grid points are contained in
the sparse grid. For level 8 (2817 sparse grid points) the
shape of the two reconstructed spirals gets smoother and
level
1
2
3
4
5
6
7
8
9
10
level
5
6
7
8
9
λ
0.0003
0.0006
0.00075
0.0006
0.0006
Table 3: Results for the Ripley data set
linear basis
d-linear basis best possible %
ten-fold test %
λ
test data %
test data %
linear d-linear
85.2
0.0020
89.9
89.8
90.6
90.3
85.2
0.0065
90.3
90.4
90.4
90.9
88.4
0.0020
90.9
90.6
91.0
91.2
87.2
0.0035
91.4
90.6
91.4
91.2
88.0
0.0055
91.3
90.9
91.5
91.1
86.8
0.0045
90.7
90.8
90.7
90.8
86.8
0.0008
89.0
88.8
91.1
91.0
87.2
0.0037
91.0
89.7
91.2
91.0
87.7
0.0015
90.1
90.9
91.1
91.0
89.2
0.0020
91.0
90.6
91.2
91.1
training correctness
94.87 %
97.42 %
100.00 %
100.00 %
100.00 %
testing correctness
82.99 %
84.02 %
88.66 %
89.18 %
88.14 %
Table 2: Leave-one-out cross-validation results for
the spiral data set
the reconstruction gets more precise.
3.1.2
Ripley
This data set, taken from [36], consists of 250 training
data and 1000 test points. The data set was generated synthetically and is known to exhibit 8 % error. Thus no better
testing correctness than 92 % can be expected.
Since we now have training and testing data, we proceed
as follows: First we use the training set to determine the best
regularization parameter λ per ten-fold cross-validation. The
best test correctness rate and the corresponding λ are given
for different levels n in the first two columns of Table 3.
With this λ we then compute the sparse grid classifier from
the 250 training data. The column three of Table 3 gives
the result of this classifier on the (previously unknown) test
data set. We see that our method works well. Already level
4 is sufficient to obtain results of 91.4 %. The reason is
surely the relative simplicity of the data, see Figure 5. Just
a few hyperplanes should be enough to separate the classes
quite properly. We also see that there is not much need
to use any higher levels, on the contrary there is even an
overfitting effect visible in Figure 5.
In column 4 we show the results from [18], there we achieve
almost the same results with d-linear functions.
To see what kind of results could be possible with a more
sophisticated strategy for determing λ we give in the last two
columns of Table 3 the testing correctness which is achieved
for the best possible λ. To this end we compute for all
(discrete) values of λ the sparse grid classifiers from the 250
data points and evaluate them on the test set. We then pick
the best result. We clearly see that there is not much of
a difference. This indicates that the approach to determine
the value of λ from the training set by cross-validation works
well. Again we have almost the same results with linear and
d-linear basis functions. Note that a testing correctness of
Figure 5: Ripley data set, combination technique
with linear basis functions. Left: level 4, λ = 0.0035.
Right: level 8, λ = 0.0037
90.6 % and 91.1 % was achieved in [36] and [35], respectively,
for this data set.
3.2
3.2.1
6-dimensional problems
BUPA Liver
The BUPA Liver Disorders data set from Irvine Machine
Learning Database Repository [6] consists of 345 data points
with 6 features and a selector field used to split the data
into 2 sets with 145 instances and 200 instances respectively.
Here we have no test data and therefore can only report our
ten-fold cross-validation results.
We compare with our d-linear results from [18] and with
the two best results from [33], the therein introduced smoothed support vector machine (SSVM) and the classical support
vector machine (SVM||.||2 ) [11, 46]. The results are given in
2
Table 4.
As expected, our sparse grid combination approach with
linear basis functions performs slightly worse than the dlinear approach. The best test result was 69.60% on level
4. The new variant of the sparse grid combination technique performs only slightly worse than the SSVM, whereas
the d-linear variant performs slighly better than the support
vector machines. Note that the results for other SVM approaches like the support vector machine using the 1-norm
approach (SVM||.||1 ) were reported to be somewhat worse
in [33].
level 1
level 2
level 3
level 4
3.2.2
Table 4: Results for the BUPA liver disorders data set
linear
d-linear
For comparison with
λ
%
λ
%
other methods
10-fold train. correctness 0.012 76.00 0.020 76.00
SVM [33]
10-fold test. correctness
69.00
67.87 SSVM
SVM||.||2
2
10-fold train. correctness 0.040 76.13
0.10
77.49
70.37
70.57
10-fold test. correctness
66.01
67.84
70.33
69.86
10-fold train. correctness 0.165 78.71 0.007 84.28
10-fold test. correctness
66.41
70.34
10-fold train. correctness 0.075 92.01 0.0004 90.27
10-fold test. correctness
69.60
70.92
Synthetic massive data set in 6D
To measure the performance on a massive data set we
produced with DatGen [34] a 6-dimensional test case with
5 million training points and 20 000 points for testing. We
used the call datgen -r1 -X0/100,R,O:0/100,R,O:0/100,R,O:
0/100,R,O:0/200,R,O:0/200,R,O -R2 -C2/4 -D2/5 -T10/60
-O5020000 -p -e0.15.
The results are given in Table 5. Note that already on level
1 a testing correctness of over 90 % was achieved with just
λ = 0.01. The main observation on this test case concerns
the execution time, measured on a Pentium III 700 MHz
machine. Besides the total run time, we also give the CPU
time which is needed for the computation of the matrices
Gl = Bl · BlT .
We see that with linear basis functions really huge data
sets of 5 million points can be processed in reasonable time.
Note that more than 50 % of the computation time is spent
for the data matrix assembly only and, more importantly,
that the execution time scales linearly with the number of
data points. The latter is also the case for the d-linear functions, but, as mentioned, this approach needs more operations per data point and results in a much longer execution
time, compare also Table 5. Especially the assembly of the
data matrix needs more than 96 % of the total run time for
this variant. For our present example the linear basis approach is about 40 times faster than the d-linear approach
on the same refinement level, e.g. for level 2 we need 17
minutes in the linear case and 11 hours in the d-linear case.
For higher dimensions the factor will be even larger.
3.3
3.3.1
10-dimensional problems
Forest cover type
The forest cover type dataset comes from the UCI KDD
Archive [4], it was also used in [30], where an approach similar to ours was followed. It consists of cartographic variables
for 30 x 30 meter cells and a forest cover type is to be predicted. The 12 originally measured attributes resulted in 54
attributes in the data set, besides 10 quantitative variables
there are 4 binary wilderness areas and 40 binary soil type
variables. We only use the 10 quantitative variables. The
class label has 7 values, Spruce/Fir, Lodgepole Pine, Ponderosa Pine, Cottonwood/Willow, Aspen, Douglas-fir and
Krummholz. Like [30] we only report results for the classification of Ponderosa Pine, which has 35754 instances out of
the total 581012.
Since far less than 10 % of the instances belong to Ponderosa Pine we weigh this class with a factor of 5, i.e. Ponderosa Pine has a class value of 5, all others of -1 and the
treshold value for separating the classes is 0. The data set
was randomly separated into a training set, a test set, and
a evaluation set, all similar in size.
In [30] only results up to 6 dimensions could be reported.
In Table 6 we present our results for the 6 dimensions chosen
there, i.e. the dimensions 1,4,5,6,7, and 10, and for all 10
dimensions as well. To give an overview of the behavior over
several λ’s we present for each level n the overall correctness
results, the correctness results for Ponderosa Pine and the
correctness result for the other class for three values of λ.
We then give results on the evaluation set for a chosen λ.
We see in Table 6 that already with level 1 we have a
testing correctness of 93.95 % for the Ponderosa Pine in the
6 dimensional version. Higher refinement levels do not give
better results. The result of 93.52% on the evaluation set
is almost the same as the corresponding testing correctness.
Note that in [30] a correctness rate of 86.97 % was achieved
on the evaluation set.
The usage of all 10 dimensions improves the results slightly,
we get 93.81 % as our evaluation result on level 1. As before
higher refinement levels do not improve the results for this
data set.
Note that the forest cover example is sound enough as an
example of classification, but it might strike forest scientists
as being amusingly superficial. It has been known for 30
years that the dynamics of forest growth can have a dominant effect on which species is present at a given location
[7], yet there are no dynamic variables in the classifier. This
one can see as a warning that it should never be assumed
that the available data contains all the relevant information.
3.3.2
Synthetic massive data set in 10D
To measure the performance on a still higher dimensional
massive data set we produced with DatGen [34] a 10-dimensional test case with 5 million training points and 50 000
points for testing. We used the call datgen -r1 -X0/200,R,O:
0/200,R,O:0/200,R,O:0/200,R,O:0/200,R,O:0/200,R,O:0/2
00,R,O:0/200,R,O:0/200,R,O:0/200,R,O -R2 -C2/6 -D2/7
-T10/60 -O5050000 -p -e0.15.
Like in the synthetical 6-dimensional example the main
observations concern the run time, measured on a Pentium
III 700 MHz machine. Besides the total run time, we also
give the CPU time which is needed for the computation of
the matrices Gl = Bl · BlT . Note that the highest amount
of memory needed (for level 2 in the case of 5 million data
points) was 500 MBytes, about 250 MBytes for the matrix
and about 250 MBytes for keeping the data points in memory.
More than 50 % of the run time is spent for the assembly
level 1
level 2
level 3
level 1
level 2
Table 5: Results for a 6D synthetic massive data set, λ = 0.01
training
testing
total
data matrix
# of
# of points correctness correctness time (sec)
time (sec)
iterations
linear basis functions
50 000
90.4
90.5
3
1
23
500 000
90.5
90.5
25
8
25
5 million
90.5
90.6
242
77
28
50 000
91.4
91.0
12
5
184
500 000
91.2
91.1
110
55
204
5 million
91.1
91.2
1086
546
223
50 000
92.2
91.4
48
23
869
500 000
91.7
91.7
417
226
966
5 million
91.6
91.7
4087
2239
1057
d-linear basis functions
500 000
90.7
90.8
597
572
91
5 million
90.7
90.7
5897
5658
102
500 000
91.5
91.6
4285
4168
656
5 million
91.4
91.5
42690
41596
742
of the data matrix and the time needed for the data matrix
scales linearly with the number of data points, see Table 7.
The total run time seems to scale even better than linear.
4. CONCLUSIONS
We presented the sparse grid combination technique with
linear basis functions based on simplices for the classification
of data in moderate-dimensional spaces. Our new method
gave good results for a wide range of problems. It is capable
to handle huge data sets with 5 million points and more. The
run time scales only linearly with the number of data. This
is an important property for many practical applications
where often the dimension of the problem can substantially
be reduced by certain preprocessing steps but the number
of data can be extremely huge. We believe that our sparse
grid combination method possesses a great potential in such
practical application problems.
We demonstrated for the Ripley data set how the best
value of the regularization parameter λ can be determined.
This is also of practical relevance.
A parallel version of the sparse grid combination technique reduces the run time significantly, see [17]. Note that
our method is easily parallelizable already on a coarse grain
level. A second level of parallelization is possible on each
grid of the combination technique with the standard techniques known from the numerical treatment of partial differential equations.
Since not necessarily all dimensions need the maximum refinement level, a modification of the combination technique
with regard to different refinement levels in each dimension
along the lines of [19] seems to be promising.
Note furthermore that our approach delivers a continuous
classifier function which approximates the data. It therefore
can be used without modification for regression problems as
well. This is in contrast to many other methods like e.g.
decision trees. Also more than two classes can be handled
by using isolines with just different values.
Finally, for reasons of simplicity, we used the operator P =
∇. But other differential (e.g. P = ∆) or pseudo-differential
operators can be employed here with their associated regular
finite element ansatz functions.
5.
ACKNOWLEDGEMENTS
Part of the work was supported by the German Bundesministerium für Bildung und Forschung (BMB+F)
within the project 03GRM6BN. This work was carried out
in cooperation with Prudential Systems Software GmbH,
Chemnitz. The authors thank one of the referees for his
remarks on the forest cover data set.
6.
REFERENCES
[1] E. Arge, M. Dæhlen, and A. Tveito. Approximation of
scattered data using smooth grid functions. J.
Comput. Appl. Math, 59:191–205, 1995.
[2] R. Balder. Adaptive Verfahren für elliptische und
parabolische Differentialgleichungen auf dünnen
Gittern. Dissertation, Technische Universität
München, 1994.
[3] G. Baszenski. N –th order polynomial spline blending.
In W. Schempp and K. Zeller, editors, Multivariate
Approximation Theory III, ISNM 75, pages 35–46.
Birkhäuser, Basel, 1985.
[4] S. D. Bay. The UCI KDD archive.
http://kdd.ics.uci.edu, 1999.
[5] M. J. A. Berry and G. S. Linoff. Mastering Data
Mining. Wiley, 2000.
[6] C. L. Blake and C. J. Merz. UCI repository of
machine learning databases, 1998.
http://www.ics.uci.edu/∼mlearn/MLRepository.html.
[7] D. Botkin, J. Janak, and J. Wallis. Some ecological
consequences of a computer model of forest growth. J.
Ecology, 60:849–872, 1972.
[8] H.-J. Bungartz. Dünne Gitter und deren Anwendung
bei der adaptiven Lösung der dreidimensionalen
Poisson-Gleichung. Dissertation, Institut für
Informatik, Technische Universität München, 1992.
[9] H.-J. Bungartz, T. Dornseifer, and C. Zenger. Tensor
product approximation spaces for the efficient
numerical solution of partial differential equations. In
Proc. Int. Workshop on Scientific Computations,
Konya, 1996. Nova Science Publishers, 1997.
[10] H.-J. Bungartz, M. Griebel, D. Röschke, and
Table 6: Results for forest cover type data set using 6 and 10 attributes
testing correctness
λ
overall Ponderosa Pine other class
6 dimensions
level 1
0.0005
92.68
93.87
92.59
0.0050
92.52
93.95
92.42
0.0500
92.45
93.43
92.39
on evaluation set 0.0050
92.50
93.52
92.43
level 2
0.0001
93.34
92.08
93.42
0.0010
93.20
92.30
93.25
0.0100
92.31
88.95
92.52
on evaluation set 0.0010
93.19
91.73
93.28
level 3
0.0010
92.78
90.90
92.90
0.0100
93.10
91.74
93.18
0.1000
93.50
87.97
93.86
on evaluation set 0.0100
93.02
91.42
93.13
10 dimensions
level 1
0.0025
93.64
94.03
93.62
0.0250
93.56
94.19
93.52
0.2500
93.64
92.30
93.72
on evaluation set 0.0250
93.53
93.81
93.51
level 2
0.0050
92.95
92.36
92.98
0.0500
93.67
92.96
93.71
0.5000
93.10
91.81
93.18
on evaluation set 0.0500
93.72
92.89
93.77
Table 7: Results for a 10D synthetic massive data set, λ = 0.01
training
testing
total
data matrix
# of
# of points correctness correctness time (sec)
time (sec)
iterations
50 000
98.8
97.2
19
4
47
level 1
500 000
97.6
97.4
104
49
50
5 million
97.4
97.4
811
452
56
50 000
99.8
96.3
265
45
592
level 2
500 000
98.6
97.8
1126
541
635
5 million
97.9
97.9
7764
5330
688
[11]
[12]
[13]
[14]
[15]
[16]
C. Zenger. Pointwise convergence of the combination
technique for the Laplace equation. East-West J.
Numer. Math., 2:21–45, 1994. also as SFB-Bericht
342/16/93A, Institut für Informatik, TU München,
1993.
V. Cherkassky and F. Mulier. Learning from Data Concepts, Theory and Methods. John Wiley & Sons,
1998.
K. Cios, W. Pedrycz, and R. Swiniarski. Data Mining
Methods for Knowledge Discovery. Kluwer, 1998.
T. G. Dietterich. Approximate statistical tests for
comparing supervised classification learning
algorithms. Neural Computation, 10(7):1895–1924,
1998.
K. Frank, S. Heinrich, and S. Pereverzev. Information
Complexity of Multivariate Fredholm Integral
Equations in Sobolev Classes. J. of Complexity,
12:17–34, 1996.
H. Freudenthal. Simplizialzerlegungen von
beschränkter Flachheit. Annals of Mathematics,
43:580–582, 1942.
J. Garcke and M. Griebel. On the computation of the
[17]
[18]
[19]
[20]
eigenproblems of hydrogen and helium in strong
magnetic and electric fields with the sparse grid
combination technique. Journal of Computational
Physics, 165(2):694–716, 2000. also as SFB 256
Preprint 670, Institut für Angewandte Mathematik,
Universität Bonn, 2000.
J. Garcke and M. Griebel. On the parallelization of
the sparse grid approach for data mining. SFB 256
Preprint 721, Universität Bonn, 2001.
http://wissrech.iam.unibonn.de/research/pub/garcke/psm.pdf.
J. Garcke, M. Griebel, and M. Thess. Data mining
with sparse grids. 2000. Submitted, also as SFB 256
Preprint 675, Institut für Angewandte Mathematik,
Universität Bonn, 2000.
T. Gerstner and M. Griebel. Numerical Integration
using Sparse Grids. Numer. Algorithms, 18:209–232,
1998. (also as SFB 256 preprint 553, Univ. Bonn,
1998).
F. Girosi. An equivalence between sparse
approximation and support vector machines. Neural
Computation, 10(6):1455–1480, 1998.
[21] F. Girosi, M. Jones, and T. Poggio. Regularization
theory and neural networks architectures. Neural
Computation, 7:219–265, 1995.
[22] G. Golub, M. Heath, and G. Wahba. Generalized cross
validation as a method for choosing a good ridge
parameter. Technometrics, 21:215–224, 1979.
[23] M. Griebel. The combination technique for the sparse
grid solution of PDEs on multiprocessor machines.
Parallel Processing Letters, 2(1):61–70, 1992. also as
SFB Bericht 342/14/91 A, Institut für Informatik, TU
München, 1991.
[24] M. Griebel. Adaptive sparse grid multilevel methods
for elliptic PDEs based on finite differences.
Computing, 61(2):151–179, 1998. also as Proceedings
Large-Scale Scientific Computations of Engineering
and Environmental Problems, 7. June - 11. June, 1997,
Varna, Bulgaria, Notes on Numerical Fluid Mechanics
62, Vieweg-Verlag, Braunschweig, M. Griebel, O. Iliev,
S. Margenov and P. Vassilevski (editors).
[25] M. Griebel, W. Huber, T. Störtkuhl, and C. Zenger.
On the parallel solution of 3D PDEs on a network of
workstations and on vector computers. In A. Bode and
M. D. Cin, editors, Parallel Computer Architectures:
Theory, Hardware, Software, Applications, volume 732
of Lecture Notes in Computer Science, pages 276–291.
Springer Verlag, 1993.
[26] M. Griebel and S. Knapek. Optimized tensor-product
approximation spaces. Constructive Approximation,
16(4):525–540, 2000.
[27] M. Griebel, P. Oswald, and T. Schiekofer. Sparse grids
for boundary integral equations. Numer. Mathematik,
83(2):279–312, 1999. also as SFB 256 report 554,
Universität Bonn.
[28] M. Griebel, M. Schneider, and C. Zenger. A
combination technique for the solution of sparse grid
problems. In P. de Groen and R. Beauwens, editors,
Iterative Methods in Linear Algebra, pages 263–281.
IMACS, Elsevier, North Holland, 1992. also as SFB
Bericht, 342/19/90 A, Institut für Informatik, TU
München, 1990.
[29] M. Griebel and V. Thurner. The efficient solution of
fluid dynamics problems by the combination
technique. Int. J. Num. Meth. for Heat and Fluid
Flow, 5(3):251–269, 1995. also as SFB Bericht
342/1/93 A, Institut für Informatik. TU München,
1993.
[30] M. Hegland, O. M. Nielsen, and Z. Shen. High
dimensional smoothing based on multilevel analysis.
Technical report, Data Mining Group, The Australian
National University, Canberra, November 2000.
Submitted to SIAM J. Scientific Computing.
[31] J. Hoschek and D. Lasser. Grundlagen der
goemetrischen Datenverarbeitung, chapter 9. Teubner,
1992.
[32] H. W. Kuhn. Some combinatorial lemmas in topology.
IBM J. Res. Develop., 4:518–524, 1960.
[33] Y. J. Lee and O. L. Mangasarian.
[34]
[35]
[36]
[37]
[38]
[39]
[40]
[41]
[42]
[43]
[44]
[45]
[46]
[47]
[48]
[49]
SSVM: A smooth support vector machine for
classification. Computational Optimization and
Applications, 20(1), 2001. to appear.
G. Melli. Datgen: A program that creates structured
data. Website. http://www.datasetgenerator.com.
W. D. Penny and S. J. Roberts. Bayesian neural
networks for classification: how useful is the evidence
framework ? Neural Networks, 12:877–892, 1999.
B. D. Ripley. Neural networks and related methods for
classification. Journal of the Royal Statistical Society
B, 56(3):409–456, 1994.
S. L. Salzberg. On comparing classifiers: Pitfalls to
avoid and a recommended approach. Data Mining and
Knowledge Discovery, 1:317–327, 1997.
T. Schiekofer. Die Methode der Finiten Differenzen
auf dünnen Gittern zur Lösung elliptischer und
parabolischer partieller Differentialgleichungen.
Doktorarbeit, Institut für Angewandte Mathematik,
Universität Bonn, 1999.
W. Sickel and F. Sprengel. Interpolation on sparse
grids and Nikol’skij–Besov spaces of dominating mixed
smoothness. J. Comput. Anal. Appl., 1:263–288, 1999.
S. Singh. 2d spiral pattern recognition with
possibilistic measures. Pattern Recognition Letters,
19(2):141–147, 1998.
S. A. Smolyak. Quadrature and interpolation formulas
for tensor products of certain classes of functions.
Dokl. Akad. Nauk SSSR, 148:1042–1043, 1963.
Russian, Engl. Transl.: Soviet Math. Dokl. 4:240–243,
1963.
V. N. Temlyakov. Approximation of functions with
bounded mixed derivative. Proc. Steklov Inst. Math.,
1, 1989.
A. N. Tikhonov and V. A. Arsenin. Solutios of
ill-posed problems. W.H. Winston, Washington D.C.,
1977.
F. Utreras. Cross-validation techniques for smoothing
spline functions in one or two dimensions. In
T. Gasser and M. Rosenblatt, editors, Smoothing
techniques for curve estimation, pages 196–231.
Springer-Verlag, Heidelberg, 1979.
V. N. Vapnik. Estimation of dependences based on
empirical data. Springer-Verlag, Berlin, 1982.
V. N. Vapnik. The Nature of Statistical Learning
Theory. Springer, 1995.
G. Wahba. Spline models for observational data,
volume 59 of Series in Applied Mathematics. SIAM,
Philadelphia, 1990.
A. Wieland. Spiral data set.
http://www.cs.cmu.edu/afs/cs.cmu.edu/project/airepository/ai/areas/neural/bench/cmu/0.html.
C. Zenger. Sparse grids. In W. Hackbusch, editor,
Parallel Algorithms for Partial Differential Equations,
Proceedings of the Sixth GAMM-Seminar, Kiel, 1990,
volume 31 of Notes on Num. Fluid Mech.
Vieweg-Verlag, 1991.