Skip to main content

'maskBAD' - a package to detect and remove Affymetrix probes with binding affinity differences

Abstract

Background

Hybridization differences caused by target sequence differences can be a confounding factor in analyzing gene expression on microarrays, lead to false positives and reduce power to detect real expression differences. We prepared an R Bioconductor compatible package to detect, characterize and remove such probes in Affymetrix 3’IVT and exon-based arrays on the basis of correlation of signal intensities from probes within probe sets.

Results

Using completely mouse genomes we determined type 1 (false negatives) and type 2 (false positives) errors with high accuracy and we show that our method routinely outperforms previous methods. When detecting 76.2% of known SNP/indels in mouse expression data, we obtain at most 5.5% false positives. At the same level of false positives, best previous method detected 72.6%. We also show that probes with differing binding affinity both hinder differential expression detection and introduce artifacts in cancer-healthy tissue comparison.

Conclusions

Detection and removal of such probes should be a routine step in Affymetrix data preprocessing. We prepared a user friendly R package, compatible with Bioconductor, that allows the filtering and improving of data from Affymetrix microarrays experiments.

Background

In microarray gene expression analysis, there is an assumption that a probe has the same set of targets in compared groups and therefore differences in probe signal intensity are caused by different levels of gene expression. This assumption does not hold when experimental groups with different genetic makeup are compared, as the target region of a specific probe may contain SNPs and other sequence differences. Experimental groups may also differ in their set of expressed isoforms or cross-hybridizing targets. The latter issue may arise even between genetically identical samples, such as when comparing different tissues, or samples differing in applied treatment. The binding affinity for such probes will differ between exprimental groups and the difference in signal intensity will be confounded with transcript abundance. We termed probes with such b inding a ffinity d ifferences BAD probes.

BAD probes lead to errors in estimates of differential gene expression[1], disruption of eQTL mapping[2, 3] and errors in resolving cis and trans effects[4]. We ourselves have shown that BAD probes both introduce spurious gene expression differences and, by disrupting normalization, reduce the power to detect true ones[5]. On the other hand, BAD probes might be useful as genetic markers distinguishing species or strains (called also single feature polymorphisms, SFPs)[6, 7].

The number of affected probes depends on the genetic distance between experimental groups. Even with 1% nucleotide differences, as observed between human and chimpanzee or Mus musculus and Mus spretus, SFPs due to SNPs alone will appear in ~22% of 25-nucleotide probes.

To overcome this problem, several approaches were employed, including: removal of probes overlapping known polymorphisms[810], adding group as a factor in probe-level analysis[1, 11] and methods based on correlating expression values within a probe set[6, 7, 12, 13]. The advantage of the last approach is that information concerning sequences or actual targets (isoform and cross hybridizing targets) need not be known. It also alows one to discover SFPs.

Previously, we proposed a method to detect BAD probes on Affymetrix gene expression microarrays based on the expression values themselves, as we described in[5]. Briefly, the signal for a given probe is proportional to the amount of RNA in the sample and its binding affinity. When one target is measured with several probes (a probe set), as on Affymetrix arrays, the probe signals are correlated for each sample. BAD probes correlation differs between groups, hence comparison of pairwise correlations between those groups allows to identify of BAD probes, as summarized on Figure1.

Figure 1
figure 1

Principle of the masking method. Each dot represents a sample— human or chimpanzee. On the axes are fluorescence intensities for the probes from the same probe set. Our method performs a t-test of the slopes to each point (green and blue lines), assuming that the intercept is taken from all points (black line). On the left ( a) there is no binding afinity difference between humans and chimpanzees in either probe. On the right ( b) one of the probes is BAD.

We present an R package implementing this method for the detection and removal of BAD probes from the Affymetrix gene expression data. Functions in this package improve upon the version that we made available with the original paper[5], are compatible with current R Bioconductor framework, and work for both Affymetrix 3’IVT and exon-based arrays. The package with a vignette and example data was submitted to Bioconductor. We re-validated the method with recently available full genome data for mouse strains and compared its performance with competing software. We also employed masking on a human tumour-healthy tissue data set, to test for presence of BAD probes between tissue types and their influence on differential gene expression detection. In such comparisons, the difference in targets between experimental groups and impact of BAD probes has been overlooked to date.

Implementation

BAD probes detection

We implemented the method described in[5]. Briefly, a signal for the probe j on the array i might be expressed as a sum of baseline response due to nonspecific hybridization (ν j ), abundance of target RNA (Φ i ) multiplied by binding strength of probe j (θ j ) and an error term.

If probes O i1 and O i2 hybridize to the same transcript, the relationship between their fluorescence levels might be expressed as

O i 2 = v 2 θ 2 v 1 θ 2 θ 1 + θ 2 θ 1 O i 1 +

When samples differ between groups in binding affinities and/or background intensity, this linear relationship still holds within each group, but their slopes differ between groups.

We test the null hypothesis that in both groups the binding strength, as well as the background binding level, are the same,

  1. 1.

    We estimate the intercept for combined groups

    β = v 2 θ 1 v 1 θ 2 θ 1
  2. 2.

    We test with t-test if distribution of (O i2  − β)/O i1 is the same for both groups and record its P-value.

    O i 2 β O i 1 = θ 2 θ 1 +
  3. 3.

    The same test (1-2) is performed for all probe pairs, in both directions. We thus build a J ×  J matrix of all pairwise tests, less the diagonal.

  4. 4.

    For each probe in a probe set we calculate the geometric mean of all P-values in the matrix where this probe is involved. We record the probe with the smallest geometric mean of P-values (mP-value) and exclude this probe’s comparisons from the matrix.

  5. 5.

    The previous step is repeated, until the matrix contains only two probes – they are both assigned geometric mean of their pvalues.

Then a cutoff is chosen and all probes with an mP-value below this cutoff are designated as BAD.

Description of the package

The package allows detection of BAD probes in Affymetrix microarrays designed with several probes measuring a target, 3’ IVT gene expression arrays and whole–transcript expression arrays (exon and gene arrays). Standard Bioconductor gene expression data structures are supported, thus the package may be easily be used with other Bioconductor tools.

As input for detection of BAD probes the package requires raw expression data in the form of an AffyBatch object and a group assignment of all samples. Detection of BAD probes in expression data works only for probe sets targeting transcripts that are expressed – others, picking background and crosshybridization signal are meaningless. Therefore by default, probe sets are evaluated with mas5calls() function from the package affy and only probe sets which are expressed (“P” call) in at least 90% of samples in each group are retained for BAD probes detection. However, the user may choose to analyze a custom set of probe sets or use average probes values to define probe sets to analyze. The masking achieves sufficient power with at least five samples in each group to compare (groups may differ in size). The resulting list contains a mask - a data frame with quality scores for all analyzed probes.

A low quality score means that a probe is likely to be BAD and probes with quality value below a certain cutoff may be removed from expressionSet and downstream analysis. Ranking of probes by quality scores depends on the data set (sample size and number of probes within probe sets) and hence a threshold for excluding probes from downstream analysis is data set specific. The package contains several functions to assist with choice of cutoff score. A stringent (high) cutoff might be used to compare gene expression between groups, whereas a relaxed (low) cutoff may be used to identify candidate SFPs, because then a low rate of false positives is important.

When BAD status is known for a subset of probes, a cutoff might be chosen to match desired sensitivity and specificity level, on the basis of this subset analysis. Function overlapExpExtMasks() computes type 1 and type 2 errors and its confidence intervals for different cutoffs and then plots them. Also, the distributions of quality scores for probes defined as BAD and non-BAD might be compared using a Kolmogorov-Smirnov or Wilcoxon test, to estimate if cutoff is too stringent and prevents discrimnation of BAD and non-BAD probes.

In the absence of a reference subset of probes, distribution of quality scores might suggest an appropriate cutoff level.

It is advisable to inspect some probes that have borderline quality score. The function plotProbe() allows comparison of a probe’s intensities against all other probes from the same probe set.

Probes may be removed from the original AffyBatch object with prepareMaskedAffybatch(). It returns a new affyBatch object and an appropriate CDF environment, which are both devoid of BAD probes. At this step the user may decide what is a minimal number of probes left to still keep a probe set in the analysis. For prepareMaskedAffybatch() BAD probes may be identified by a mask object and a cutoff value or as a list of probes to remove.

After removal of BAD probes, expression estimates might be obtained in any way preferred by the user, as for every probe set the remaining probes are treated as a redefined probe set. Masking might be coupled also with probe set redefinition by a custom cdf.

The package is compatible with 3’ IVT arrays and gene/exon arrays. The resulting affyBatch object may be used downstream as a usual affyBatch object.

Performance

We took the opportunity to use the recent sequencing of 20 inbred mouse strains as a comprehensive source of information about SNPs and indels. We detected BAD probes in a public dataset of striatum expression from C57BL/6NJ and DBA/2 J strains [[14], GEO Series GSE26024], measured on the MOE430 2.0 array based on C57BL sequences. We estimated false positives (probes detected as BAD with no polymorphism) and false negatives (undetected BAD probes) of expression-based mask by comparison with polymorphisms in probe target regions in a similar way as in[5].We did the same with SNEP[15], which is a method to detect BAD probes shown to be superior to several other approaches and not compared with ours before.

We also tested for the presence of BAD probes and masking effects in a public dataset comprising 17 healthy tissue and 20 tumour samples from human lung ([16], data fromhttp://www.broadinstitute.org/mpr/lung/), measured on U95 arrays. The mask was produced with default features and a cutoff of 0.001 (1373 probes masked – 4.5%), determined from the distribution of probes’ quality scores. Probe sets were defined as being differentially expressed if, after gcrma normalization, their Benjamin-Hochberg corrected t-test p-values were smaller than 0.01.

Results and Discussion

The package maskBAD is designed to detect and remove BAD probes and the resulting bias in expression estimates. Previously we demonstrated the high accuracy and detection rate of the method in detecting artificially introduced BAD probes[5]. We detected 90% of probes with an artificially introduced difference and masked only 1.8% of probes without a difference. We estimated also false positive and false negative rates in actual data from two mouse strains and a human-chimpanzee comparison. However, this approach suffered from incomplete mouse polymorphism data at the time, and unknown polymorphisms between human and chimpanzee individuals used in the expression studies. However, with the full genome information for inbred mouse strains it was possible to estimate it with greater accuracy [Figure2. According to the sequence data, within the 22748 expressed probe sets, 2.4% of probes were affected by either a SNP or an indel. At cutoff 0.032 we detect 76.2% of known SNPs/indels, at the same time masking only 5.5% of probes without any known polymorphism. Still, some of the probes without known polymorphisms might differ in binding affinity because of other differences between experimental groups, for example in additional file1 we show a probe (quality score = 2.46e − 10) without a known polymorphism between mouse strains and with obvious BAD behavior.

Figure 2
figure 2

Detection of known polymorphisms by maskBAD. Performance maskBAD compared with SNEP algorithm for the mouse dataset. X-axis: fraction of probes masked, but without known polymorphism. Y-axis: detected fraction of known SNPs/indels. Masks were build using 4 or 10 individuals from each group.

We compared the performance of our method with SNEP[15] using the same dataset. For group sizes 4 and 10 our method is equally good for low cutoffs and superior for high cutoffs [Figure2. When detecting 75.6% of real SNPs/indels, it detects as BAD 8.5% probes without SNP/indel and with type 2 error 5.5% it detects 72.8% of known SNPs/indels.

We find also that BAD probes are present in the cancer-healthy tissue comparison and influence DE detection. We analyzed 1913 (15%) probe sets which were expressed in both groups and identified 1373 (4.5%) BAD probes at cutoff 0.001 between carcinoid lung tumors and healthy lung tissue. Such differences between two human tissues mean qualitative differences in targets, such as cross-hybridizing targets or isoforms between tumour and normal tissue. We enquired how masking influences differential expression detection. There were 656 probe sets detected as differentially expressed (DE) both before and after masking, while 94 probe sets were only DE before masking and 38 were only DE after masking.

A single BAD probe can cause an extreme difference in calling differential expression. For example, a probe set (38657_s_at), targeting clathrin, before masking showed no difference in expression (p = 0.41). By removing probe 3 (detected as BAD: quality score = 2.5e-5, additional file2), the P-value becomes highly significant (p = 0.009). The probe response shows the opposite direction of intensity change for this probe than the others, leading to a biased expression estimate.

On the other hand, in probe set 37766_s_at differential expression detected without masking (p = 0.01) is an artifact of only one BAD probe (x = 420 y = 307, quality score = 5.5e-6) in this probe set ( Additional file3) and disappears after masking (p = 0.08). This detected difference might be still of interest, as it might indicate differential isoform expression or RNA editing between two tissues, or identical somatic mutations in tumour samples, but it is not a “simple” difference in expression levels.

If removal of BAD probes reveals a real biological signal, and does not not just introduce a random change in expression estimates due to a reduction in the number of probes in probe set, than when discarding BAD probes one should see much a bigger difference in DE estimates compared to removing probes randomly. To test this, we ran a simulation 1000 times where we removed the same number of probes, with the same distribution of probes per probe set, as the set of probes we removed as BAD. The number of probe sets detected as DE was much smaller (Figure3).

Figure 3
figure 3

Probe sets changing DE status after removal of BAD or random probes. Number of probe sets changing DE status after removal of 1373 probes, randomly chosen (sampled 1000 times) or identified as BAD probes. ( a) All probe sets ( b) probe sets detected as DE only after masking, ( c) probe sets loosing DE status after masking.

As we have shown previously[5], excluding BAD probes both removes artifacts and reveals a real biological signal. Previously, it was used in comparisons between genetically different strains or species[12, 1721]. Systematic differences in probes’ targets might also be present between different tissues (as in the previous cancer-healthy tissue comparison) or samples subjected to different treatments. Whereas regions of known differences might be accommodated in array design (by careful design and annotation of separate probe sets targeting known isoforms and exon-level analysis), other differences that are not recognized might lead to errors in detecting DE. To date, their identification and removal is usually not a part of a 3’IVT arrays data analysis pipeline. As they differ in binding affinity between compared groups, but are still in relation to other probes within a probe set, downweighting of outlier probes, as performed in summarization step of preprocessing methods (RMA, GCRMA, affyILM, plier etc.) does not reduce their interference.

BAD probes violate the assumption made in methods for estimating gene expression from microarrays, that there is a common binding affinity for a given probe for all samples. Therefore, for DE gene discovery, they should be removed from analysis.

As BAD probes are a result of systematic differences between compared groups, they might identify candidate loci for further investigation, for example differing in splicing isoforms between compared groups. When using expression data to classify samples, they might be another factor discriminating samples. However, as they obscure real expression levels, by potentially canceling out expression differences with reciprocal signal or by disrupting the normalization process, they should be removed before estimating expression level differences.

Therefore BAD probe detection should be a part of standard differential gene expression analysis. When a goal is to find both quantitative and qualitative differences in expression between samples, the analysis might be done twice, with and without BAD probes. Comparison of results for the same dataset before and after masking, along with the localization of BAD probes, would help to interpret which probe sets apparently detecting DE differ in expression levels and which have rather qualitative target differences.

A set of probes identified as BAD for a specific experiment might be removed from analysis of other similar datasets. However, each tissue, developmental stage etc. might differ qualitatively in transcriptome and therefore have a different set of BAD probes, so identification of ones specific for the experiment is better.

Conclusions

We introduce “maskBAD”, the R package to detect and remove probes with different binding affinity in Affymetrix array expression data. The method implemented in maskBAD performs better than other methods in detecting BAD probes. Identification and removal of BAD probes removes spurious gene expression differences and helps to reveal real ones. In clustering analysis of gene expression, identification of BAD probes guides interpretation of discriminating probe sets.

The BAD probes are prevalent in comparisons of genetically distinct samples, such as different strains of a species or between species, but systematic qualitative differences in transcriptome might introduce them also when samples differ by treatment, health status or tissue type. All commonly used preprocessing procedures assume constant binding affinity for a probe in all samples and their downweighting of outlier probes does not protect from BAD probes. Therefore masking should be a routine step in data preprocessing. The “maskBAD” package allows identifying, inspection and removing BAD probes in R and Bioconductor environment and make it a part of standard gene expression analysis pipeline.

Availability and requirements

Project name: Masking BAD microarray probes.

Project home page:http://bioinf.eva.mpg.de/masking/test/pmwiki.php/Site/MaskingMicroarraysProbesWithBindingAffinityDifferences and Bioconductor (http://bioconductor.org/packages/2.10/bioc/html/maskBAD.html)

Operating systems: Linux, OS X, Windows

Programming language: R (currently requires R-devel version)

Other requirements: packages affy, gcrma

License: GNU GPL

Links

Package is available at

http://bioconductor.org/packages/2.10/bioc/html/maskBAD.html

http://bioinf.eva.mpg.de/masking/test/pmwiki.php/Site/MaskingMicroarraysProbesWithBindingAffinityDifferences

Abbreviations

BAD:

binding affinity different

DE:

differential expression

SFP:

single feature polymorphism

SNP:

single nucleotide polymorphism.

References

  1. Hsieh WP, Chu TM, Wolfinger RD, Gibson G: Mixed-model reanalysis of primate data suggests tissue and species biases in oligonucleotide-based gene expression profiles. Genetics 2003, 165(2):747–757.

    PubMed Central  CAS  PubMed  Google Scholar 

  2. Alberts R, Terpstra P, Li Y, Breitling R, Nap J-P, Jansen RC: Sequence Polymorphisms Cause Many False cis eQTLs. PLoS One 2007, 2(7):e622. 10.1371/journal.pone.0000622

    Article  PubMed Central  PubMed  Google Scholar 

  3. Chen L, Page GP, Mehta T, Feng R, Cui X: Single nucleotide polymorphisms affect both cis- and trans-eQTLs. Genomics 2009, 93(6):501–508. 10.1016/j.ygeno.2009.01.011

    Article  PubMed Central  CAS  PubMed  Google Scholar 

  4. Ciobanu DC, Lu L, Mozhui K, Wang X, Jagalur M, Morris JA, Taylor WL, Dietz K, Simon P, Williams RW: Detection, validation, and downstream analysis of allelic variation in gene expression. Genetics 2010, 184(1):119–128. 10.1534/genetics.109.107474

    Article  PubMed Central  CAS  PubMed  Google Scholar 

  5. Dannemann M, Lorenc A, Hellmann I, Khaitovich P, Lachmann M: The effects of probe binding affinity differences on gene expression measurements and how to deal with them. Bioinformatics 2009, 25(21):2772–2779. 10.1093/bioinformatics/btp492

    Article  CAS  PubMed  Google Scholar 

  6. Cui X, Xu J, Asghar R, Condamine P, Svensson JT, Wanamaker S, Stein N, Roose M, Close TJ: Detecting single-feature polymorphisms using oligonucleotide arrays and robustified projection pursuit. Bioinformatics 2005, 21(20):3852–3858. 10.1093/bioinformatics/bti640

    Article  CAS  PubMed  Google Scholar 

  7. Ronald J, Akey JM, Whittle J, Smith EN, Yvert G, Kruglyak L: Simultaneous genotyping, gene-expression measurement, and detection of allele-specific expression with oligonucleotide arrays. Genome Res 2005, 15(2):284–291. 10.1101/gr.2850605

    Article  PubMed Central  CAS  PubMed  Google Scholar 

  8. Kumari S, Verma LK, Weller JW: AffyMAPSDetector: a software tool to characterize Affymetrix GeneChip expression arrays with respect to SNPs. BMC Bioinforma 2007, 8: 276. 10.1186/1471-2105-8-276

    Article  Google Scholar 

  9. Duan S, Zhang W, Bleibel WK, Cox NJ, Dolan ME: SNPinProbe_1.0: a database for filtering out probes in the Affymetrix GeneChip human exon 1.0 ST array potentially affected by SNPs. Bioinformation 2008, 2(10):469–470. 10.6026/97320630002469

    Article  PubMed Central  PubMed  Google Scholar 

  10. Toleno DM, Renaud G, Wolfsberg TG, Islam M, Wildman DE, Siegmund KD, Hacia JG: Development and evaluation of new mask protocols for gene expression profiling in humans and chimpanzees. BMC Bioinforma 2009, 10: 77. 10.1186/1471-2105-10-77

    Article  Google Scholar 

  11. Alberts R, Terpstra P, Bystrykh LV, De Haan G, Jansen RC: A statistical multiprobe model for analyzing cis and trans genes in genetical genomics experiments with short-oligonucleotide arrays. Genetics 2005, 171(3):1437–1439. 10.1534/genetics.105.045930

    Article  PubMed Central  CAS  PubMed  Google Scholar 

  12. Khaitovich P, Muetzel B, She X, Lachmann M, Hellmann I, Dietzsch J, Steigele S, Do HH, Weiss G, Enard W, et al.: Regional patterns of gene expression in human and chimpanzee brains. Genome Res 2004, 14(8):1462–1473. 10.1101/gr.2538704

    Article  PubMed Central  CAS  PubMed  Google Scholar 

  13. Wang M, Hu X, Li G, Leach LJ, Potokina E, Druka A, Waugh R, Kearsey MJ, Luo Z: Robust detection and genotyping of single feature polymorphisms from gene expression data. PLoS Comput Biol 2009, 5(3):e1000317. 10.1371/journal.pcbi.1000317

    Article  PubMed Central  PubMed  Google Scholar 

  14. Bottomly D, Walter NA, Hunter JE, Darakjian P, Kawane S, Buck KJ, Searles RP, Mooney M, McWeeney SK, Hitzemann R: Evaluating gene expression in C57BL/6J and DBA/2J mouse striatum using RNA-Seq and microarrays. PLoS One 6(3):e17820.

  15. Fujisawa H, Horiuchi Y, Harushima Y, Takada T, Eguchi S, Mochizuki T, Sakaguchi T, Shiroishi T, Kurata N: SNEP: Simultaneous detection of nucleotide and expression polymorphisms using Affymetrix GeneChip. BMC Bioinforma 2009, 10: 131. 10.1186/1471-2105-10-131

    Article  Google Scholar 

  16. Bhattacharjee A, Richards WG, Staunton J, Li C, Monti S, Vasa P, Ladd C, Beheshti J, Bueno R, Gillette M, et al.: Classification of human lung carcinomas by mRNA expression profiling reveals distinct adenocarcinoma subclasses. Proc Natl Acad Sci U S A 2001, 98(24):13790–13795. 10.1073/pnas.191502998

    Article  PubMed Central  CAS  PubMed  Google Scholar 

  17. Kumar R, Qiu J, Joshi T, Valliyodan B, Xu D, Nguyen HT: Single feature polymorphism discovery in rice. PLoS One 2007, 2(3):e284. 10.1371/journal.pone.0000284

    Article  PubMed Central  PubMed  Google Scholar 

  18. Walia H, Wilson C, Condamine P, Ismail AM, Xu J, Cui X, Close TJ: Array-based genotyping and expression analysis of barley cv. Maythorpe and Golden Promise. BMC Genomics 2007, 8: 87. 10.1186/1471-2164-8-87

    Article  PubMed Central  PubMed  Google Scholar 

  19. Bischoff SR, Tsai S, Hardison NE, York AM, Freking BA, Nonneman D, Rohrer G, Piedrahita JA: Identification of SNPs and INDELS in swine transcribed sequences using short oligonucleotide microarrays. BMC Genomics 2008, 9: 252. 10.1186/1471-2164-9-252

    Article  PubMed Central  PubMed  Google Scholar 

  20. Das S, Bhat PR, Sudhakar C, Ehlers JD, Wanamaker S, Roberts PA, Cui X, Close TJ: Detection and validation of single feature polymorphisms in cowpea (Vigna unguiculata L. Walp) using a soybean genome array. BMC Genomics 2008, 9: 107. 10.1186/1471-2164-9-107

    Article  PubMed Central  PubMed  Google Scholar 

  21. Bernardo AN, Bradbury PJ, Ma H, Hu S, Bowden RL, Buckler ES, Bai G: Discovery and mapping of single feature polymorphisms in wheat using Affymetrix arrays. BMC Genomics 2009, 10: 251. 10.1186/1471-2164-10-251

    Article  PubMed Central  PubMed  Google Scholar 

Download references

Acknowledgements

We would like to thank three anonymous reviewers for their help in making this manuscript more transparent. We are grateful to Jarek Bryk, Bernhard Haubold and Jai Denton for comments on the manuscript. AL, MD, ML are funded by Max Planck Society.

Author information

Authors and Affiliations

Authors

Corresponding author

Correspondence to Anna Lorenc.

Additional information

Competing interests

The authors declare that they have no competing interests.

Authors' contribution

AL, MD and ML conceived the package. MD developed the package. MD and AL tested the package. AL wrote the manuscript, all authors have contributed to it and have read and accepted the final version.

Michael Dannemann and Anna Lorenc contributed equally to this work.

Electronic supplementary material

12859_2011_5358_MOESM1_ESM.pdf

Additional file 1:A BAD probe without known polymorphisms in the targets. Examples of fluorescence intensities for probes from the probe set 1415723_at, without any polymorphisms in target region according to sequence data, for mice from C57BL/6NJ (green) and DBA/ 2 J (blue) strains. A. BAD probe (quality score 2.46e - 10) B. Probe without BAD (quality score 0.876). (PDF 452 KB)

12859_2011_5358_MOESM2_ESM.pdf

Additional file 2:BAD probe introduces spurious DE. Fluorescence levels of the probe set 37766_s_at for normal lung and tumor lung tissue. Each dot represents a sample. This probe set is detected as DE (alpha = 0.01) with raw data, but is not significant after masking. Intensities and its correlations with some other probes of the probe set are shown for the probe 15, identified as BAD (left) and probe 13, non-BAD (right). In the middle fluorescence levels for consecutive probes. (PDF 453 KB)

12859_2011_5358_MOESM3_ESM.pdf

Additional file 3:BAD probe prevents detection of DE. Fluorescence levels of the probe set 38657_s_at for normal lung and tumor lung tissue. Each dot represents a sample. This probe set is detected as DE (alpha = 0.01) only after masking. Intensities and its correlations with some other probes of the probe set are shown for the probe 3, identified as BAD (left) and probe 4, non-BAD (right). In the middle fluorescence levels for consecutive probes. (PDF 434 KB)

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

Authors’ original file for figure 3

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

Dannemann, M., Lachmann, M. & Lorenc, A. 'maskBAD' - a package to detect and remove Affymetrix probes with binding affinity differences. BMC Bioinformatics 13, 56 (2012). https://doi.org/10.1186/1471-2105-13-56

Download citation

  • Received:

  • Accepted:

  • Published:

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

Keywords