Skip to main content

CrossHybDetector: detection of cross-hybridization events in DNA microarray experiments

Abstract

Background

DNA microarrays contain thousands of different probe sequences represented on their surface. These are designed in such a way that potential cross-hybridization reactions with non-target sequences are minimized. However, given the large number of probes, the occurrence of cross hybridization events cannot be excluded. This problem can dramatically affect the data quality and cause false positive/false negative results.

Results

CrossHybDetector is a software package aimed at the identification of cross-hybridization events occurred during individual array hybridization, by using the probe sequences and the array intensity values. As output, the software provides the user with a list of array spots potentially 'corrupted' and their associated p-values calculated by Monte Carlo simulations. Graphical plots are also generated, which provide a visual and global overview of the quality of the microarray experiment with respect to cross-hybridization issues.

Conclusion

CrossHybDetector is implemented as a package for the statistical computing environment R and is freely available under the LGPL license within the CRAN project.

Background

Expression microrrays are used in a wide range of applications to simultaneously monitor the relative abundance of thousands of target sequences. A basic requirement of array probes is that of having low reciprocal similarity in order to reduce the likelihood of cross-hybridization effects. On the other hand, the permissible sequence 'dissimilarity' between probes is constrained by the requirement that probes have to share similar temperatures of annealing. This guarantees that all target sequences correctly hybridize with their probes in the same experimental conditions. Thus, the optimal array probe design is a trade-off solution between probe Tm similarities and probe sequence 'dissimilarities'. As a consequence, the greater the number of probes spotted on the array, the greater the chance of cross-hybridization events occurring. In this case the signal intensity measured by a chip spot carrying a given probe is affected by the unspecific binding of an off-target sequence similar to the target sequence. This effect, if not detected, can result in a number of false positives signals on the array. Even in the case of optimal probe design, suboptimal experimental conditions may favor cross-hybridization over specific binding [1]. This issue can be particularly relevant for customized microarray designs. In fact, hybridization protocols of standard commercial platforms are optimized and rigorous quality controls are carried out before the microarray platform gets deployed [2, 3]. On the contrary, customized arrays are more prone to be affected by cross-hybridization or other issues related to the novel probe design. As a consequence, the set up of ad-hoc quality controls procedures is a crucial pre-requisite to improve data quality. CrossHybDetector identifies probes highly similar and checks for 'suspicious' spot intensity patterns based on the outcome of a single microarray experiment. A p-value expressing the likelihood of the pattern occurring by chance is calculated for each probe using Monte Carlo simulations. In addition, a global 'cross-hybridization quality control' parameter is provided in output and plots are generated which allow a visual overview of the cross-hybridization events in the microarray experiment. Here we present the CrossHybDetector software and, as a proof of concept, we illustrate two case studies in which the software and the underlying methodology have been successfully applied to detect cross-hybridization events.

Implementation

CrossHybDetector is implemented as a package within the statistical computing environment R [4]. Functions of marray and methods R packages are internally utilized and are required by CrossHybDetector to work.

Data formats

CrossHybDetector algorithm uses as input data i) the array probe sequences, ii) the spot intensities and array layout, iii) the spot type information (i.e. for each spot, whether it is "standard probe", "negative control", "spike-in"). This information is respectively contained into three separated text files. Exemplary analysis and related input files are submitted as supplemental materials (Additional files 1 and 2).

Algorithm

A cross-hybridization event takes place when a target sequence not only hybridizes to its related spot(s) on the chip, but also 'corrupts' chip spots carrying probes with similar sequences. The degree of the cross-hybridization effect is proportional to the sequence similarity between probes and to the relative abundance of the off-target sequence versus the target sequence. As a consequence, abundant target sequences can generate high signal intensities on their related chip spots as well as 'pushing ahead' the intensity values of spots carrying similar probes. The algorithm implemented in CrossHybDetector works as follows:

  1. 1.

    The probes with the highest intensities are selected as follows: probes with intensities higher than the saturation value (default = 65535) OR probes with intensity higher than a z-score threshold (default = 3). Among the two generated probe list, the largest one is selected. These probes are more prone to cause detectable cross-hybridization events on probes with similar sequences. In principle even low abundant targets could cross-hybridize to non specific probes on the chip, but this would have a minor impact on the final readout. For this reason these probes are not considered by default. However, the default threshold values can be modified by the user to extend the analysis to the probes with lower intensities.

  2. 2.

    Each of the selected probes is aligned against all the others. For each pairwise alignment the similarity between sequences is expressed as the Smith-Waterman (SW) score [5].

Among the available measures of pairwise sequence similarity (i.e. percent identity, longest common stretch) [6, 7], we decided to adopt the SW score. This metric can be rapidly computed and is reported to be highly correlated (r = 0.98, p-value p < 10-165) with the best univariate predictor of cross-hybridization ("most contiguous base pairs between probe and target sequences") [7].

In the presence of a particular composition of the probes spotted on the array, alternative methods to compute the pairwise sequence similarity can be easily plugged in.

  1. 3.

    All the probes similar in sequence to probe i are identified by selecting all the alignments with a ΔSW score below a user-defined threshold. ΔSW is computed as:

    ΔSWi,k = SWi,i - SWi,k

where SWi,i is the score of the alignment of probei vs. probei ('perfect' pairing) and SWi,k is the score of the aligment of probei vs probek ('imperfect' pairing).

  1. 4.

    Monte Carlo simulations: the sum of intensities for each subset of probes selected in 3 is compared against the distribution of the sums obtained from the random sampling of an equal number of probes on the array (10,000 samplings by default). A p-value is therefore calculated for each subset of probes as the fraction of the random samplings having a sum of intensities higher than the observed value, and corrected for multiple testing using the FDR procedure [8]. Probe subsets with p-value below a user-defined threshold (0.01 by default) are assessed as being composed of probes affected by unspecific binding. These probes are flagged as corrupted. The probe corresponding to the target sequence causing cross-hybridization is instead flagged as corruptor. A corruptor/corrupted probe pair is therefore composed by a corruptor probe with one of its corrupted probes.

The total number of corruptor/corrupted probe pairs reflects the amount of cross-hybridization in the microarray experiment.

Output

Different types of outputs are generated as results of the analysis (see also Additional file 1):

  1. 1)

    A plot showing for each analyzed probe the p-value resulting from the Monte Carlo simulation

  2. 2)

    A list of the probes identified as corruptors and their related p-values

  3. 3)

    A list of the probes identified as corrupted and their related p-values

  4. 4)

    A plot showing the spatial distribution of corruptors and corrupted probes on the array

  5. 5)

    A plot showing the ratio versus average intensity values (MA plot) with corruptors and corrupted probes highlighted in colors (Figure 1).

Figure 1
figure 1

Examples of cross-hybridization in two independent data sets. Magnitude versus amplitude (MA) plot of two arrays from the "Phage TAG array" (A) and the "Yeast TAG array" (B) data sets. The x-axis represents the average log2 intensity of the two channels, and the y-axis represents the log2 ratio of channel1/channel2. Probes identified as corruptors or corrupted in the first (R), the second (G) and both (RG) channels are highlighted with the respective labels. Horizontal lines indicate 2-fold change (log2 ratio = -/+1).

Performance

The analysis of a double channel Agilent 22K array (with the default parameters) takes about 8 min using a Pentium 4, 3 GHz, 1GB RAM

A step-by-step description on how to run an exemplary microarray analysis and the output figures is illustrated in supplemental materials (Additional file 1).

Results

To validate the software and the related methodology, we have used the CrossHybDetector software to analyze independent microarray data sets obtained from two different array layouts, here referred as "Phage TAG array" and "Yeast TAG array". In both cases the oligonucleotide probes spotted on the arrays were representing artificially designed "DNA barcodes". These types of arrays are largely used in a variety of applications to monitor the respective abundances of DNA synthetic sequences ("barcodes") present in different samples [9, 10].

The "Phage TAG array" dataset is composed of 76 previously reported microarray experiments carried out in our laboratory [11]. The array layout includes probes complementary to a repertoire of 20.736 synthetic DNA "barcode" sequences and was designed to analyze collection of phage clones tagged with short synthetic DNA sequences [11]. The "Yeast TAG array" dataset contains 135 microarray generated with in-house synthesized oligonucleotide arrays [12, 13]. The array layout includes probes complementary to a collection of 11.986 different DNA barcodes. In this case, it was designed to profile the relative abundances of yeast strains from the Yeast Knockout (YKO) strain collection [12, 13], tagged with short synthetic DNA sequences.

The results obtained by applying CrossHybDetector to each hybridization experiment of the two data sets (using a Monte Carlo p-value threshold equal to 0.01) are presented in Table 1. In both data sets corruptor and corrupted probes were identified. In the case of the "Phage TAG array" data set, after the adoption of more stringent conditions to the hybridization and washing protocols, the hybridization experiments affected by cross-hybridization problems decreased from 22 (out of an initial number of 152 hybridization experiments) to 5 (data not shown).

Table 1 Summary results of CrossHybDetector

The output plots in Figure 1 (panels A and B) show the results of the CrossHybDetector analysis in one experiment affected by cross-hybridization events in each of the two data sets. In panel A, it can be observed that many spots with high intensity values are identified as corruptors and affect a large part of the probes with a fold change greater than two, thus resulting as corrupted.

The complete set of output results can be generated by following the software guidelines provided as supplemental materials (Additional file 1).

To further validate the results, we separately run an additional analysis on the probes identified as corrupted in more than 10% of the experiments of each data set.

For each corrupted probe, the correlation with each of its respective corruptors in the different experiments was calculated across the entire data set.

The rationale for this analysis is that any statistically significant correlation observed between two probes of a corruptor/corrupted pair can only be ascribed to cross-hybridization effects as no functional relationship exist between the synthetic sequences monitored in the two experiment settings. Results are illustrated in Table 2. In both data sets we observed that the average Pearson's correlation for the whole set of corruptor/corrupted pairs was significantly higher than the average correlation obtained on an equal number of randomly selected probe pairs (10,000 Monte Carlo samplings, p-value < 0.0001). As an example, the correlation between the probes of two corruptor/corrupted pairs, respectively identified in each data set, is shown in Figure 2.

Figure 2
figure 2

Plots of the intensity of corruptor versus corrupted probes. Correlation between the probe intensity values of two corruptor/corrupted pairs, respectively identified in each data set. Each point represents a different array hybridization experiment. The Pearson's correlation and the corresponding p-values are indicated.

Table 2 Summary results of the probe pairs correlation analysis

These results represent independent confirmation that the probes identified as corrupted in individual experiments by the CrossHybDetector were affected by artifactual cross-hybridization effects.

Discussion and conclusion

Other methods have been reported that address the problem of cross-hybridization in DNA microarray. Flikka et al. [14] developed a web-tool for the assessment of the reliability of hybridization signals in different array designs by comparing probe sequences against human, mouse and rat transcript collections. Gene candidates for cross-hybridization are selected on the basis of sequence similarity calculated using the BLAST algorithm [15]. As opposed to CrossHybDetector, this tool was not conceived as a quality control tool for array hybridization experiments and it does not take into account the hybridization signals derived from specific experiments. A different approach was used by Casneuf and collaborators [16]. Here probe sets affected by off-target hybridization were identified on the basis of positive correlations between sequence similarity and expression across a series of microarray experiments. This approach is similar to the correlation analysis we carried out to validate the results of CrossHybDetector. The most important difference between the two methodologies lies in the fact that while Casneuf's approach uses an entire data series to identify potential cross-hybridizing probes, CrossHybDetector focuses on individual hybridization array experiments.

In this respect, CrossHybDetector is mainly a quality control software for single hybridization experiments, conceptually similar to other published tools aiming at the monitoring of different quality parameters such as the 'geographical' bias, the spot replicate concordance, the two-channel correlation [17, 18]. Other methods also exist, which are aimed at correcting the spot intensities with a model-based approach [6, 7] and therefore with a different purpose than experimental quality control.

CrossHybDetector uses both the probe intensity values and the probe sequences to identify potentially 'corrupted' spots. As a consequence, cross-hybridization events that do not cause an intensity increase of the spots carrying similar probe sequences cannot be detected. This has to be considered as an intrinsic limitation due to the 'in-silico' nature of the method and does not affect its general utility.

CrossHybDetector can be applied to all arrays where for each individual probe its intensity signal is provided. As a consequence, it can not be applied to Affymetrix chips where the intensity values are associated to multiple probes (PM and MM probe sets). We envisage CrossHybDetector to be extremely useful to quality control experiments performed on customized microarrays. In these particular settings, microarrays are more prone to present issues related to suboptimal probe design and/or experimental conditions.

Moreover, being developed as a standard R package, CrossHybDetector is well suited to integrating into more complex quality control platforms and automated analysis workflows.

Availability and requirements

Project name: CrossHybDetector

Project home page: http://cran.r-project.org/

Operating systems: The crosshybDetector package can be installed on all the platforms supporting R. These include a wide variety of UNIX platforms, Windows and MacOS.

Programming language: R

License: LGPL

References

  1. Dai H, Meyer M, Stepaniants S, Ziman M, Stoughton R: Use of hybridization kinetics for differentiating specific from non-specific binding to oligonucleotide microarrays. Nucleic Acids Res 2002, 30: e86. 10.1093/nar/gnf085

    Article  PubMed Central  PubMed  Google Scholar 

  2. Shi L, Reid LH, Jones WD, Shippy R, Warrington JA, Baker SC, Collins PJ, de Longueville F, Kawasaki ES, Lee KY, et al.: The MicroArray Quality Control (MAQC) project shows inter- and intraplatform reproducibility of gene expression measurements. Nat Biotechnol 2006, 24: 1151–1161. 10.1038/nbt1239

    Article  CAS  PubMed  Google Scholar 

  3. Wilkes T, Laux H, Foy CA: Microarray data quality – review of current developments. Omics 2007, 11: 1–13. 10.1089/omi.2006.0001

    Article  CAS  PubMed  Google Scholar 

  4. The R Project for Statistical Computing[http://www.r-project.org]

  5. Smith TF, Waterman MS: Identification of common molecular subsequences. J Mol Biol 1981, 147: 195–197. 10.1016/0022-2836(81)90087-5

    Article  CAS  PubMed  Google Scholar 

  6. Huang JC, Morris QD, Hughes TR, Frey BJ: GenXHC: a probabilistic generative model for cross-hybridization compensation in high-density genome-wide microarray data. Bioinformatics 2005, 21(Suppl 1):i222–231. 10.1093/bioinformatics/bti1045

    Article  CAS  PubMed  Google Scholar 

  7. Chen YA, Chou CC, Lu X, Slate EH, Peck K, Xu W, Voit EO, Almeida JS: A multivariate prediction model for microarray cross-hybridization. BMC Bioinformatics 2006, 7: 101. 10.1186/1471-2105-7-101

    Article  PubMed Central  CAS  PubMed  Google Scholar 

  8. Benjamini Y, Hochberg Y: Controlling the false discovery rate: a practical and powerful approach to multiple testing. J Royal Stat Soc B 1995, 57: 289–300.

    Google Scholar 

  9. Mazurkiewicz P, Tang CM, Boone C, Holden DW: Signature-tagged mutagenesis: barcoding mutants for genome-wide screens. Nat Rev Genet 2006, 7: 929–939. 10.1038/nrg1984

    Article  CAS  PubMed  Google Scholar 

  10. Pierce SE, Fung EL, Jaramillo DF, Chu AM, Davis RW, Nislow C, Giaever G: A unique and universal molecular barcode array. Nat Methods 2006, 3: 601–603. 10.1038/nmeth905

    Article  CAS  PubMed  Google Scholar 

  11. Monaci P, Luzzago A, Santini C, De Pra A, Arcuri M, Magistri F, Bellini A, Ansuini H, Ambrosio M, Ammendola V, et al.: Differential screening of phage-ab libraries by oligonucleotide microarray technology. PLoS ONE 2008, 3: e1508. 10.1371/journal.pone.0001508

    Article  PubMed Central  PubMed  Google Scholar 

  12. Yuan DS, Pan X, Ooi SL, Peyser BD, Spencer FA, Irizarry RA, Boeke JD: Improved microarray methods for profiling the Yeast Knockout strain collection. Nucleic Acids Res 2005, 33: e103. 10.1093/nar/gni105

    Article  PubMed Central  PubMed  Google Scholar 

  13. Shoemaker DD, Lashkari DA, Morris D, Mittmann M, Davis RW: Quantitative phenotypic analysis of yeast deletion mutants using a highly parallel molecular bar-coding strategy. Nat Genet 1996, 14: 450–456. 10.1038/ng1296-450

    Article  CAS  PubMed  Google Scholar 

  14. Flikka K, Yadetie F, Laegreid A, Jonassen I: XHM: a system for detection of potential cross hybridizations in DNA microarrays. BMC Bioinformatics 2004, 5: 117. 10.1186/1471-2105-5-117

    Article  PubMed Central  PubMed  Google Scholar 

  15. Altschul SF, Gish W, Miller W, Myers EW, Lipman DJ: Basic local alignment search tool. J Mol Biol 1990, 215: 403–410.

    Article  CAS  PubMed  Google Scholar 

  16. Casneuf T, Peer Y, Huber W: In situ analysis of cross-hybridisation on microarrays and the inference of expression correlation. BMC Bioinformatics 2007, 8: 461. 10.1186/1471-2105-8-461

    Article  PubMed Central  PubMed  Google Scholar 

  17. Buness A, Huber W, Steiner K, Sultmann H, Poustka A: arrayMagic: two-colour cDNA microarray quality control and preprocessing. Bioinformatics 2005, 21: 554–556. 10.1093/bioinformatics/bti052

    Article  CAS  PubMed  Google Scholar 

  18. Reimers M, Weinstein JN: Quality assessment of microarrays: visualization of spatial artifacts and quantitation of regional biases. BMC Bioinformatics 2005, 6: 166. 10.1186/1471-2105-6-166

    Article  PubMed Central  PubMed  Google Scholar 

Download references

Acknowledgements

We wish to thank Paolo Monaci and Armin Lahm for useful discussions and Janet Clench for the linguistic revision of the text. We also would like to thank the insightful suggestions from anonymous reviewers. This work was supported in part by a grant from Ministero dell'Istruzione, dell'Università e della Ricerca.

Author information

Authors and Affiliations

Authors

Corresponding authors

Correspondence to Paolo Uva or Emanuele de Rinaldis.

Additional information

Authors' contributions

PU conceived and implemented the method, wrote the code and drafted the manuscript. EDR contributed to the conceptualization of the method and wrote the final version of the manuscript. Both authors read and approved the final manuscript.

Electronic supplementary material

12859_2008_2470_MOESM1_ESM.doc

Additional file 1: Application of CrossHybDetector to a microarray experiment. PDF file containing step-by-step instructions on how to run a complete analysis using the CrossHybDetector package. The document also includes all the plots produced by the package. Input files used in this example are available in Additional file 2. (DOC 139 KB)

12859_2008_2470_MOESM2_ESM.zip

Additional file 2: Input files used for CrossHybDetector exemplary analysis. This ZIP archive include three files containing i) the array probe sequences, ii) the array spot intensities and array layout, iii) the spot type information (i.e. for each spot, whether it is "probe", "negative control", "spike-in"). (ZIP 2 MB)

Authors’ original submitted files for images

Below are the links to the authors’ original submitted files for images.

Authors’ original file for figure 1

Authors’ original file for figure 2

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

Uva, P., de Rinaldis, E. CrossHybDetector: detection of cross-hybridization events in DNA microarray experiments. BMC Bioinformatics 9, 485 (2008). https://doi.org/10.1186/1471-2105-9-485

Download citation

  • Received:

  • Accepted:

  • Published:

  • DOI: https://doi.org/10.1186/1471-2105-9-485

Keywords