Skip to main content

ICGE: an R package for detecting relevant clusters and atypical units in gene expression

Abstract

Background

Gene expression technologies have opened up new ways to diagnose and treat cancer and other diseases. Clustering algorithms are a useful approach with which to analyze genome expression data. They attempt to partition the genes into groups exhibiting similar patterns of variation in expression level. An important problem associated with gene classification is to discern whether the clustering process can find a relevant partition as well as the identification of new genes classes. There are two key aspects to classification: the estimation of the number of clusters, and the decision as to whether a new unit (gene, tumor sample...) belongs to one of these previously identified clusters or to a new group.

Results

ICGE is a user-friendly R package which provides many functions related to this problem: identify the number of clusters using mixed variables, usually found by applied biomedical researchers; detect whether the data have a cluster structure; identify whether a new unit belongs to one of the pre-identified clusters or to a novel group, and classify new units into the corresponding cluster. The functions in the ICGE package are accompanied by help files and easy examples to facilitate its use.

Conclusions

We demonstrate the utility of ICGE by analyzing simulated and real data sets. The results show that ICGE could be very useful to a broad research community.

Background

There is considerable interest among researches in using cluster methods. For example, a common approach in many biomedical applications is to seek a reliable and precise classification of genes into a number of clusters, which is essential for understanding the bases of complex diseases. For instance, an accurate classification of tumors is essential to successful diagnosis and treatment of cancer. Clustering algorithms attempt to partition the units into groups that have similar properties and it is necessary to identify the value of k at which the final partition appears to be the best. There is considerable interest among researches in using cluster methods, which can be generally found in R packages on the Comprehensive R Archive Network (CRAN, http://CRAN.R-project.org). An important problem associated with the classification of units is to assess whether the clustering process finds a relevant partition, and to identify new classes of units. For example, if genes are classified into groups exhibiting similar patterns of gene expression variation, it is necessary to pay attention to two things. First the correct classification in k clusters of the genes by an unsupervised method. Usually, when a clustering algorithm is applied to a set of units, although the data do not present a cluster structure, the algorithm returns a partition. It is thus necessary that the index used to establish the "real" number of clusters should also be able to detect the absence of cluster structure. A variety of measures for determining the "real" number of cluster can be found in the literature, see for example [1–8] or [9], which gives an excellent overview. Most of these procedures are useful only for continuous data. Only one, the silhouette method [5], is appropriate for any kind of data (continuous, binary or qualitative). Data of this kind are common in biomedical applications, but the silhouette index cannot detect the absence of a cluster structure. An index that can be applied to any kind of attribute type, the INCA index, can be found in [10]. This index can use continuous data without any assumption about their distribution and it also permits detection of data that have no cluster structure. Second, given a new gene, the procedure should establish whether it is sufficiently similar to any of the existing clusters. If not, a new type of expression pattern must be considered. Note that some techniques of classification, similar to discriminant analysis, classify a new unit as necessarily belonging to one of the specified clusters. However, this new unit may not belong to any of the pre-identified clusters, but may rather be a member of an entirely different and unknown cluster. There are few approaches in the literature dealing with the typicality problem [11–15]. All these methods have some restrictions on the type of data (only continuous data following normal distribution) or on the number of groups (only two groups for any kind of data). Recently, Irigoien et al. [10] developed an effective test for determining atypical objects in different types of clustering applications. This test provides an alternative to the other models that impose constraints on the type of data or the number of groups. This test can be used with any kind of data, and has no limitation on the number of groups.

The literature on statistical clustering is large, but it does not appear to contain any computational tool capable of solving all the key aspects of classification: identifying the number of clusters using mixed variables, usually found in applied biomedical research; detecting whether the data have a cluster structure; identifying whether a new unit belongs to one of the pre-identified clusters, and classifying this unit. The ICGE package uses the methodology introduced in [10] and deals with all the aspects commented above.

Implementation

In this section, the structure of the package and the functions implemented are explained. Examples illustrating the usage of the functions are also included.

The ICGE package was developed for the free statistical R environment (http://www.r-project.org) and runs under the major operating systems. We do not delve here into details of the underlying statistical methodology. However, a review of this methodology can be found in the Methods subsection.

Main functions

Table 1 summarizes the main functions available in the package. A detailed description of these functions is provided below.

Table 1 Main functions on package ICGE

The main function INCAindex helps to estimate the number of clusters in a dataset.

  • Usage

    INCAindex(d, pert_clus)

  • Arguments

    To call the main function INCAindex(d, pert_clus), two arguments must be specified. As usual, d is a distance matrix or a dist object containing the distances between the n units, and pert clus is an n-vector that indicates which group each unit belongs to. The default value indicates the presence of only one group in the data. Note that the expected values of pert_clus are greater than or equal to 1 (for instance 1,2,3,4...).

  • Value

    This function returns an object of class incaix, which is a list containing the following components:

    well_class, a vector indicating the number of units that are well classified;

    Ni_cluster, a vector indicating each cluster size and

    Total, percentage of units well classified in the partition defined by pert_clus, i.e., the INCA index.

  • Remarks It admits the associated methods summary and plot. The first simply returns the percentage of well-classified units and the second offers a barchart with the percentages of well classified units for each group in the given partition.

  • Example 1

Consider the following simulated data. Using the data simulation functions included in the WGCNA package (see [16]), we generated 100 samples and three groups containing 480, 360 and 360 genes, respectively. We used the Euclidean distance and calculated the percentage of well classified genes.

library("WGCNA")

library("ICGE")

nSamples = 100

set.seed(3)

nModules = 3

nGenes = 1200

eigengenes = matrix(rnorm(nSamples *nModules), nSamples, nModules)

d = simulateDatExpr(eigengenes, nGenes, c(b0.3, 0.3, 0.4, 0), signed = TRUE)

data = d$datExpr;

dst = dist(t(data))

x = INCAindex(dst, d$allLabels)

The output was: a vector indicating the number of units in each group (360, 360 and 480); the number of units well classified (84, 94 and 91 per cent, respectively) and the INCA index, which indicat the total of units well classified (89.84%).

Furthermore, in order to obtain an estimation of the "real" number of clusters from the data, we compute the INCA index for several partitions, with different number k of clusters in each partition, where k = 2,..., K. This is the aim of INCAnumclu function.

  • Usage

    INCAnumclu(d, K, method="pam", pert, noise="NULL", L)

  • Arguments

    The function INCAnumclu(d, K, method="pam", pert, noise="NULL", L) has 6 arguments but they are not involved simultaneously. A distance matrix d or a dist object with distance information between the n units is required. Argument K indicates the maximum number of clusters to be considered. For each value k, k = 2, ..., K a partition in k clusters is considered. The method argument is a character string defining the clustering method to be applied in order to obtain the corresponding partitions. The clustering method is performed via the function pam and agnes in cluster package. The available clustering methods are pam (default method, Partitioning Around Medoids clustering method, PAM, [17]), average (UPGMA), single (single linkage), complete (complete linkage), ward (Ward's method), weighted (weighted average linkage). Nevertheless, the user can introduce particular partitions indicating method="partition" and using the pert argument. This argument is a matrix with n rows, and each column contains a particular partition. This means that each column is an n vector that indicates the group to which each unit belongs. Note that the expected values of each column of pert are consecutive integers that are greater than or equal to 1 (for instance 1,2,3,4..., k). The argument noise is a logical vector indicating units considered as "noise" units by the user, and argument L must be set as L="custom". When argument L = "NULL" no "noise" units are considered. If parameter L is greater than or equal to 1, the units classified in all clusters C, containing a number of units ≤ L, are considered "noise" units. If L="custom", the "noise" units are selected by the user and they must be indicated in the noise argument.

  • Value

    This function returns a numeric vector with the INCA index values calculate for each partition (with and without the units considered "noise" units). The associate method plot returns two plots of INCA k versus the number of clusters k. One plot shows the INCA k index values considering all the units, and the other shows the INCA k index values calculated without "noise" units. As explained in [10], when the value INCAk+1shows a large decrease respect to the INCA k value, we conclude that there are k clusters in the data. When values of INCA k are low and constant, it means that there is no cluster structure, or that all the data form a single cluster.

  • Example 1 (cont.)

    The average clustering algorithm was applied to the same data. Using INCAnumclu we determined the number of clusters. Consequently we calculated the INCA index associated with partitions having k = 2, ..., 10 clusters.

    out <- INCAnumclu(dst,10,"average")

    plot(out)

    The procedure gives good results and identifies the three clusters, see Figure 1.

Figure 1
figure 1

Estimating the number of clusters using data in example 1 (Implementation section). Plot of the index INCA k versus the number of clusters k. The largest (negative) slope indicates that there are three clusters.

  • Example 2

    Now consider the following example. Using the data simulation functions included in [16], we generated 100 samples and three groups containing 360, 360 and 360 simulated genes, respectively. A fourth group with 120 "noise" genes was also generated. The INCAnumclu function shows (taken K = 15) that the "noise" genes have hidden the underlying cluster structure. Using the parameter noise with L = 2, the procedure identifies, in the initial partitions 13 "noise" genes.

    library("WGCNA")

    library("ICGE")

    nSamples = 100

    set.seed(3)

    nModules = 3

    nGenes = 1200

    eigengenes = matrix(rnorm(nSamples *nModules), nSamples, nModules)

    d = simulateDatExpr(eigengenes, nGenes, c(0.3, 0.3, 0.3, 0.1), signed = TRUE)

    data = d$datExpr;

    dst = dist(t(data))

    out<-INCAnumclu(dst, 15, "average", L = 2)

    The results are:

    INCA index to estimate the number of clusters considering all units

    Clustering method: average

    k = 2, 0.00042

    k = 3, 0.33

    k = 4, 0.25

    k = 5, 0.2

    k = 6, 0.17

    k = 7, 0.14

    k = 8, 0.12

    k = 9, 0.52

    k = 10, 0.54

    k = 11, 0.5

    k = 12, 0.41

    k = 13, 0.41

    k = 14, 0.36

    k = 15, 0.3

    Noise units:

    Gene.1081 Gene.1087 Gene.1102 Gene.1107 Gene.1128 Gene.1134 Gene.1141

    Gene.1155 Gene.1158 Gene.1165 Gene.1170 Gene.1176 Gene.1182

    INCA index to estimate the number of clusters without the noise units

    Clustering method: average

    k = 2, 0.67

    k = 3, 0.44

    k = 4, 0.2

    k = 5, 0.069

    k = 6, 0.0024

    k = 7, 0.0022

    k = .8, 0.043

    k = 9, 0.00087

    k = 10, 0.034

    k = 11, 0.031

    k = 12, 0.028

    k = 13, 0.026

    k = 14, 0.024

    k = 15, 0.023

Finally, INCAtest function performs the typicality INCA test. Therein, the null hypothesis that a new unit g0 is a typical unit with respect to a previously fixed partition is tested versus the alternative hypothesis that the unit is atypical.

  • Usage

    INCAtest(d, pert, d test, np = 1000, alpha = 0.05, P = 1)

  • Arguments

    By calling the function, INCAtest(d, pert, d_test, np = 1000, alpha = 0.05, P = 1), 6 arguments are specified. As before, d is a distance matrix or a dist object with distance information between the n units, and pert is an n-vector that indicates the group to which each unit belongs. The default value indicates the presence of only one group in the data. Note that the expected values of pert are greater than or equal to 1 (for instance 1,2,3,4...). The argument d_test is a vector of length n that contains the distances from the new unit g0 to the rest of the n units. Note that sampling distributions of the INCA statistics W(g0) and the related statistics U j (g0) (j = 1, ..., k) (see subsection Methods for the definition) can be difficult to find for mixed data, but they may nevertheless be obtained by re-sampling methods, in particular by drawing bootstrap samples as follows. Draw N units g with replacement from the union of C1, ..., C k and calculate the corresponding W(g) and U j (g) (j = 1, ..., k) values. This process is repeated 10P times. In this way, the bootstrap distributions under H0 are obtained. Then, the np and alpha arguments indicate the sample size for the bootstrap procedure, and the level for the test, respectively. Finally, the argument P indicates that the bootstrap procedure is repeated 10P times.

  • Value

    The function returns a list with incat class containing the following components:

    StatisticW0 value of the INCA statistic;

    ProjectionsU values of statistics measuring the projection from the specific object to each group;

    Percentage under alpha percentage of times that the INCA test has been rejected for a fixed significance level;

    alpha specified value of the significance level of the test.

  • Example 2 (cont.)

    Consider the above simulated gene-expression data that include 120 "noise" genes, 100 samples and three groups containing 360, 360 and 360 simulated genes, respectively.

    Now, consider only the three groups without "noise" genes. Select one "noise" gene at random and insert the distances from it to the "non-noise" genes in vector dd. Then, compute the INCAtest function:

    dr<-as.matrix(dst)[d$allLabels! = 0,d$allLabels! = 0]

    cl<-d$allLabels[d$allLabels! = 0]

    INCAtest(dr,cl,dd,np = 1000,alpha = 0.05, P = 1)

    As we expected, the output indicates that this "noise" gene is atypical.

    StatisticW0

    238758.6

    ProjectionsU

    1 147.4769

    2 257.0330

    3 433.4185

    Percentage under alpha

    100

    alpha

    0.05

    Also take at random (from group 3) one gene of the cluster (i.e., "non-noise") genes and insert the distances from it to the "non-noise" genes in vector dd. Then, the INCAtest correctly predicts their cluster membership:

    INCA test

    INCA statistic value = 5.839681

    U projections values:

    U 1 = 137.9698

    U 2 = 137.3148

    U 3 = 7.615953

    significative tests for alpha= 0.05: 0

    We also considered 100 genes selected at random: 87 "non-noise" genes (27 from group 1, 30 from group 2 and 30 from group 3) and 13 "noise" genes. We computed the INCAtest function. The results show that the function correctly predicts the cluster membership of the 87 "non-noise" genes. For the "noise" genes, 8 are considered as atypical and the other 5 are confounded as genes of the initial groups.

Auxiliary functions

These main functions are, of course, based on the auxiliary functions that calculate the geometric variability, the distance between two groups, the proximity function and the INCA statistic itself, which are described at the beginning of the Method Section. Table 2 shows the corresponding functions available from the package, and more detailed comments are presented below.

Table 2 Auxiliary functions on package ICGE

The vgeo function calculates the geometrical variability V ^ δ ( C j ) (see subsection Methods for the definition) for each group in the data.

  • Usage

    vgeo(d, pert = "onegroup")

  • Arguments

    To call vgeo(d, pert = "onegroup") two arguments must be specified. The d argument is a distance matrix or a dist object with distance information between the n units and pert is an n- vector that indicates the group to which each unit belongs. The default value indicates that there is only one group in the data. Note that the expected values of pert are numbers greater than or equal to 1 (for instance 1,2,3,4...).

  • Value

    The function returns a matrix containing the geometric variability for each group.

The deltas function calculates the distance Δ ^ i j 2 between each pair of groups C i and C j in the data (see subsection Methods for the definition).

  • Usage

    deltas(d, pert = "onegroup")

  • Arguments

    To call deltas(d, pert = "onegroup") the same d and pert arguments must be specified.

  • Value

    The function returns a matrix containing the distances between each pair of groups. proxi function calculates the proximity function Ï• ^ 2 ( g 0 , C j ) (see subsection Methods for the definition) from a specific unit g0 to the other groups C j in the data.

  • Usage

    proxi(d, dx0, pert = "onegroup")

  • Arguments

    To call proxi(d, dx0, pert = "onegroup") three arguments must be specified. The d argument is a distance matrix or an object dist for the n units; dx0 is an n- vector containing the distances from g0 to the rest of the units and pert is an n- vector that indicates the unit to which group belongs. The default value indicates that there is only one group in the data. Note that the expected values of pert are numbers greater than or equal to 1 (for instance 1,2,3,4...).

  • Value

    The function returns a vector containing the proximity function from g0 to each group.

The function estW calculates the INCA statistic W(g0) and the related statistics U j (g0), j = 1, ..., k.

  • Usage

    estW(d, dx0, pert = "onegroup")

  • Arguments

    This needs the same arguments as proxi.

  • Value

    The function returns an object of incaest class, which is a list containing the following components:

    Wvalue, is the INCA statistic W(g0);

    Uvalue, is a vector containing the statistics U j (g0), j = 1,..., k.

    The associated summary method returns only the INCA statistic value.

Distance functions

Note that all these functions require the previous calculation of a distance between units. Biomedical and genetic studies incorporate any type of data, not only continuous variables, and correlation or other types of dissimilarities are frequently used for clustering. For this reason, ICGE can calculate different distance matrices (Table 3).

Table 3 Distances provided by the ICGE package

The correlation distance and the Mahalanobis distance [18] are well known, but perhaps the Bhattacharyya and the Gower distances are less. A function named mahalanobis() that calculates the Mahalanobis distance already exists in the stats package, but it is not suitable in our context. While this function calculates the Mahalanobis distance with respect to a given center, our function is designed to calculate the Mahalanobis distance between each pair of units given a data matrix.

The Bhattacharyya distance [19] between two units with frequencies i = (pi 1, ..., pi m) and j = (pj 1, ...,p jm ) is defined by:

d ( i , j ) = arccos ∑ l = 1 m p i l p j l .

The Gower distance [20], used for mixed variables, is defined by d i j 2 =2 ( 1 - s i j ) . As each unit is characterized by m1 continuous, m2 binary and m3 qualitative variables, the similarity coefficient s ij between unit i and j is calculated as follows:

s i j = ∑ l = 1 m 1 1 - x i l - x j l R l + a + α m 1 + ( m 2 - d ) + m 3
(1)

where R l is the range of the l th continuous variable (l = 1,..., m1); for the m2 binary variables, a and d represent the number of matches presence-presence and absence-absence, respectively and α is the number of matches between states for the m3 qualitative variables. Note that there is also the daisy() function in cluster package, which can calculate the Gower distance for mixed variables. The difference between this function and dgower() in ICGE is that in daisy() the distance is calculated as d ij = 1 - s ij and in dgower() as d i j 2 =2* ( 1 - s i j ) . Moreover, dgower() allows us to include missing values (such as NA) and therefore calculates distances based on Gower's weighted similarity coefficients.

The procrustes distance was defined in [21], and it was introduced to find an appropiate distance between genes using their expression profile. It was defined as the procrustes statistics between the procrustes weighted mean associated with two genes, see definition 2, Step C in [21] for more details.

Methods

Briefly, we describe some of the concepts used in the ICGE package. A more detailed description of the procedure and applications can be found in [10].

Consider a dataset with n units and a partition into k groups C1, ..., C k . Let δ(g,g') be a distance between units g and g'. Let samples g 1 1 , … , g n 1 1 , … , g 1 k , … , g n k k , of sizes n1, ..., n k be taken from the C1, ..., C k groups respectively.

The geometric variability for each group is defined by:

V ^ δ ( C j ) = 1 2 n j 2 ∑ l , m δ 2 ( g l j , g m j ) .

Given two groups C i , C j the distance between them is given by:

Δ ^ i j 2 = 1 n i n j ∑ l , m δ 2 ( g l i , g m j ) - V ^ δ ( C i ) - V ^ δ ( C j ) .

Given the distances from one specific unit g0 to the rest of the units organized in the k groups, the proximity function of unit g0 to C j is defined by:

ϕ ^ 2 ( g 0 , C j ) = 1 n j ∑ l δ 2 ( g 0 , g l j ) - V ^ δ ( C j ) .

For more details on these concepts see [22].

From these previous concepts we define the INCA statistic. Consider a fixed unit g0, which may be an element of some C j , j = 1,..., k or may belong to some unknown cluster, i.e., it may be an atypical unit. This statistic trades off between minimizing the weighted sum of proximities of g0 to clusters (which takes into consideration the within-cluster variabilities) and maximizing the weighted sum of the squared distances between clusters (between-cluster variability) - a common feature of a clustering criterion. Moreover, this statistic can be interpreted (see Figure 2) as the (squared) orthogonal distance or height h of g0 on the hyperplane generated by the centers of C i (i = 1,..., k), denoted in Figure 2 by a i , i = 1,..., k. Then, points which lie significantly far from this hyperplane are held to be atypical. This intuitive idea is used both to determine the number of clusters, and to detect atypical units among existing clusters. The definition of the INCA statistic is:

Figure 2
figure 2

Geometrical interpretation of the INCA statistics. For k = 3, new observation {g0}, centers of clusters {a1, a2, a3} and (squared) projection r i of the edges {g0, a i } on the plane {a1, a2, a3}. The (squared) height h is the INCA statistic.

W ( g 0 ) = min α i { L ( g 0 ) } , ∑ i = 1 k α i = 1

where,

L ( g 0 ) = ∑ i = 1 k α i ϕ i 2 ( g 0 ) - ∑ 1 ≤ i < j ≤ k α i α j Δ i j 2 .

Estimating the number of clusters

We define the INCA index, INCA k , associated with the partition C1,..., C k , as the probability of finding well classified units. Consider that n units are divided into k clusters C1,...,C k of sizes n1,..., n k , respectively. Fix cluster C j and for each unit g belonging to the data set, consider the value of INCA statistic, W C j ( g ) , with respect to clusters C i with i ≠ j. Consider the maximum, W C j , of these (squared) orthogonal distances for all the units that do not belong to C j . Then consider the following criterion: Unit g of C j is well classified in C j if W C j ( g ) > W C j . Unit g of C j is poorly classified in C j if W C j ( g ) ≤ W C j , in fact, it is closer to another cluster.

Let N j be the total number of units in C j which are well classified. Thus we define the INCA index, INCA k , associated with the partition C1,..., C k as the frequency of well classified, i.e.,

I N C A k = 1 k ∑ j = 1 k N j n j .

Procedure for detecting an atypical observation

Suppose now that a cluster analysis is performed and the optimal number of clusters is found. Let g0 be a new unit and consider the INCA test to decide whether g0 belongs to one of the fixed clusters C j , j = 1,..., k or, on the contrary, whether it is an atypical observation, belonging to some different and unknown cluster. Compute W(g0): if this value is significant it means that g0 comes from a different and unknown cluster. Otherwise, we allocate g0 to C i using the rule:

allocate g 0 to C i if U i ( g 0 ) = min j = 1 , … , k { U j ( g 0 ) } ,
(2)

where U j ( g 0 ) = Ï• j 2 ( g 0 ) -W ( g 0 ) , j = 1, ..., k.

For a geometric interpretation, see Figure 2, where for simplicity the (squared) projection U j (g0) is denoted by r j , j = 1,..., k. So, the above criterion follows the next geometric and intuitive allocation rule:

allocate  g 0 to C i if the projection  U i ( g 0 )  is the smaller .
(3)

A more detailed explanation of these procedures, properties and examples can be found in [10].

Results

Remarks and limitations of the package

For ICGE package the computing times are reasonable. Table 4 shows runtime for functions INCAindex and INCAtest based on synthetic data sets of different sample sizes (n = 50,100, 500 or 1000), and different number of groups k = 2, 3, 5, 10, 15, 20, 30 or 40. Observe that for a large number of clusters, the time increases exponentially.

Table 4 Runtime for functions INCAindex and INCAtest based on synthetic data sets of different sizes

Furthermore, note that in the main functions INCAindex, INCAnumclu and INCAtest the argument d is a distance matrix or a dist object. Therefore, any kind of dissimilarity can be used, not only those included in ICGE, and in this sense the package is flexible.

Another aspect is also relevant. Let p be the dimensionality of the Euclidean space in which the original metric space (S, δ) can be embedded (see [10], section 2). If the number of clusters k is equal to or greater than the dimensionality p, the hyperplane generated by the cluster centers will simply be the whole space, and the INCA statistic will always be zero. This special situation should be taken into account when using these functions, and it may be a limitation of the method (and of the package).

Application to real and simulated data

Functions and methods are illustrated and tested on both real and simulated data.

Chowdary's data set

Chowdary et al., compared in [23] pairs of snap-frozen and RNAlater preservative-suspended tissue from lymph node-negative breast tumors (B) and Dukes' B colon tumors (C). ICGE package proved to be effective at automatically discovering the both groups (see Figure 3). The procedure chooses k as the value of k prior to the first biggest slope decrease. Using the correlation distance, the clustering procedure PAM was used to partition the 94 samples successively into 2, 3, ..., 10 clusters. The plot indicates that there are two clusters as it was already reported. This data set is included in the package.

Figure 3
figure 3

Estimating the number of clusters using Chowdary's data set. Plot of the index INCA k versus the number of clusters k. The largest (negative) slope indicates that there are two clusters.

Golub's data set

Golub et al., studied in [24] gene expression in two types of acute leukemia: acute lymphoblastic leukemia (ALL) and acute myeloid leukemia (AML). They worked with 27 ALL and 11 AML samples. There were no missing values and we standardized the data as described in [25]. We evaluated the performance of the typicality test using the correlation distance. We considered 5 and 3 units at random from ALL and AML group, respectively. Using ICGE we decided whether these unknown units are typical units with respect to ALL and AML groups or whether on the contrary, they are units from another group. We repeated this procedure ten times for each group. Good results at the 5% level were obtained. In each case, the units were identified as units from one of the two groups and were well classified. Data can be found in the multtest library.

Synthetic time course data

We generated time course data with 8 groups, 15 genes in each group and six time points, following 8 different profiles (see Figure 4): G1, constant profile; G2, monotone increasing but with small difference between the expression value at the first and the last time points; G3, constant profile at 1, 2 and 3, and later monotone increasing; G4 up-down profile with maxima at 2; G5, up-down with maxima at 5; G6, down-up profile with minima at 3; G7, cyclic with maxima at 2 and minima at 5; G8, down-up constant profile with minima at 2 and constant at 3,4,5 and 6. The procrustes distance was used [21]. When genes in G1 are considered as new genes to be classified in G2, G3, G4, G5, G6, G7 or G8 the procedure identifies the 15 as belonging to a new group. When genes in G2 are considered as new genes to be classified in G1, G3, G4, G5, G6, G7 or G8 the procedure identifies 3 as belonging to a new group (as we know) and 12 as belonging to G1. When genes in G i , i = 3,4,5,6,7,8 are considered as new genes to be classified in G j , j ≠ i, the procedure identifies the 15 genes as belonging to a new group (as we know). ICGE package proved to be effective at automatically discovering atypical genes. This data set is included in the package.

Figure 4
figure 4

Synthetic time course data. Synthetic time course data following 8 different profiles: G1, constant profile; G2, monotone increasing but with small difference between the expression value at the first and the last time points; G3, constant profile at 1, 2 and 3, and later monotone increasing; G4 up-down profile with maxima at 2; G5, up-down with maxima at 5; G6, down-up profile with minima at 3; G7, cyclic with maxima at 2 and minima at 5; G8, down-up constant profile with minima at 2 and constant at 3,4,5 and 6.

Lymphatic cancer data

The data from [26] demonstrates that ICGE can correctly identify situations in which the data do not present a clear cluster structure (see Figure 5). The Lymphatic data set consists of 148 instances of the diagnosis of four lymphatic cancer classes (normal found, metastases, malign lymph and fibrosis), with 2, 81, 61 and 4 samples, respectively. Note that it is very difficult for any method to find four clusters given the small sizes of two of the groups. 18 mixed variables were measured: 1 quantitative; 9 binaries and 8 multi-state. ICGE can correctly identify situations in which the data do not present cluster structure. Notice that this is an advantage over other procedures. The PAM clustering procedure was used to partition the 148 samples successively into 2, 3, ..., 10 clusters. Gower's distance was used. As expected, the low values of the index indicate no cluster structure. This data set is included in the package. For additional details read [10].

Figure 5
figure 5

Lymphatic cancer data. The low values of the index indicate no cluster structure.

Conclusions

ICGE offers a friendly implementation for R users that is capable of solving important questions in genetic analysis and in general studies, where an unsupervised classification is necessary. One aspect of the package is the estimation of the number of clusters. The ICGE procedures provide functionalities that are not offered by other tools; in particular, they can deal with mixtures of categorical and continuous data, a situation usually found by applied researchers. Furthermore, it can detect the absence of cluster structure. Only the silhouette method is appropriate for any kind of data, but this index cannot detect the absence of cluster structure. Thus, our method is able to deal with data of a more general kind. In contrast to other classification techniques, given a new unit to be classified, it does not automatically classify it in previously specified clusters. The procedure decides whether a new unit belongs to a new group. For this reason, the ICGE package is able to solve the typicality problem. Other methods present restrictions in the kind of data or number of groups, but the ICGE package can work with any kind of data and has no limitation on the number of groups. For all these reasons ICGE could be very useful to a large number of researchers.

Availability and requirements

The ICGE package has been developed for the free statistical R environment (http://www.r-project.org) and will run under the major operating systems. The functions in the ICGE package are accompanied by help files and simple examples to facilitate its use. A manual is also included. ICGE and its documentation are freely available at http://www.sc.ehu.es/ccwrobot.

Software name: ICGE

Software home page: http://www.sc.ehu.es/ccwrobot

Operating system(s): e.g. Platform independent

Programming language: R platform

Other requirements: No

Any restrictions to use: it is available for free download.

References

  1. Calinski R, Harabasz J: A Dendrite Method for Cluster Analysis. Communications in Statistics 1974, 3: 1–27.

    Article  Google Scholar 

  2. Fowlkes EB, Mallows CL: A Method for Comparing Two Hierarchical Clusterings. Journal of the American Statistical Association 1983, 78: 553–584. 10.2307/2288117

    Article  Google Scholar 

  3. Hartigan JA: Statistical Theory in Clustering. Journal of Classification 1985, 2: 63–76. 10.1007/BF01908064

    Article  Google Scholar 

  4. Milligan GW, Cooper MC: An Examination of Procedures for Determining the Number of Clusters in a Data Set. Psychometrika 1985, 50: 159–179. 10.1007/BF02294245

    Article  Google Scholar 

  5. Rousseeuw PJ: Silhouettes: A Graphical Aid to the Interpretation and Validation of Cluster Analysis. Journal of Computational and Applied Mathematics 1987, 20: 53–65.

    Article  Google Scholar 

  6. Krzanowski WJ, Lai Y: A Criterion for Determining the Number of Groups in a Dataset Using Sum of Squares Clustering. Biometrics 1988, 44: 23–34. 10.2307/2531893

    Article  Google Scholar 

  7. Jain AK, Dubes RC: Algorithms for Clustering Data. Prentice-Hall, Englewood Cliffs, New York; 1988. USA USA

    Google Scholar 

  8. Tibshirani R, Walther G, Hastie T: Estimating the Number of Clusters in a Data Set Via the Gap Statistic. Journal of the Royal Statistical Society. Serie B 2001, 63: 411–423. 10.1111/1467-9868.00293

    Article  Google Scholar 

  9. Dudoit S, Fridlyand J: A Prediction-Based Resampling Method for Estimating the Number of Clusters in a Data Set. Genome Biology 2002., 3: research0036.1–0036.21 research0036.1-0036.21

    Google Scholar 

  10. Irigoien I, Arenas C: INCA: New Statistic for Estimating the Number of Clusters and Identifying Atypical Units. Statistics in Medicine 2008, 27: 2948–2973. 10.1002/sim.3143

    Article  CAS  PubMed  Google Scholar 

  11. Rao CR: Use of Discriminant and Allied Functions in Multivariate Analysis. Sankhya-Serie A 1962, 24: 149–154.

    Google Scholar 

  12. McDonald LL, Lowe VW, Smidt RK, Meister KA: A Preliminary Test for Discriminant Analysis Based on Small Samples. Biometrics 1976, 32: 417–422. 10.2307/2529509

    Article  Google Scholar 

  13. McLachlan GJ: On the Bias and Variance of Some Proportion Estimators. Communications in Statistics, Simulation and Computation 1982, 11: 715–736. 10.1080/03610918208812290

    Article  Google Scholar 

  14. Cuadras CM, Fortiana J: The Importance of Geometry in Multivariate Analysis and Some Applications. In Statistics for the 21st Century. Marcel Dekker, New York; 2000:93–108.

    Google Scholar 

  15. Bar-Hen A: Preliminary Tests in Linear Discriminat Analysis. Statistica 2001, 4: 585–593.

    Google Scholar 

  16. Langfelder P, Horvath S: Eingene networks for studying the relationships between co-expression modules. BMC Systems Biology 2007, 1: 1–54. 10.1186/1752-0509-1-1

    Article  Google Scholar 

  17. Kaufman L, Rousseeuw P: Finding Groups in Data. An introduction to cluster analysis. Wiley, New York; 1990.

    Google Scholar 

  18. Mahalanobis PC: On the Generalized Distance in Statistics. Procedures of the Natural Institute of Science of India 1936, 2: 49–55.

    Google Scholar 

  19. Bhattacharyya A: On a Measure of Divergence of Two Multinominal Populations. Sankhy¯a 1946, 7: 401–406.

    Google Scholar 

  20. Gower JC: A General Coefficient of Similarity and Some of its Properties. Biometrics 1971, 27: 857–871. 10.2307/2528823

    Article  Google Scholar 

  21. Irigoien I, Vives S, Arenas C: Microarray Time Course Experiments: Finding Profiles. IEEE/ACM Transactions and Computational Biology and Bioinformatics 2011, 8: 464–475.

    Article  Google Scholar 

  22. Arenas C, Cuadras CM: Some Recent Statistical Methods Based on Distances. Contributions to Science 2002, 2: 183–191.

    Google Scholar 

  23. Chowdary D, Lathrop J, Skelton J, et al.: Prognostic gene expression signatures can be measured in tissues collected in RNAlater preservative. Journal Mol Diagnosis 2006, 8: 31–39. 10.2353/jmoldx.2006.050056

    Article  CAS  Google Scholar 

  24. Golub TR, Slonim DK, Tamayo P, et al.: Molecular classification of cancer: class discovery and class prediction by gene expression monitoring. Science 1998, 286: 531–537.

    Article  Google Scholar 

  25. Yang YH, Dudoit S, Luu P, et al.: Normalization for cDNA microarray data: a robust composite method addressing single and multiple slide systematic variation. Nucleic Acids Research 2002, 30: e15. 10.1093/nar/30.4.e15

    Article  PubMed Central  PubMed  Google Scholar 

  26. Hettich S, Bay SD:The UCI KDD Archive. Department of Information and Computer Science. University of California at Irvine, Irvine, CA; 1999. [http://kdd.ics.uci.edu]

    Google Scholar 

Download references

Acknowledgements

The authors thank Drs. F. Mestres and J.F. Abril (Dept. Genetics, University of Barcelona) for their suggestions and comments. The authors are very grateful to the anonymous reviewers whose helpful comments have greatly improved the clarity of this article. We also thank the English Language Service at the Universitat de Barcelona for revising and correcting the English text. This study was supported by grant BFU2009-06974 from the MCNN (Spain).

Author information

Authors and Affiliations

Authors

Corresponding author

Correspondence to Concepcion Arenas.

Additional information

Authors' contributions

II developed the algorithms, prepared the implementation of the ICGE package and carried out the data analysis. BS worked on the draft preparation and cooperated in writing the manuscript. CA conceived the software implementation idea, drafted and wrote the manuscript. II and CA designed the statistical method. All authors have read and approved the final version of the manuscript.

Authors’ original submitted files for images

Rights and permissions

Open Access This article is published under license to BioMed Central Ltd. This is an Open Access article is distributed under the terms of the Creative Commons Attribution License ( https://creativecommons.org/licenses/by/2.0 ), which permits unrestricted use, distribution, and reproduction in any medium, provided the original work is properly cited.

Reprints and permissions

About this article

Cite this article

Irigoien, I., Sierra, B. & Arenas, C. ICGE: an R package for detecting relevant clusters and atypical units in gene expression. BMC Bioinformatics 13, 30 (2012). https://doi.org/10.1186/1471-2105-13-30

Download citation

  • Received:

  • Accepted:

  • Published:

  • DOI: https://doi.org/10.1186/1471-2105-13-30

Keywords