Skip to main content

Wavelet-based identification of DNA focal genomic aberrations from single nucleotide polymorphism arrays

Abstract

Background

Copy number aberrations (CNAs) are an important molecular signature in cancer initiation, development, and progression. However, these aberrations span a wide range of chromosomes, making it hard to distinguish cancer related genes from other genes that are not closely related to cancer but are located in broadly aberrant regions. With the current availability of high-resolution data sets such as single nucleotide polymorphism (SNP) microarrays, it has become an important issue to develop a computational method to detect driving genes related to cancer development located in the focal regions of CNAs.

Results

In this study, we introduce a novel method referred to as the wavelet-based identification of focal genomic aberrations (WIFA). The use of the wavelet analysis, because it is a multi-resolution approach, makes it possible to effectively identify focal genomic aberrations in broadly aberrant regions. The proposed method integrates multiple cancer samples so that it enables the detection of the consistent aberrations across multiple samples. We then apply this method to glioblastoma multiforme and lung cancer data sets from the SNP microarray platform. Through this process, we confirm the ability to detect previously known cancer related genes from both cancer types with high accuracy. Also, the application of this approach to a lung cancer data set identifies focal amplification regions that contain known oncogenes, though these regions are not reported using a recent CNAs detecting algorithm GISTIC: SMAD7 (chr18q21.1) and FGF10 (chr5p12).

Conclusions

Our results suggest that WIFA can be used to reveal cancer related genes in various cancer data sets.

Background

With the recent advances of cancer studies at a molecular level, DNA copy number aberrations (CNAs) have been studied as important causes and consequences in the initiation, development, and progression of cancer. To date, many researchers have focused on the detection of chromosomal regions having amplifications and deletions using arrays of comparative genomic hybridization (CGH) data sets. These studies have generated valuable observations about cancer metastasis [1–7]. For example, it is now known that many oncogenes and tumor suppressor genes are located in regions of amplifications and deletions, and that chromosome regions with aberrations can be used to distinguish between cancer types. Also, new cancer related genes have been discovered. These advances have been accelerated by the development of computational methods and software [8–14]; segmentation and denoising methods such as circular binary segmentation (CBS) [8], wavelets [9], and the Gaussian-based likelihood approach (GLAD) [10] have been developed in order to identify true aberrations from background noise in a single sample. And with the accumulation of copy number aberration data sets, it has become increasingly important to find concordant aberrations in multiple samples. Thus, algorithms such as the minimum common region (MCRs) [15] and significance testing for aberrant copy number (STAC) [16] have been developed to address this issue.

However, even though each method can identify aberrant regions, these regions are not concordant between the different methods. As one possible explanation for this lack of concordance, Beroukhim et al. (2007) [17] assumed that many aberrations randomly occur, though most methods do not explicitly consider the background rate of random aberrations. For instance, most locations of chr7 and chr10 are amplified and deleted, respectively, in short-term survival patients of glioblastoma multiforme (GBM) [18], though only a few of their genes are known oncogenes and tumor suppressors in GBM. As such, if random aberrations are not considered, most chr7 and chr10 genes will be regarded as relevant. Hence, an important issue is to distinguish cancer driving genes, i.e., genes involved in cancer development, from broad chromosomal aberrations. Fortunately, the amount of aberrations of driving genes has been observed to be larger than in their neighboring genes, and these aberrations are likely to occur consistently across multiple cancer patients. A few algorithms, such as the genomic identification of significant targets in cancer (GISTIC) [17], have been developed in attempts to incorporate these issues and are used to detect focal aberrations. Note that the term "focal aberrations" is used here to refer to relatively short, but consistently aberrant, regions in multiple samples. The use of GISTIC revealed that these focal aberrations contain many cancer related genes. In a comparison of GISTIC to MCR [15], via three independent data sets, GISTIC consistently identified more cancer related genes than MCR. In GISTIC, it first selects copy number aberration regions by applying a segmentation method to each sample, and then sums the amount of aberrations from the multiple samples. Then, differences between the aberrations and their neighbors are computed using a peel-off method. However, GISTIC has an inherent weakness: differences between neighbors in individual samples may cancel out since it summates log2 ratios in all aberrant samples first. The important difference between GISTIC and our proposed approach is that we first consider the differences between neighbors in an individual sample, before identifying focal regions in multiple samples. In this study, we propose a novel algorithm, referred to as the wavelet-based identification of focal genomic aberrations (WIFA), to address the following issues: (i) distinguish signals from noise among probes having high aberrations, (ii) detect focal aberrations by considering the differences between aberrations and their neighbors, as well as the amount of aberrations, and (iii) consider the consistency of aberrations in multiple samples.

Wavelet analysis is a mathematical technique for representing data. Wavelets can be used to remove noise from observed data (contaminated by noise) while preserving important features of true data; this process is called wavelet denoising. In this study, we use a variant of the translation-invariant level dependent wavelet denoising method in [19] to obtain translation-invariant approximations of the smooth (low-frequency) part of true data y LOW , and of the local (high-frequency) behavior of true data y HIGH , from the observed data y. In brief, y LOW is based on the averages of the neighboring values of y, and y HIGH is based on the differences of neighboring values of y, followed by thresholding. Thresholding is only performed in y HIGH since it is likely that noise would be more pronounced in the high-frequency content. After obtaining y HIGH via the wavelet analysis, we obtain for each sample by adjusting some obvious artifacts in y HIGH , and then cluster continuous focal aberrations across multiple samples. By applying this approach to GBM and lung cancer data sets, we are able to find previously known cancer related genes in the focal aberrations. In addition, a similar procedure based on y LOW enables us to detect broad regions of chromosomal aberrations.

The difficulty of assessing the performance in detecting focal aberrations is that the true answer is often not known, since regions containing cancer related genes still need to be revealed. Hence, we compare genes identified by our approach to known cancer genes obtained from GISTIC [17]. Based on this comparison, in addition to confirming regions identified by GISTIC, we are able to find new regions not previously identified by GISTIC; literature shows that these new regions contain known oncogenes. In addition, WIFA is compared to STAC and MCR, outperforming these two methods both in the simulation and GBM data. The source code for WIFA is available at http://www.gcancer.org/wifa/WIFA.html.

Materials and methods

Materials

We collected and reanalyzed three single nucleotide polymorphism (SNP) data sets: 154 GBM tumor samples [17], 178 GBM tumor samples [20], and 371 lung tumor samples [21]. We downloaded the signal intensities of the data sets from either the websites of the original publications or the GEO database. We used all chromosomes except X and Y. Both GBM data sets were generated from an Affymetrix 100K SNP microarray, and the lung cancer data set was from 250K Sty SNP arrays. Since the 100K SNP array consisted of independent 50K Xba and 50K Hind arrays, we then merged these two arrays along the chromosome positions. Next, to calculate copy number changes from signal intensities, we applied the following procedure (similar to original publications): (i) signal intensities were transformed using the log2 transform to make the noise constant; (ii) for each sample, the median value across all probes was subtracted from the probes; (iii) to obtain the log2 ratio for tumor samples compared to the normal samples, log2 transformed normal samples were subtracted from the log2 transformed tumor samples; and (iv) to remove copy number variants (CNVs) that occur in normal population, positions with CNVs obtained from [22] were omitted from the data sets.

WIFA methodology

Figure 1 illustrates the WIFA method for detecting broad and focal aberrations in SNP array data sets using the wavelet transform. The procedure for detecting focal aberrations is as follows. First, the difference between the aberrations and their neighbors is measured for the SNP array data using the wavelet transform and a post-processing step; this process is called a HIGH transform and generates . Probes that have a larger difference with their neighbors than a given threshold value are likely to have nonzero values in . Thus, can be used to distinguish driving aberrations from passenger aberrations because the amount of aberrations for driving genes is usually larger than for their neighbors. Second, the significance of probes for indicating the driving gene in multiple samples is calculated as the sum of the values in from multiple samples, and is referred to as . This value is generated based on the assumption that both the number of samples with aberrations and the amount of aberrations are important indicators for discovering driving aberrations. Third, probes having nonzero values are clustered with neighbors having nonzero values within a certain distance. Since chromosome positions are also important for identifying candidate cancer-related genes, we consider sets of neighboring probes in this third step instead of using the information from individual probes. To prioritize these clusters, the score of each cluster is determined by summing the probes' values in in the cluster. Similar to the procedure for detecting focal aberrations, broad aberrations are identified using ; values are calculated for each sample and then summed for all samples, denoted as . The statistical significance of the aberrations is subsequently calculated as shown in Figure 1(d)-(e).

Figure 1
figure 1

Schematic of our approach. (a) From a SNP array sample, , representing differences of aberrations with neighbors, and values, showing the overall aberrations, are generated using the wavelet transform. (b) The from multiple samples are summed in order to combine aberrations from multiple samples. (c) Focal aberrations are identified by clustering probes with their neighbors. (d) The values from multiple samples are summed to identify aberrations from multiple samples. (e) Broad aberration regions are identified if the summation of values across multiple samples are larger than a threshold of statistical significance the size of a chromosome arm.

Wavelet transform and its use in WIFA

Wavelet transform

Let J and L be integers such that 1 ≤ L ≤ J - 1. The (discrete) wavelet transform (WT) maps a given data set y of length 2Jinto the scaling coefficients s := {sL,t: t = 0, 1, ..., 2 L - 1} and the wavelet coefficients w := {wj,t: j = L, L + 1, ..., J - 1; t = 0, 1, ..., 2j- 1}. Note that WT is linear and can be represented by a 2J× 2Jorthogonal matrix W. WT depends on the specific wavelet selected. In this paper, we use a WT based on the Haar wavelet. The Haar wavelet transform is used to simply pair up input values, storing the difference and passing the average, and it repeats this process recursively, pairing up the averages to provide the next level--finally resulting in 2 L averages (stored in the scaling coefficients s) and 2J- 2 L differences (that are stored in the wavelet coefficients w). For more details about wavelets, refer to [23], [24], and [25].

Wavelet procedure for WIFA

A drawback of the traditional WT is that it is not translation-invariant. In attempts to remedy this problem, a number of translation-invariant wavelet transforms have been employed [9, 19, 26]. Among the available translation-invariant wavelet transforms, we use the stationary wavelet transform by [27] for our WIFA methodology.

Suppose that a single tumor sample is fixed, and that a chromosome of the sample has n = 2Jlocations for some positive integer J. We then denote y i as the observed copy number change at the i-th genomic location x i for i = 1, ..., n. We assume that the genomic locations x i are fixed, known and equally spaced; for a wavelet analysis with unequally spaced data, see example [28]. We further assume that for i = 1, ..., n, the observed copy number change can be expressed as

(1)

where f is an underlying function representing the true copy number change, and ε i is a stationary Gaussian noise with a zero mean value [19].

The basic principle of wavelet denoising then becomes to identify and zero out the wavelet coefficients y := {y i : i = 1, ..., n} that are likely to contain noise, and to estimate {f (x i ): i = 1, ..., n} in (1). Instead of the usual wavelet denoising procedure [29], we use the following modified steps as the main wavelet denoising procedure for our methodology:

(Step 1) Given the data y of length n = 2 J , and an integer L such that 1 ≤ L ≤ J - 1, compute W y = {s, w}. For an integer M ≥ L, let w MID be the wavelet coefficients w of y with levels j = L, L + 1, ..., M - 1, and w HIGH be the wavelet coefficients w of y with levels j = M, M + 1, ..., J - 1.

(Step 2) Define T LOW :{s, w MID , w HIGH } ↦ {s, 0, 0} and , where is obtained from w HIGH by thresholding using a hard threshold function [30] with the threshold value for each level j = M, M + 1, ..., J - 1. Here, is the estimate of the noise variance for the wavelet coefficients at level j, n j is the length of the subsignal at level j, and C is a constant to be determined later.

(Step 3) Let S represent a shift operator of the one time unit [27]. Then, compute the translation-invariant low-frequency and high-frequency approximations y LOW and y HIGH defined as

The threshold value used in (Step 2) is a variant of the threshold value used in [19]. After (Step 1)-(Step 3), we obtain y LOW and y HIGH . Note that y LOW gives a translation-invariant approximation of the smooth (low-frequency) part of the true data, which provides rough estimate for detecting a broad region of chromosomal aberrations. This value is based on the Haar scaling coefficients, which can be considered as averages of neighboring values of y. On the other hand, y HIGH gives a translation-invariant approximation of the local (high-frequency) behavior of the true data, which provides a rough idea for detecting the focal aberration of chromosomes; y HIGH is based on Haar wavelet coefficients -- which are differences between the neighboring values of y--and the threshold.

Dividing the wavelet coefficients depending on the level has been used in many studies (see [19] and [31]), although the exact form may vary. The main difference between our method and other level-dependent wavelet denoising methods is that we concentrate only on the low-frequency scaling and high-frequency wavelet coefficients, and do not consider the mid-frequency wavelet coefficients. To do this, we add the parameter M to the usual wavelet thresholding process; from the discussion in the Results section, this parameter allows us to identify focal genomic aberrations more effectively.

The values of y LOW for all chromosomes of a given sample y are obtained simply by processing each chromosome separately, and then concatenating the values of y LOW for each chromosome; similarly, the values of y HIGH for all chromosomes can be found.

Next, let us explain how we treat the problem of the boundary of each chromosome. In brief, the problem of the boundary is caused by our previous assumption that the chromosome has n = 2Jlocations for a positive integer J, which may not hold true in general; for a more detailed discussion about boundary conditions, refer to [32]. We handle this boundary problem by extending each chromosome first symmetrically and then periodically. Our experiments show the effectiveness of this method. Other parameters used in our methodology include:

  • Constant C in the threshold value : in (Step 2), we use the threshold value to threshold the high-frequency wavelet coefficients at level j. A smaller C would allow more nonzero values in y HIGH .

  • Level L: parameter L can be as small as 1 and as large as J - 1. A smaller L would increase the coarseness of the y LOW approximation, whereas a larger L would make it finer.

  • Level M : parameter M can be as small as L and as large as needed. A smaller M would produce a y HIGH with more nonzero values, whereas a larger M would produce a y HIGH with fewer nonzero values. Since this is not a standard parameter in wavelet literature, we pay special attention to it and discuss its effect on our methodology by varying M. See the Results section.

In the Results section, we further discuss which values of the above parameters C, L, and M are used for each of the data sets in our experiments. To implement the wavelet transforms, we used WaveLab http://www-stat.stanford.edu/%7Ewavelab/Wavelab_850/index_wavelab850.html.

Identification of broad and focal aberrations in WIFA

Identification of focal aberrations

The values of y HIGH generated from the wavelet transform indicate the difference between the neighboring values of the denoised sample. To use this information for focal aberration detection in the WIFA method, we process the y HIGH values. In Figure 2(a), we draw the log2 ratio of 152 probes for a single sample, a part of the GBM SNP array data [17], in which there are strong amplifications between the 98th and 143th probes. The y HIGH values obtained by the wavelet transform are then presented in Figure 2(b). Note that negative y HIGH values are generated around the positive y HIGH values of the 98th and 143th probes. This negativity is due to the fact that the positions next to amplifications also have large differences with their neighbors. To keep only y HIGH positions with amplifications, we select the position with the highest absolute log2 ratio value among the consecutive positions with nonzero y HIGH values, and then assign zero to the positions with a different sign in the y HIGH values. This process generates , as shown in Figure 2(c). A similar process is then performed on the deletions.

Figure 2
figure 2

Processing y HIGH values. (a) log2 ratios of 152 probes of SNP array data are shown from one sample. (b) With the wavelet transform, y HIGH values representing neighboring values of the denoised sample are generated. Note that negative values are generated because positions next to amplifications also show large differences with their neighbors. (c) In this example, negative y HIGH values are set to zero to generate because they do not represent true aberrations. To keep only y HIGH positions with amplifications, we pick a position with the highest absolute log2 ratio value among the consecutive positions with nonzero y HIGH values, and then assign zero to the positions having a different sign in the y HIGH values.

After obtaining , WIFA considers the two following issues. Let be the value of at a position p. First, if for a given probe p, , and for its consecutive probes k on both sides, , the p might represent CNVs that are abundant in a normal population, instead of CNAs. Thus, we set . Second, we attempt to determine focal aberrations that are consistent across multiple samples. Figure 3(a) shows the log2 ratio of the SNP array data of 154 samples in the same region as in Figure 2(a); this region consists of 152 probes. The sample used in Figure 2 is one of these samples, and red (or blue) indicates the amplifications (or deletions, respectively). The HIGH transformed values of Figure 3(a) are then drawn in Figure 3(b). As shown in both Figures 2(c) and 3(b), a HIGH transform value assigns relatively big nonzero values to the boundaries of aberrations and relatively small (or zero) values to the middle of aberrations. Note, therefore, that zero values do not always indicate that there are no aberrations. Hence, consecutively or nearly consecutively occurring nonzero values across multiple samples might reflect the presence of true focal aberrations. As such, we sum the of the multiple samples shown in Figure 3(c), subsequently represented as .

Figure 3
figure 3

Comparing log2 ratio of SNP array data with for the GBM data set. (a) log2 ratios of the SNP array data for 154 GBM patients [17] are drawn for the region from 52,767 to 55,790 KB in chr7. Stronger red presents a larger log2 ratio, representing amplifications. Amplifications are abundant in this region. (b) in the corresponding regions of (a) are presented. Probes with nonzero values in are drawn in red (blue) for amplifications (deletions). EGFR, a GBM gene, is located in this region. (c) from multiple samples are drawn for the same region. A part of the region from 54,145 to 55,790 KB is detected as a focal aberration.

In order to identify the focal aberration regions, we consider the neighboring positions together instead of as a single position. For this task, we consider groups of positions having positive (or negative) values located within 1 MB along the chromosome. Then, in order to find regions of focal aberrations in a group, we construct clusters such that the two closest positions in a cluster having positive (or negative) values are located within a distance d. From the clusters in a group, we select a cluster c having the maximum score . In the clustering process, clusters containing nonzero values from only a single patient are removed. Then, statistically significant clusters are ranked based on their S(c) scores. In Figure 3(c), the cluster on the right is a focal aberration that contains a known cancer related gene (EGFR).

A statistical significance of each cluster is calculated based on the null hypothesis that consecutive aberrations in each sample are independent from those in other samples. Here, the number of permutations N and the significant value α are used to estimate the significance of clusters.

  1. 1.

    In each sample, segments of aberrations (a set of consecutive probes with ) are randomly positioned on a chromosome. This random positioning is then applied to all samples, generating randomly permuted data from the multiple samples. This permutation approach is described in detail in [11].

  2. 2.

    The process for detecting focal aberrations in multiple samples is subsequently applied to the randomly permuted data, generating a set of clusters.

  3. 3.

    Steps 1 and 2 are repeated N times. Let the max score of clusters from the i th permutation be the max_score(i).

  4. 4.

    The p-value of each cluster c of the observed data P cluster(c) can be calculated by comparing scores from the permuted and observed data:

    (2)

where S(c) is the score of a given cluster c, and I denotes the indicator function.

  1. 5.

    Clusters with Pcluster(c) less than α are considered statistically significant.

In this paper, we use N = 1,000 and α = 0.1, and the permutation and calculation of Pcluster is performed for each chromosome.

Identification of broad aberrations

After y LOW values are generated from the wavelet transform for each sample, we use y LOW as ; y LOW values do not require a processing step, contrary to y HIGH . To integrate multiple samples, we sum values from multiple samples, referred to as . Note that if all probes in a chromosome arm are statistically significant in , we consider it a broad aberration. We then calculate the statistical significance of in the following way. The null hypothesis for is that is independent among samples, so the summation of , , is the same across all probes in the chromosomes. To generate the null distribution, we first construct a histogram h i of in a single sample i by splitting values into bins at intervals of 0.01. Next, the distribution of is calculated by the convolution of h i of all samples, and the p-value of the observed is calculated by summing the probabilities from the tail of the null distribution to the observed value. The p-value is separately calculated for amplifications and deletions. For the correction of multiple tests, p-values are converted into q-values [33]; the p-values of are similarly calculated. This approach is similar to the calculation of statistical significance of aberrations used in [17]. Note that the p-values of are calculated for each probe, and the Pcluster discussed above is calculated for each cluster.

Results

Broad and focal aberrations in glioblastoma

We applied our approach to 154 GBM tumor samples [17]. After testing different values of C, L, and M (cf. Methods section), we selected C = 1.94, L = 9, and M = 12. Our experimental results for different values of M are shown below (experiments for different values of C and L are not shown). Since J total := ⌈log 2(n total )⌉ = 17, where n total is the number of total probes in the data set, L = 9 for this data set roughly indicates that we average the log2 ratios of probes in the 100K SNP array to obtain y LOW . In order to identify broad aberrations, we apply the LOW transform and calculate the q-values of . Here, amplifications and deletions in the size of a chromosome arm are considered broad aberrations, with a threshold q-value of 0.01. As shown in Additional File 1(a) and 1(b), chr7, 8q, 17q, 19p, and 20 are amplified, and chr6q, 9p, 10, 13, 14, and 22 are deleted in the size of a chromosome arm. Next, using the HIGH transform, our model is able to detect clusters with focal aberrations; we used d = 100 KB to construct clusters. Since EGFR, MDM2, PDGFRA, MDM4, CDK4, MET, CDKN2A, PTEN, RB1, CDK6, and MYC have been reported as important GBM related genes [34], we investigate whether the clusters contain these genes. In addition, we investigate the effect of different M values for detecting focal aberrations. We use M values ≥ 9 since M can have values from L, as described in the Methods section. The number of probes with nonzero values in is the largest when M = 9; Figure 4(a) shows that 71 statistically significant clusters are generated for this value. In these clusters, seven GBM related genes are ranked as the top seven clusters. As M increases, the number of clusters and the number of nonzero probes in decreases. Indeed, in Figure 4(g) only two clusters are generated when M = 15. In the range M = 10-12, eight or nine GBM genes are located in the highly ranked clusters; this observation shows that our method highly ranks clusters containing important GBM genes regardless of the M value. However, if we consider the size of the chromosomal region containing the identified focal aberrations, there is a preferred choice for M value. When M = 9, among all 71 clusters spanning 436 MB, the top seven clusters contained seven GBM genes. On the other hand, when M = 12, 19 clusters spanning 26 MB included nine GBM genes in the top nine clusters. Hence, we use M = 12 for further analysis. As shown in Figure 4(b), these nine clusters contain nine previously identified GBM related genes [34], including EGFR, MDM2, PDFGFA, MDM4, CDK4, MET (amplifications), CDKN2A, PTEN, and RB1 (deletions); however, MDM4 and RB1 lie slightly out of the detected region. These nine genes were also detected by GISTIC. In addition to these nine genes, aberrations of CDK6 and MYC have also been reported in multiple GBM studies [34]. However, using this GBM data set, aberrations of these two genes were detected neither by our method nor by the GISTIC method. The above results indicate that our method highly ranks most of the important GBM genes and reports only a small number of false positive positions--although there is a possibility that these false positive regions may include previously unreported GBM genes.

Figure 4
figure 4

Focal aberrations in GBM data with several M values. Focal aberrations of GBM data [17] are shown. and its corresponding p-values are generated using M values from 9 to 15. (a)-(b) On the left, p-values of are drawn across chromosomes with GBM related genes for M values of 9 and 12. Deletions (amplifications) are represented in blue (red). On the right, statistically significant clusters with GBM related gene symbols are shown. For example, in (a), 71 clusters are generated and the top seven clusters include seven GBM genes. These clusters span 436 MB chromosomal regions in total. Clusters with deletions (amplifications) are represented in blue (red). As M increases, the number of clusters decreases. Although the values of M change, GBM genes are still located in the highly ranked clusters. When M = 12, a cluster containing RB1 (MDM4) is indicated in light blue (light red), which denotes that RB1 (MDM4) lies slightly out of the cluster. (c)-(g) Clusters with M values of 10, 11, 13, 14, and 15 are shown for GBM genes.

Table 1 shows the positions of clusters in chromosomes, ranked according to the cluster scores when M = 12. WIFA identified ten additional regions (other than the above nine genes). Two regions include known cancer related genes (MYCN [35] and IGFBPL1 [36]), though the remaining eight regions do not contain any cancer related genes; Additional File 2 contains the gene symbols for all clusters. In contrast, GISTIC identified 17 additional regions. In these regions, five known cancer related genes are included, one of which is MYCN. The remaining 12 regions do not contain any cancer related genes. Hence, both methods contain regions that may require further analysis, or they might just be falsely detected regions. Let us now revisit Figure 3 in order to illustrate the use of the HIGH transform to detect focal aberrations in GBM data [17]. Figure 3(a) presents the SNP array data of 154 patients at positions from 52,767 to 55,790 KB in chr7. In this region, DNA amplification seems apparent in multiple patients. Figure 3(b) then gives the HIGH analysis for the corresponding region. Note that the cluster from 54,145 to 55,790 KB ranks 2nd in Table 1 and contains EGFR.

Table 1 Clusters with focal aberrations in GBM.

We also applied the proposed method to a GBM data set obtained by Kotliarov et al.[20]. We used the same parameter values for C, L, M, and d as for the previous GBM data, since both are generated using the same SNP array platform. The HIGH analysis for this GBM data generates eight clusters; among these clusters, one focal deletion contains CDKN2A, and five focal amplifications contain MDM4, PDGFRA, EGFR, MDM2, and CDK4 (Additional File 3 and Additional File 4). Note that MET is not included in the focal aberrations because amplification occurs only in a single sample. The six GBM genes identified using this data are also found in the previous GBM data set. This result confirms that our method is able to detect focal aberrations that are consistent across different experiments.

Broad and focal aberrations in lung cancer

We applied our method to the 371 lung cancer patients studied by Weir et al.[21]. Let us first explain how some of the parameters in our Methods section can be determined for a data set other than GBM data, by using this data set as an example. We recall that the parameters used for GBM data are C = 1.94, L = 9, M = 12, and J total = 17. Since the average distance between probes for GBM data set is 50 KB, the actual length of genomes we average for y LOW is approximately

and the actual length of genomes we consider as a focal aberration for y HIGH is approximately

For the lung data set, the average distance between probes is 13 K and J total := ⌈log 2(n total )⌉ = 18, where n total is the number of total probes in the data set. Since we want the actual length of genomes that we average for y LOW and the actual length of genomes we consider as focal aberrations to be similar to the GBM case, we select L = 8 and M = 11. Then, the actual length of genomes we average over for y LOW is approximately

and the actual length of genomes that we consider as focal aberrations for y HIGH is approximately

With the value of C = 1.94, the number of nonzero values in y HIGH of all chromosomes in the GBM data set is about 10% of the number of nonzero values in the sample. The value of C that provides approximately the same percentage of nonzero values in y HIGH for the lung data set is C = 5.2.

Using the LOW analysis, we then attempt to detect broad aberrations in lung cancer. For this task, the q-value is first calculated for each probe. As shown in Additional File 5 (a) and 5 (b), with a threshold q-value of 0.01: chr1p, 3p, 4q, 5q, 6q, 8p, 9, 10q, 13p, 15, 16q, 18, 21p, and 22 are deleted; and chr1q, 2p, 5p, 6p, 7, 8q, 14p, 17q, and 20q are amplified in the size of the chromosome arm.

When Weir et al.[21] analyzed this lung cancer data set using the GISTIC approach, they identified five deleted focal regions and 17 amplified focal regions with statistical significance: in these regions, ten known oncogenes (MDM2, MYC, EGFR, CDK4, KRAS, CCNE1, ERBB2, CCND1, TERT, and ARNT), two known tumor suppressor genes (CDKN2A and PTEN), and six new candidate genes (MBIP, NKX2-1, VEGFA, PTPRD, PDE4D, and AUTS2) were found. We applied the WIFA approach to this same data set (d = 50 KB). When M = 11, 20 clusters spanning 28 MB are generated. Table 2 and Additional File 6 present a detailed description of these 20 clusters. The top-ranked cluster contains MBIP, a new candidate gene that is also ranked at the top in the GISTIC analysis. Among the 18 cancer related genes noted above, six known oncogenes (MDM2, EGFR, KRAS, CCNE1, ERBB2, and CCND1), one known tumor suppressor gene (CDKN2A), and three new candidate genes (MBIP, NKX2-1, and VEGFA) are included in the focal aberrations. In addition, SS18 and FGFR1--which were identified by Weir et al., though they did not consider them statistically significant--are identified as having statistical significance in our study. Let us now look at the remaining clusters that do not contain cancer related genes reported by Weir et al. We investigated whether or not these remaining clusters contain other cancer related genes (Table 2). Two genes SMAD7 (chr18q21.1) and FGF10 (chr5p12) are located in focal aberration regions. It is known that SMAD7 functions as an intracellular antagonist of transforming growth factor beta (TGF-beta) signaling and is frequently unregulated in various cancers [37]. A recent study showed that a transgenic mouse model with SMAD7 disrupted TGF-beta signaling and increased lung carcinogenesis [38]. In our study, the values of in chr18:43,953-45,322 KB, where SMAD7 is located, are positive in two patients. Indeed, the averages of the log2 intensity ratio of these two patients are higher than those of patients having zero values in (Additional File 7(a)). This result implies the DNA amplification of SMAD7 in lung cancer. A member of the fibroblast growth factor FGF10 has also been reported in several cancer studies; multiple lines of evidences show that FGF10 plays important roles in various cancer types, including prostate and pancreatic cancers [39, 40]. Previously, the mRNA expression of FGF10 in the fetal lung of mice was shown to disrupt lung morphogenesis [41], and the alternation of FGF pathways frequently occurs in lung cancer [42]. Our analysis reveals that eight lung cancer patients contain DNA amplification in the chr5:42,891-44,452 KB regions, including FGF10. As shown in Additional File 7(b), the average values of the log2 intensity ratios of samples having positive values in are higher than those of samples having zero values in . This result suggests the possibility that the DNA copy numbers of FGF10 increase in lung cancer and might affect lung cancer development.

Table 2 Clusters with focal aberrations in lung cancer.

Let us further explain the difference between GISTIC and WIFA by looking at chr18:43,953-45,322 KB (where SMAD7 is located), which was identified only by WIFA. Figure 5(a) shows the log2 intensity ratios of two patients for part of chr18. Although both samples are commonly amplified in chr18:43,953-45,322 KB, the G-values obtained by GISTIC are not large enough to identify this region. The G-values are calculated by summing the log2 intensity ratios of the amplified samples; 40 samples are considered amplified in this region (log2 ratio>0.1). However, even though the original data from two patients (Figure 5(a)) were highly amplified and their differences with neighbors seemed significant, the G-values did not capture this significance. This is because the other 38 (amplified with less difference between neighboring values than the two) samples were also used to calculate the G-values, which resulted in the significance of the two samples being obscured (Figure 5(b)). In contrast, WIFA first calculates the differences with neighbors for each sample, then sums the differences. In WIFA, the values are high for the two samples, but the values are zero for the other samples since these other samples do not have any significant difference with their neighbors. Therefore, --the summation of values from multiple samples--can reflect the significant differences with the neighbors of these two samples (Figure 5(c)). Note that both GISTIC and WIFA identify amplification in chr18:20,300-23,559 KB.

Figure 5
figure 5

Chr18:18-62 MB regions. Both GISTIC and WIFA identify amplifications in chr18:20,300-23,559 KB, whereas amplifications in chr18:43,954-45,322 KB including SMAD7 are only identified by WIFA. (a) log2 ratios of two patients amplified in chr18:43,954-45,322 KB are shown. (b) G-scores in the same region by GISTIC are not large enough to be identified. (c) by WIFA is significantly higher in the same region.

To validate our choice of M, we conducted experiments with various M values. For example, with M = 9, 37 clusters spanning 161 MB included 12 cancer related genes, as shown in Additional File 8(a). However, even though the M = 9 case identified two more genes compared to M = 11, it required the search of five times more genomic regions; refer to Additional File 8 for the results of the other M values. Our analysis of lung cancer confirms that WIFA is useful for identifying cancer related genes in focal aberrations across different cancer types.

Comparison with other methods

We then compared our method with MCR and STAC. For implementation, we used the MCR from waviCGH [13](http://wavi.bioinfo.cnio.es/) and STAC from the authors' website (http://www.cbil.upenn.edu/STAC/). Note that the input files from both methods should have binary aberration calls of amplification, deletion, or no change; hence, GLAD [10], a segmentation method, was applied to single samples. The thresholds for amplification and deletion were then used to determine the aberration regions. In MCR, the fraction of samples in aberrant regions was used to determine the significant regions. In STAC, the p-value of the footprint was used as a measure of the significance of aberrant regions. For WIFA, the cluster score is used for this purpose.

We used a series of simulation data as the basis of our comparison, and generated the simulation data in two steps. First, ten different underlying true data were generated using Multiple Sample Analysis [11](http://www.cbil.upenn.edu/MSA/) software. For each true data, the length of a genome, in terms of number of markers, was 4,500; in addition, the number of samples was 50; the number of markers in the underlying concordant aberrations was 30; and the numbers of samples in concordant aberrations varied from 50% to 70%. In ten true data, the numbers of concordant aberrant regions varied from five to seven, and there were one or two nonconcordant regions. Second, the background aberrations were generated using a normal distribution. Because the maximum (in absolute) values of the markers for each sample were different, we set the standard deviation of the normal distribution to be the multiplication of a fixed number, which we refer to as the noise level, and the maximum value of the true data.

We investigated noise levels of 0.2 and 0.4. Performances of three methods are measured based on values for the area under a curve (AUC) for the sensitivity and false positive rate. For both noise levels, WIFA shows very good performance in identifying concordant regions in the simulation data, as shown in Figure 6. Note that MCR performs slightly better than WIFA when the noise level is 0.2, but WIFA is superior when the noise level is 0.4. Considering that a lower noise level generally results in easier noise removal, we can conclude that WIFA is the most useful in identifying concordant regions in the simulation data. During these simulations, the parameter values of C, L, and M in WIFA were determined in the same manner as for lung cancer. In MCR and STAC, 0.1 is used as the threshold value for identifying amplifications and deletions in a single sample, after application of the GLAD segmentation method.

Figure 6
figure 6

Comparison of STAC, MCR, and WIFA in the simulation data. Averages of AUC values of ten underlying true data in three methods are drawn for noise levels of 0.2 and 0.4. The standard deviation of the AUC values for ten underlying true data is drawn as error bars.

We next compared WIFA with MCR and STAC using real GBM data sets. As a measure of performance, we used the length of genomes to identify known GBM genes. In Figure 7, the y-axis represents the length of the genome regions sorted based on the region significance, and the x-axis represents the number of GBM genes contained in the corresponding genomes in the y-axis. Because methods with high performance require a smaller length of genomes in their search for known GBM related genes, methods closer to the x-axis generally outperform other methods. Here, on average, WIFA typically shows the best performance, as nine genes can be identified around 10,000 KB. In MCR and STAC, five different thresholds of 0.1, 0.2, 0.3, 0.4, and 0.5 are used to determine the amplification and deletion. In both methods, the threshold value of 0.3 shows the best performance. Figure 7 includes the graphs of the 0.3 threshold, along with one other threshold for comparison. In MCR, only three or four genes are identified within 10,000 KB; more than 100,000 KB is required to identify the remaining genes. In STAC, more than 10,000 KB is required to identify most of the genes.

Figure 7
figure 7

Comparison of STAC, MCR, and WIFA in GBM data. The y-axis is the length of the genome regions sorted based on the significance of regions, and the x-axis is the number of GBM genes contained in the corresponding genomes in the y-axis. When the genome length is larger than 6,000,000 KB, it is shown exactly as 6,000,000 KB for clarity. Because methods with high performance require a smaller length of genomes in their search for known GBM related genes, a method closer to x-axis is considered to outperform other methods.

Discussion and Conclusions

Our work is based on a wavelet analysis. The wavelet analysis has been used in other papers to analyze array CGH data (cf. [9], [43]); for example, in [9], it is shown to perform well compared to approaches such as CBS, a change-point method [8], and HMM [44]. Compared to other wavelet-based approaches used to analyze array CGH data, the main differences in WIFA include: (i) a new parameter M is introduced, which is used to identify focal genomic aberrations more effectively; and (ii) a new method that integrates multiple samples, as a post-processing step in the wavelet analysis, is suggested in order to identify cancer-related genes from a data set having multiple samples. As a result, we were able to detect cancer related genes with high rate of accuracy in both GBM and lung data sets.

CNPs are another type of DNA variation that are abundant in the normal population, and are usually observed in kilobase or megabase DNA deletions or duplications. When a HIGH analysis was applied to SNP microarrays, deletions of a single SNP probe were frequently observed. When these were compared to the positions of known CNPs [22], many regions were found to overlap (data not shown); these single SNP probes were removed from our analysis since the relevance of CNPs to cancer requires further study. However, if CNPs are the main subject of analysis, it is possible that a new method based on our HIGH analysis could be developed to achieve this task. As a promising example, a single deletion of the SNP probe from 13 patients was observed at the 55,205,890 base position of chr11 when the GBM data set was used [17]. Olfactory receptor (OR) genes such as OR4C11, OR4P4, OR4S2, and OR4C6 are located at this position, and it was previously shown that the OR genomic location is frequently affected by CNPs [45]. This observation suggests that our wavelet analysis has the potential to be broadly applied to detect various kinds of focal aberrations.

References

  1. Liu F, Park PJ, Lai W, Maher E, Chakravarti A, Durso L, Jiang X, Yu Y, Brosius A, Thomas M, Chin L, Brennan C, DePinho RA, Kohane I, Carroll RS, Black PM, Johnson MD: A genome-wide screen reveals functional gene clusters in the cancer genome and identifies EphA2 as a mitogen in glioblastoma. Cancer Res 2006, 66(22):10815–10823. 10.1158/0008-5472.CAN-06-1408

    Article  CAS  PubMed  Google Scholar 

  2. Chaudhary J, Schmidt M: The impact of genomic alterations on the transcriptome: a prostate cancer cell line case study. Chromosome Res 2006, 14(5):567–586. 10.1007/s10577-006-1055-4

    Article  CAS  PubMed  Google Scholar 

  3. Tonon G, Wong KK, Maulik G, Brennan C, Feng B, Zhang Y, Khatry DB, Protopopov A, You MJ, Aguirre AJ, Martin ES, Yang Z, Ji H, Chin L, Depinho RA: High-resolution genomic profiles of human lung cancer. Proc Natl Acad Sci USA 2005, 102(27):9625–9630. 10.1073/pnas.0504126102

    Article  PubMed Central  CAS  PubMed  Google Scholar 

  4. Pole JCM, Courtay-Cahen C, Garcia MJ, Blood KA, Cooke SL, Alsop AE, Tse DML, Caldas C, Edwards PAW: High-resolution analysis of chromosome rearrangements on 8p in breast, colon and pancreatic cancer reveals a complex pattern of loss, gain and translocation. Oncogene 2006, 25(41):5693–5706. 10.1038/sj.onc.1209570

    Article  CAS  PubMed  Google Scholar 

  5. Phillips HS, Kharbanda S, Chen R, Forrest WF, Soriano RH, Wu TD, Misra A, Nigro JM, Colman H, Soroceanu L, Williams PM, Modrusan Z, Feuerstein BG, Aldape K: Molecular subclasses of high-grade glioma predict prognosis, delineate a pattern of disease progression, and resemble stages in neurogenesis. Cancer Cell 2006, 9(3):157–173. [Comparative Study] [Comparative Study] 10.1016/j.ccr.2006.02.019

    Article  CAS  PubMed  Google Scholar 

  6. Myllykangas S, Bohling T, Knuutila S: Specificity, selection and significance of gene amplifications in cancer. Semin Cancer Biol 2007, 17: 42–55. 10.1016/j.semcancer.2006.10.005

    Article  CAS  PubMed  Google Scholar 

  7. Jong K, Marchiori E, van der Vaart A, Chin SF, Carvalho B, Tijssen M, Eijk PP, van den Ijssel P, Grabsch H, Quirke P, Oudejans JJ, Meijer GA, Caldas C, Ylstra B: Cross-platform array comparative genomic hybridization meta-analysis separates hematopoietic and mesenchymal from epithelial tumors. Oncogene 2007, 26(10):1499–1506. [Evaluation Studies] [Evaluation Studies] 10.1038/sj.onc.1209919

    Article  CAS  PubMed  Google Scholar 

  8. Olshen AB, Venkatraman ES, Lucito R, Wigler M: Circular binary segmentation for the analysis of array-based DNA copy number data. Biostatistics 2004, 5(4):557–572. 10.1093/biostatistics/kxh008

    Article  PubMed  Google Scholar 

  9. Hsu L, Self S, Grove D, Randolph T, Wang K, Delrow J, Loo L, Porter P: Denoising array-based comparative genomic hybridization data using wavelets. Biostatistics 2005, 6(2):211–26. 10.1093/biostatistics/kxi004

    Article  PubMed  Google Scholar 

  10. Hupe P, Stransky N, Thiery J, Radvanyi F, Barillot E: Analysis of array CGH data: from signal ratio to gain and loss of DNA regions. Bioinformatics 2004, 20(18):3413–22. 10.1093/bioinformatics/bth418

    Article  CAS  PubMed  Google Scholar 

  11. Guttman M, Mies C, Dudycz-Sulicz K, Diskin S, Baldwin D, Stoeckert CJJ, Grant G: Assessing the significance of conserved genomic aberrations using high resolution genomic microarrays. PLoS Genet 2007, 3(8):e143. 10.1371/journal.pgen.0030143

    Article  PubMed Central  PubMed  Google Scholar 

  12. Lee H, Kong S, Park P: Integrative analysis reveals the direct and indirect interactions between DNA copy number aberrations and gene expression changes. Bioinformatics 2008, 24(7):889–96. 10.1093/bioinformatics/btn034

    Article  PubMed Central  CAS  PubMed  Google Scholar 

  13. Carro A, Rico D, Rueda O, Díaz-Uriarte R, Pisano D: waviCGH: a web application for the analysis and visualization of genomic copy number alterations. Nucleic Acids Res 2010, 38(Suppl):W182–7.

    Article  PubMed Central  CAS  PubMed  Google Scholar 

  14. Oh M, Song B, Lee H: CAM: a web tool for combining array CGH and microarray gene expression data from multiple samples. Comput Biol Med 2010, 40(9):781–5. 10.1016/j.compbiomed.2010.07.006

    Article  CAS  PubMed  Google Scholar 

  15. Maher E, Brennan C, Wen P, Durso L, Ligon K, Richardson A, Khatry D, Feng B, Sinha R, Louis D, Quackenbush J, Black P, Chin L, DePinho R: Marked genomic differences characterize primary and secondary glioblastoma subtypes and identify two distinct molecular and clinical secondary glioblastoma entities. Cancer Res 2006, 66(23):11502–13. 10.1158/0008-5472.CAN-06-2072

    Article  CAS  PubMed  Google Scholar 

  16. Diskin S, Eck T, Greshock J, Mosse Y, Naylor T, Stoeckert CJJ, Weber B, Maris J, Grant G: STAC: A method for testing the significance of DNA copy number aberrations across multiple array-CGH experiments. Genome Res 2006, 16(9):1149–58. 10.1101/gr.5076506

    Article  PubMed Central  CAS  PubMed  Google Scholar 

  17. Beroukhim R, Getz G, Nghiemphu L, Barretina J, Linhart HsuehTD, et al.: Assessing the significance of chromosomal aberrations in cancer: Methodology and application to glioma. Proc Natl Acad Sci USA 2007, 104(50):20007–20012. 10.1073/pnas.0710052104

    Article  PubMed Central  CAS  PubMed  Google Scholar 

  18. Nigro JM, Misra A, Zhang L, Smirnov I, Colman H, Griffin C, Ozburn N, Chen M, Pan E, Koul D, Yung WKA, Feuerstein BG, Aldape KD: Integrated array-comparative genomic hybridization and expression array profiles identify clinically relevant molecular subtypes of glioblastoma. Cancer Res 2005, 65(5):1678–1686. [Comparative Study] [Comparative Study] 10.1158/0008-5472.CAN-04-2921

    Article  CAS  PubMed  Google Scholar 

  19. Johnstone IM, Silverman BW: Wavelet Threshold Estimators for Data with Correlated Noise. J Royal Statist Soc 1997, B 59(2):319–351.

    Article  Google Scholar 

  20. Kotliarov Y, Steed M, Christopher N, Walling J, Su Q, Center A, Heiss J, Rosenblum M, Mikkelsen T, Zenklusen J, Fine H: High-resolution global genomic survey of 178 gliomas reveals novel regions of copy number alteration and allelic imbalances. Cancer Res 2006, 66(19):9428–36. 10.1158/0008-5472.CAN-06-1691

    Article  PubMed Central  CAS  PubMed  Google Scholar 

  21. Weir B, Woo M, Getz G, Perner S, Ding L, Beroukhim R, Lin W, Province M, Kraja A, Johnson L, Shah K, Sato M, Thomas R, Barletta J, Borecki I, Broderick S, Chang A, Chiang D, Chirieac L, Cho J, Fujii Y, Gazdar A, Giordano T, Greulich H, Hanna M, Johnson B, Kris M, Lash A, Lin L, Lindeman N, Mardis E, McPherson J, Minna J, Morgan M, Nadel M, Orringer M, Osborne J, Ozenberger B, Ramos A, Robinson J, Roth J, Rusch V, Sasaki H, Shepherd F, Sougnez C, Spitz M, Tsao M, Twomey D, Verhaak R, Weinstock G, Wheeler D, Winckler W, Yoshizawa A, Yu S, Zakowski M, Zhang Q, Beer D, Wistuba I, Watson M, Garraway L, Ladanyi M, Travis W, Pao W, Rubin M, Gabriel S, Gibbs R, Varmus H, Wilson R, Lander E, Meyerson M: Characterizing the cancer genome in lung adenocarcinoma. Nature 2007, 450(7171):893–8. 10.1038/nature06358

    Article  PubMed Central  CAS  PubMed  Google Scholar 

  22. Conrad D, Andrews T, Carter N, Hurles M, Pritchard J: A high-resolution survey of deletion polymorphism in the human genome. Nat Genet 2006, 38: 75–81. 10.1038/ng1697

    Article  CAS  PubMed  Google Scholar 

  23. Mallat SG: A theory for multiresolution signal decomposition: the wavelet representation. IEEE Trans Pattern Anal Machine Intell 1989, 11(7):674–693. 10.1109/34.192463

    Article  Google Scholar 

  24. Daubechies I: Ten Lectures on Wavelets. Philadelphia: Soc Ind Appl Math 1992.

    Google Scholar 

  25. Meyer Y: Wavelets and operators. Cambridge: Cambridge University Press; 1992.

    Google Scholar 

  26. Wang XH, Istepanian RSH, Song YH: Microarray image enhancement by denoising using stationary wavelet transform. IEEE Trans Nanobiosci 2003, 2(4):184–189. 10.1109/TNB.2003.816225

    Article  CAS  Google Scholar 

  27. Coifman RR, Donoho DL: Translation-Invariant De-Noising. In Wavelets and Statistics. Volume 103. Berlin: Springer-Verlag; 1995:125–150.

    Chapter  Google Scholar 

  28. Sardy S, Percival DB, Bruce AG, Gao HY, Sthestzle W: Wavelet shrinkage for unequally spaced data. Statistics and Computing 1999, 9: 65–75. 10.1023/A:1008818328241

    Article  Google Scholar 

  29. Donoho DL, Johnstone IM: Ideal spatial adaptation by wavelet shrinkage. Biometrika 1994, 81: 425–455. 10.1093/biomet/81.3.425

    Article  Google Scholar 

  30. Rosas-Orea MCE, Hernandez-Diaz M, Alarcon-Aquino V, Guerrero-Ojeda LG: A Comparative Simulation Study of Wavelet Based Denoising Algorithms. Proceedings of the 15th International Conference on Electronics, Communications and Computers 2005, 125–130.

    Google Scholar 

  31. Barford P, Kline J, Plonka D, Ron A: A Signal Analysis of Network Traffic Anomalies. Proceedings of ACM SIGCOMM Internet Measurement Workshop: November 2002; France, ACM 2002, 71–82.

    Chapter  Google Scholar 

  32. Strang G, Nguyen T: Wavelets and filter banks. Wellesley: Wellesley-Cambridge Press; 1996.

    Google Scholar 

  33. Storey J, Tibshirani R: Statistical significance for genomewide studies. Proc Natl Acad Sci USA 2003, 100(16):9440–5. 10.1073/pnas.1530509100

    Article  PubMed Central  CAS  PubMed  Google Scholar 

  34. Reifenberger G, Collins VP: Pathology and molecular genetics of astrocytic gliomas. J Mol Med 2004, 82(10):656–670. 10.1007/s00109-004-0564-x

    Article  CAS  PubMed  Google Scholar 

  35. Futreal P, Coin L, Marshall M, Down T, Hubbard T, Wooster R, Rahman N, Stratton M: A census of human cancer genes. Nat Rev Cancer 2004, 4(3):177–83. 10.1038/nrc1299

    Article  PubMed Central  CAS  PubMed  Google Scholar 

  36. Smith P, Nicholson L, Syed N, Payne A, Hiller L, Garrone O, Occelli M, Gasco M, Crook T: Epigenetic inactivation implies independent functions for insulin-like growth factor binding protein (IGFBP)-related protein 1 and the related IGFBPL1 in inhibiting breast cancer phenotypes. Clin Cancer Res 2007, 13(14):4061–8. 10.1158/1078-0432.CCR-06-3052

    Article  CAS  PubMed  Google Scholar 

  37. Kleeff J, Ishiwata T, Maruyama H, Friess H, Truong P, Büchler M, Falb D, Korc M: The TGF-beta signaling inhibitor Smad7 enhances tumorigenicity in pancreatic cancer. Oncogene 1999, 18(39):5363–72. 10.1038/sj.onc.1202909

    Article  CAS  PubMed  Google Scholar 

  38. Luo X, Ding Q, Wang M, Li Z, Mao K, Sun B, Pan Y, Wang Z, Zang Y, Chen Y: In vivo disruption of TGF-beta signaling by Smad7 in airway epithelium alleviates allergic asthma but aggravates lung carcinogenesis in mouse. PLoS One 2010, 5(4):e10149. 10.1371/journal.pone.0010149

    Article  PubMed Central  PubMed  Google Scholar 

  39. Memarzadeh S, Xin L, Mulholland D, Mansukhani A, Wu H, Teitell M, Witte O: Enhanced paracrine FGF10 expression promotes formation of multifocal prostate adenocarcinoma and an increase in epithelial androgen receptor. Cancer Cell 2007, 12(6):572–85. 10.1016/j.ccr.2007.11.002

    Article  PubMed Central  CAS  PubMed  Google Scholar 

  40. Nomura S, Yoshitomi H, Takano S, Shida T, Kobayashi S, Ohtsuka M, Kimura F, Shimizu H, Yoshidome H, Kato A, Miyazaki M: FGF10/FGFR2 signal induces cell migration and invasion in pancreatic cancer. Br J Cancer 2008, 99(2):305–13. 10.1038/sj.bjc.6604473

    Article  PubMed Central  CAS  PubMed  Google Scholar 

  41. Clark J, Tichelaar J, Wert S, Itoh N, Perl A, Stahlman M, Whitsett J: FGF-10 disrupts lung morphogenesis and causes pulmonary adenomas in vivo. Am J Physiol Lung Cell Mol Physiol 2001, 280(4):L705–15.

    CAS  PubMed  Google Scholar 

  42. Calvo R, West J, Franklin W, Erickson P, Bemis L, Li E, Helfrich B, Bunn P, Roche J, Brambilla E, Rosell R, Gemmill R, Drabkin H: Altered HOX and WNT7A expression in human lung cancer. Proc Natl Acad Sci USA 2000, 97(23):12776–81. 10.1073/pnas.97.23.12776

    Article  PubMed Central  CAS  PubMed  Google Scholar 

  43. Ben-Yaacov E, Eldar Y: A fast and flexible method for the segmentation of aCGH data. Bioinformatics 2008, 24(16):i139–45. 10.1093/bioinformatics/btn272

    Article  PubMed  Google Scholar 

  44. Fridlyand J, Snijders AM, Pinkel D, Albertson DG, Jain AN: Hidden Markov models approach to the analysis of array CGH data. J Multivar Anal 2004, 90: 132–153. 10.1016/j.jmva.2004.02.008

    Article  Google Scholar 

  45. Hasin Y, Olender T, Khen M, Gonzaga-Jauregui C, Kim P, Urban A, Snyder M, Gerstein M, Lancet D, Korbel J: High-resolution copy-number variation map reflects human olfactory receptor diversity and evolution. PLoS Genet 2008, 4(11):e1000249. 10.1371/journal.pgen.1000249

    Article  PubMed Central  PubMed  Google Scholar 

Download references

Acknowledgements

We would like to thank the three anonymous reviewers for their helpful comments. This work was supported by the National Research Foundation (NRF) of Korea funded by the Ministry of Education, Science and Technology (MEST) (2010-0003597).

Author information

Authors and Affiliations

Authors

Corresponding author

Correspondence to Hyunju Lee.

Additional information

Authors' contributions

YH developed and implemented the proposed method, and wrote the manuscript. HL initiated the project, developed and implemented the proposed method, and wrote the manuscript. All authors read and approved the final manuscript.

Electronic supplementary material

12859_2010_4539_MOESM1_ESM.PDF

Additional file 1:Broad aberrations in GBM data[17]. Broad aberrations of GBM data [17] are shown with a q-value threshold of 0.01: (a) deletions are shown in chr6q, 9p, 10, 13, 14, and 22, and (b) amplifications are shown in chr7, 8q, 17q, 19p, and 20. (PDF 105 KB)

12859_2010_4539_MOESM2_ESM.XLS

Additional file 2:Clusters with focal aberrations in GBM data set[17]. 19 clusters using HIGH analysis are shown when M = 12. 'Score' is the sum of values for positions in the cluster. Positive (or negative) value represents that a cluster contains amplified (deleted) focal aberrations. Clusters are ordered by the score. 'Pcluster' is a statistical significance of the cluster. Chromosome, cytoband, start and end positions of cluster regions, the number of patients with focal aberrations, and genes in the focal aberrations are shown. Gene annotations are based on hg18 human genome assembly. (XLS 30 KB)

12859_2010_4539_MOESM3_ESM.JPEG

Additional file 3:Focal aberrations in GBM data[20]. Focal aberrations of GBM data [20] are shown with M = 12. Deletions (amplifications) are indicated in blue (red). Focal deletions contain CDKN2A, and focal amplifications contain MDM4, PDGFRA, EGFR, MDM2, and CDK4. (JPEG 36 KB)

12859_2010_4539_MOESM4_ESM.CSV

Additional file 4:Clusters with focal aberrations in GBM data set[20]. 8 clusters using HIGH analysis are shown when M = 12. 'Score' is the sum of values for positions in the cluster. Positive (or negative) values indicate that a cluster contains amplified (deleted) focal aberrations. Clusters are ordered by score. 'Pcluster' is the statistical significance of the cluster. Chromosome, cytoband, start and end positions of cluster regions, the number of patients with focal aberrations, and genes in the focal aberrations are shown. Gene annotations are based on hg18 human genome assembly. (CSV 2 KB)

12859_2010_4539_MOESM5_ESM.PDF

Additional file 5:Broad aberrations in lung cancer data[21]. Broad aberrations of lung cancer data are shown for a q-value threshold of 0.01. (a) Deletions are shown in chr1p, 3p, 4q, 5q, 6q, 8p, 9, 10q, 13p, 15, 16q, 18, 21p, and 22. (b) Amplifications are shown in chr1q, 2p, 5p, 6p, 7, 8q, 14p, 17q, and 20q. (PDF 115 KB)

12859_2010_4539_MOESM6_ESM.XLS

Additional file 6:Clusters with focal aberrations in lung data set[21]. 20 clusters from the HIGH analysis are shown when M = 11. 'Score' is the sum of values for positions in the cluster. Positive (or negative) values indicate that a cluster contains amplified (deleted) focal aberrations. Clusters are ordered by score. 'Pcluster' is the statistical significance of the cluster. Chromosome, cytoband, start and end positions of cluster regions, the number of patients with focal aberrations, and genes in the focal aberrations are shown. Gene annotations are based on hg18 human genome assembly. (XLS 24 KB)

12859_2010_4539_MOESM7_ESM.PDF

Additional file 7:log2 intensity ratio of patients in the regions including SMAD7 and FGF10. (a) In the region chr18:43,954-45,322 KB (133 probes), where SMAD7 is located, two patients have positive values. For each probe, the average values of intensities of the two groups of patients are plotted: 'Group1' contains patients having positive values in and 'Group2' contains patients having zero values in . (b) In the region chr5:42,891-44,452KB (77 probes), where FDF10 is located, eight patients have positive values in . In both cases, it is clearly shown that the log2 intensity ratio is higher in patients having positive values in than samples having a zero value in . (PDF 976 KB)

12859_2010_4539_MOESM8_ESM.PDF

Additional file 8:Focal aberrations in lung cancer data for several M values. Focal aberrations of lung cancer data [21] are shown. M values used range from 9 to 12. (a)-(d) As described in Figure 4(a)-(g) in the main text. (PDF 205 KB)

Authors’ original submitted files for images

Rights and permissions

This article is published under license to BioMed Central Ltd. This is an Open Access article distributed under the terms of the Creative Commons Attribution License (http://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

Hur, Y., Lee, H. Wavelet-based identification of DNA focal genomic aberrations from single nucleotide polymorphism arrays. BMC Bioinformatics 12, 146 (2011). https://doi.org/10.1186/1471-2105-12-146

Download citation

  • Received:

  • Accepted:

  • Published:

  • DOI: https://doi.org/10.1186/1471-2105-12-146

Keywords