Abstract
The Nanostring nCounter gene expression assay uses molecular barcodes and single molecule imaging to detect and count hundreds of unique transcripts in a single reaction. These counts need to be normalized to adjust for the amount of sample, variations in assay efficiency and other factors. Most users adopt the normalization approach described in the nSolver analysis software, which involves background correction based on the observed values of negative control probes, a within-sample normalization using the observed values of positive control probes and normalization across samples using reference (housekeeping) genes. Here we present a new normalization method, Removing Unwanted Variation-III (RUV-III), which makes vital use of technical replicates and suitable control genes. We also propose an approach using pseudo-replicates when technical replicates are not available. The effectiveness of RUV-III is illustrated on four different datasets. We also offer suggestions on the design and analysis of studies involving this technology.
INTRODUCTION
The Nanostring nCounter gene expression platform has become widely used for research and clinical applications due to its ability to directly measure a broad range of mRNA expression levels without cDNA synthesis and amplification steps (1–4). However, the ‘accuracy and reliability of gene expression results are dependent upon the proper normalization of the data against internal reference genes’ (5). Most current normalization methods use spiked-in negative and positive controls and reference (housekeeping) genes, each of which has a good record of effectiveness in related technologies. At present the Nanostring analysis software nSolver and the R package NanoStringNorm (6) provide 84 options for normalizing Nanostring gene expression data: 4 ways of using the negative control data × 3 ways of using the positive control data × 7 ways of using the data on their reference genes.
There will always be random errors and possibly also systematic errors in any measurement process. Systematic errors are also called bias, and arise when the measurement process tends to measure something other than what was intended, e.g. (7). In many measurement problems, there is a bias-variance trade-off. A correction may well remove bias, but it will also increase the variance of the random errors in the data. An averaging may well reduce the variance of the random errors in the data, but it will also add bias. Most normalizations try to reduce both bias and variance, and will achieve these goals to a greater or lesser extent, arriving at some point in the trade-off. However, the question should not be ‘Is one normalization generally good, better or worse than another?’ Rather, we should ask ‘Are our scientific goals for this dataset (clustering, classification, measuring differential expression, etc.) better achieved using this normalization rather than another?’ In abstract terms, we should ask ‘Do we come out ahead in the trade-off this time, and can we do better?’ Similar considerations apply to the details of any normalization. There is always background, but does subtracting background help in this case? There are no perfect housekeeping (HK) genes, but does using a particular set of genes as HK genes help in this case?
This does not mean that we cannot find generally good normalization methods, but that we should focus more on assessing the effectiveness of any normalization with each dataset and goal. How do we do this? In this paper not only do we present our novel normalization for nCounter gene expression data, but in discussing its possible value, we also illustrate a number of methods we know for assessing normalizations. They range from statistical summaries such as principal component analysis (PCA) plots (8), relative log expression (RLE) plots (9) and technical replicate agreement (TRA) plots for comparing technical replicates, through to recapitulating known biology.
The normalization method presented here, RUV-III, is a novel extension of previously reported methods, which exploit positive and negative control genes and technical replicates (10,11). Here our usage of ‘negative’ and ‘positive’ clashes with that of nSolver. We define a negative control gene as one that is not expected to be affected by the biology of interest in a study, not one that is not expected to be expressed. Similarly, a gene is a positive control gene if its biological response is known, e.g. that it should be differentially expressed, not just that it should be expressed. Although we can and will make use of the spiked-in controls in the nCounter expression assay (which we will call NEG and POS in line with nSolver usage), for us negative and positive control genes should be endogenous, that is, part of the gene expression panel being measured. At times we will regard all genes as ‘negative controls’ and get helpful results, so it is important to reiterate a point made in the preceding paragraph: for us the question will not be ‘Can all genes be suitable negative controls?’ but ‘Does using all genes as negative controls help?’ We will see examples where doing so does help, and others where it does not. Selecting suitable negative controls is the major challenge in using RUV-III.
MATERIALS AND METHODS
Average plots
These are obtained by taking the average log count of all eight NEG transcripts, of all six POS transcripts and of all of the HK genes, together with library size in one nCounter assay, and plotting these three averages and the log(total count) for that assay, all suitably offset vertically to minimize overlap, in the order in which the assays were run, or a related order. Trends, temporal clustering, or other patterns in these plots can reveal issues that normalization should address.
Technical Replicate Location (TRL) plots
Here we depict the location of these replicates in time, and in relation to known batches, using lines connecting replicate pairs, triples, etc. When connecting lines are viewed together with Average and RLE plots (see below), we can get a sense of how well differences between replicates can help remove batch effects. From seeing where there are no connecting lines, we can also get a sense of how suitably defined pseudo-replicates (see below) might help.
Relative Log Expression (RLE) plots
A common representation of the results of studies like those discussed in this paper is the collection of boxplots of the log(count)s from each assay, lined up in the order in which the assays were run. Again this permits trends, temporal clustering or other patterns to be visible, and it allows outliers to stand out. The RLE plot is a more sensitive modification of this representation, as it removes the variation between mean gene counts. Instead of making a boxplot of all the log(count)s in each assay, the quantities going into the boxplots are relative to the gene-wise median counts. More fully, instead of log(count), we use log(count)—median[log(count)], where for each transcript (gene), the median over all the assays is taken and its log subtracted. Equivalently, the log(count) for a given transcript, is median corrected, where we use the median rather than the mean to reduce the influence of extremes. For a fuller discussion of RLE plots, see (9).
Principal Component Analysis (PCA) plots
The principal components (also in this context called singular vectors) of the sample × transcript array of log(count)s are the linear combinations of the transcript measurements having the largest, second largest, third largest,… variation, standardized to be of unit length and orthogonal to the preceding components. Our PCA plots are of the second versus the first principal component (PC) of the sample x transcript array. The calculations are done on mean-corrected transcript log counts, using the R code adopted from the EDAseq R package (12).
Technical Replicate Agreement (TRA) plots
If two assays 1 and 2 are technical replicates, that is, independent assays of two samples of cells from the same tissue sample or subject, then for any transcript (gene) we can form the log ratio log[(count1/count2)] of the counts from the two assays. These log ratios can then be pooled across all transcripts in the assay, for a given pair of replicates, and across all technical replicate pairs in a study, and a boxplot created out of them. This we call a TRA boxplot. The boxplot, in particular its inter-quartile range, summarizes the average closeness of technical replicates. It provides a simple visual metric for assessing and comparing normalizations. If, as in RUV-III and some other normalizations, explicit use is made of technical replicates, then the contribution of a given replicate pair to the TRA plot must be calculated after normalization without that pair being used, i.e. with them left undeclared as replicates. All TRA plots calculated after RUV-III in this paper were formed this way.
Differential Expression (DE) analysis
Differential expression analyses of all normalized Nanostring datasets in this paper were performed using the limma R package (13). The design matrix was created using the model.matrix function for only biological factor of interests. The empirical Bayes method included in the limma R package were used to carry out differential expression analysis and the unadjusted P-values and log fold changes were used for further analysis.
Volcano plots
A volcano plot is a summary of the results of a two-condition differential expression analysis, where each point corresponds to a transcript, the vertical axis being—10log10p and the horizontal axis log(FC) for that transcript, where FC is the fold change and p denotes the associated (unadjusted) P-value for the test of the null hypothesis of no change. These plots provide a convenient visualization of the efficacy of the study and the location of controls; ideally negative controls should be near (0,0), while positive controls should be well away from 0 on both axes.
P-value histograms
In a two-condition differential expression study with hundreds or thousands of transcripts (genes), the majority will in general not be differentially expressed (DE), in which case their (unadjusted) P-values will be uniformly distributed over (0,1), while those transcripts (genes) that are DE will have P-values close to zero. As a result, we usually expect that the histogram of P-values from a DE study should look uniform, with a possible spike near zero. The presence of unwanted variation will frequently destroy this expected shape. If the number of transcripts (genes) is just a few hundred, and they were pre-selected to exhibit the DE under study, then the expected shape may not result, even in the absence of unwanted variation, and so extra care in interpretation is needed in this case.
Selection of negative control genes
First, we need to reiterate that in our usage, a negative control gene is one that is not expected to change much across the samples being analyzed. Second, we need to emphasize that our approach to negative controls is pragmatic: if using a given gene in RUV-III as one of the set of negative control genes helps, as indicated by various measures, then whether or not it is an ideal negative control gene is moot: it helped. This does not rule out the fact that we may be able to do better by replacing that gene with a different gene designated a negative control. Third, we point out that theoretical analyses not presented here show that it is not the extent to which individual genes designated as negative controls are ideal or less than ideal negative controls that drives the success or otherwise of RUV-III; that is a property of the full set of negative controls. We will frequently get very good results using the entire set of genes being studied as negative controls, even when many genes are changing. (That this is not unreasonable follow from the theory just mentioned.) Fourth, it is usually the case that using more genes as negative control genes is better than fewer. That is a matter of stability, but as stated in the introduction, there is a bias-variance trade-off here: using too many genes as negative controls may be counter-productive. You must look and see. Fifth, endogenous genes generally make more suitable negative controls than spike-ins. The reason here is the obvious one, namely, that endogenous genes have shared the complete sample experience of the other genes, whereas spike-ins can only reflect unwanted variation in the process from the point at which they were added onward. The best source of endogenous negative control genes are ones that were found to be stable in previous studies similar to the one being analyzed. Given that Nanostring expression assays are frequently designed following initial, genome-wide microarray or RNA-seq assays, it should be straightforward to include 20–50 endogenous likely negative controls. We believe that the results in this paper show that their presence for use in normalizing the data will definitely justify the extra expense. Suitable generic sources of negative controls include those genes that are traditionally regarded as HK genes (ACTB, GAPDH, etc). Gender related genes, such as those on the Y chromosome, can double as negative and positive controls in a gender DE. Having said this, it can at times be quite challenging to find suitable endogenous negative controls in Nanostring studies, especially where there are few ‘HK’ genes, and where no prior studies are available. Sometimes it becomes a matter of trial and error, of doing the best you can.
RUV-III method
In RUV-III we make use of two separate sources of information on the unwanted variation in a study with technical replicates: that embodied in the differences between the expression values of the replicate samples, and that embodied in the expression values of the negative control transcripts (genes). Informally, the three steps that make up RUV-III are the following:
take residuals from the replicate expression measurements and estimate one aspect of the unwanted variation;
take the results of (i) together with the expression values of the negative controls, and estimate another aspect of the unwanted variation; and
combine the results from (i), (ii) into an estimate of the unwanted variation and subtract that from the data.
The dimension (k) of the unwanted variation also needs to be determined. Full details of the method and R code are given in the Supplementary Method (supplementary file) and the ruv R package (https://cran.r-project.org/package=ruv), respectively.
Choice of k
To use RUV-III, we need to fix the number k of (linear) dimensions of unwanted variation to be removed. As with the set of negative controls, and the replicates (or pseudo-replicates), there are no clear rules for determining k. Our general approach is to repeat the analysis with different values of , and then evaluate the quality of each analysis using various statistical metrics and prior biological knowledge, as explained in the above. RUV-III is generally robust to overestimating k, but not always. If the number of negative control genes is less than the number of samples, the maximum value of k is equal to number of technical replicates (m-m′). We refer to comments on RUV-III in the Supplementary Method.
Number and placement of technical replicates, and the occasional need to define pseudo-replicates
When a study has several batches, it is highly desirable to have replicates placed so that the unwanted variation between any pair of batches can be captured, directly or indirectly, via differences of expression values between technical replicates. For example, if there are three batches, and (for instance) there are samples with technical replicates present in all three, then all gene-wise batch–batch differences can be estimated using differences of these technical replicate samples. (How well is a different matter, see later.) But we need not have samples with technical replicates in all three batches: some which span batches 1 and 2, and others which span batches 2 and 3 will suffice, for the difference between batches 1 and 3 can be estimated by the sum of a 1–2 and a 2–3 difference. Again how well it can be estimated is a different matter. This observation generalizes in a natural way, which we do not spell out at the moment. Roughly, the best results will come when different batches can be ‘connected’ by a short chain of replicate pairs. To see this point, suppose that we have two batches, and that all the technical replicates lie wholly within batch 1, or wholly within batch 2, with no replicate pair linking batches 1 and 2. How then can we adjust all gene expression measurements for any bias in the batches? The answer is that we can’t do so directly for all genes, as we could when the two batches were ‘connected’, we can only get a direct measure of the 1–2 difference for our negative control genes. When the two batches are not connected by a replicate pair, we may do a poor job removing batch differences using RUV-III.
What can be done in this case? Suppose that there is a pair of samples with one in batch 1 and the other in batch 2, and that we believe that the batch differences between these two samples of most genes are greater than the biological differences. We might have reason to believe that the batch 1–2 difference is really large, for example, by looking at the RLE plot. If we designate this pair of samples a replicate pair, and use RUV-III, we may find ourselves coming out ahead. That is, we may be able to use the standard battery of graphical diagnostics and positive controls to convince ourselves that the resulting estimate of the batch 1–2 difference, while imperfect, was near enough to the unwanted variation we sought to remove, to permit a successful application of RUV-III. We would call the pair of samples so used pseudo-replicates. This is precisely what we did with the dendritic cell example (see below).
Not quite anything goes, but almost, as long as we check
In the preceding discussion, we have suggested that there is no such thing as a perfect negative control, but rather, plausible candidates should be tried, and their value assessed. And we said that, up to a point, the more the better. We have also said that to get RUV-III working well, we would like replicates suitably spanning the major batches or batch-like groups of samples. For example, if there are visible trends in the average or RLE plots, then we would like replicates spanning the trend, not all at one end, or all in the middle. When there are samples in excess, and clearly major pockets of unwanted variation, then creating pseudo-replicates may help. All of which brings up a point that cannot be emphasized too much: Any normalization should be critically assessed using all the tools that can be brought to the task: RLE, PCA, TRA, volcano plots, P-value histograms and comparisons with as much prior information as possible, including positive controls. Normalizing using RUV-III with different sets of negative controls, or making use of pseudo-replicates, if the natural controls or replicates available seem inadequate, is a reasonable approach, which can ‘rescue’ data that is otherwise fatally compromised by unwanted variation.
RESULTS
Datasets
To evaluate the performance of the RUV-III method on Nanostring gene expression data, we examined 4 studies comprising one in-house and three different published datasets that had technical replicate samples. The details of each study are given separately below.
Example 1: Lung cancer study
Our in-house Nanostring dataset was part of a study of the expression of DNA repair genes in lung adenocarcinoma (LUAD). The data was generated using 15 nCounter cartridges, with the majority of the normal samples being run in a 15th cartridge a year after the rest of the experiment (Supplementary Figure S1a). For more details on this study, we refer to the supplementary file and Supplementary Figure S1.
We began our analysis with an examination of the Average Plot (See ‘Materials and Methods’ section) of the raw nCounter data (Supplementary Figure S2). The spiked-in controls were roughly constant across the cartridges, though occasionally showing substantial variability. The average counts of the HK genes and the library sizes show a marked decline in the 15th cartridge while the averages of the POS and NEG spiked-in controls are fairly stable across all cartridges. This inconsistency poses a challenge for the nCounter normalization.
In Figure 1A, we present three RLE plots (See ‘Materials and Methods’ section), the first for the unnormalized data. For the nCounter normalized data, we applied a standard option: mean+2sd of the NEG transcripts for background correction, and geometric means for both the POS and the HK transcripts. In the third, the data were normalized by RUV-III using the 500 genes with lowest variance as the negative control set, all technical replicates samples (Supplementary Figure S1b) and k = 6 (See ‘Materials and Methods’ section). In the RLE plot of the raw data (Figure 1A) we see substantial differences within and across cartridges, with samples from cartridge 15 standing out. This remains the case with nCounter normalized data, whereas the RUV-III normalization yields much more uniform RLE plots, centred around zero (Figure 1A).
Figure 1.
Comparing the performance of nCounter and RUV-III normalization methods. (A) The RLE boxplots of unnormalized, nCounter normalized and RUV-III normalized datasets. Ideal RLE distributions would be centered around zero and similar to each other. The boxplots of unnormalized data clearly show substantial variation within and between batches. (B) Log ratios of genes of all technical replicate samples in unnormalized, nCounter normalized and RUV-III normalized datasets. RUV-III normalization led to smaller log ratios change of genes between technical replicate samples. (C) Scatter plots of ERCC1 and RRM1 gene expression obtained from nCounter normalized data (r = −0.47) and RUV-III normalized data (r = 0.31) and two publicly available datasets including Hou et al.’s (25) microarray gene expression data (r = 0.40) and the TCGA lung adenocarcinoma RNA-SeqV2 (r = 0.0). The nCounter normalization shows very different pattern compared to that of the RUV-III normalized data and the publicly available datasets.
We evaluated the similarity of technical replicate samples by producing TRA plots (See ‘Materials and Methods’ section and Figure 1B). These show that RUV-III normalization leads to a considerable reduction in the differences between technical replicate samples.
To assess the effectiveness of the different normalizations, we attempted to recapitulate some established biology in our data. A known biological signal in this context is that the expression of the genes RRM1 and ERCC1 should be moderately positively correlated (14–17). In Figure 1C, we present four scatter plots of the expression levels of these two genes. The nCounter normalized data scatter plot clearly deviates from the other three, including the RUV-III normalized data, two of which recapitulate the finding of (14).
We also examined all 84 different nCounter normalization options, displaying in Supplementary Figure S3 the medians of the RLE plots for each sample, the TRA plot and the correlation between RRM1 and ERCC1 for all 84 options, and for RUV-III. Repeating all 84 normalization options on the lung dataset using a new set of reference genes obtained by the geNorm (18) method led to results similar to those obtained using the initial set of reference genes (data not shown). In all the assessments we have presented, the RUV-III normalization markedly improves upon the nCounter normalizations.
Example 2: Inflammatory Bowel Disease (IBD) study
The study by Peloquin et al. (19) of Crohn's disease (CD) and ulcerative colitis (UC) included samples from three tissues (colon, rectum and terminal ileum) under each of five different conditions: CD-uninflamed, CD-inflamed, UC-uninflamed, UC-inflamed and healthy. The cartridges were run in three batches (CodeSets) numbered 2, 3 and 4, see (Supplementary Figure S4a) and the supplementary file for fuller details.
First, we examined the Average and RLE plots of the unnormalized data (Supplementary Figure S5a and b). Both show noticeable batch differences. The RLE plots of the data normalized by Peloquin et al. show that there is still noticeable variation within and between batches (Supplementary Figure S5a), and this is strongly supported by the batch-colored PCA plot (Figure 2A). There one of the two clusters is dominated by samples from batch 3, consistent with a batch difference rather than the tissue difference we would expect to see biologically. Interestingly, samples from batch 3 do not stand out if we make our PC2 against PC1 plot with the correlation matrix (20). However, batch 3 does stand out in PC3 against PC1 plot using the correlation matrix (Supplementary Figure S6).
Figure 2.
Comparing the performance of different normalization methods on Nanostring data for the inflammatory bowel disease study. (A) Scatter plots of first two principal components (log scale and centered) for Peloquin normalized Nanostring data colored by reagent lots (left) and by different tissues (right). The second principal component captures all samples of batch 3, which clearly demonstrates that batch effects remain. (B) Same as a, for RUV-III normalized Nanostring data colored by reagents lots (left) and by different tissues (right). The different tissues cluster as expected biologically. (C) Differential expression analysis of terminal ileum individuals with inflamed Crohn's disease between pairs of Nanostring batches.
We then normalized the data by RUV-III using all genes as negative controls, all technical replicates (Supplementary Figure S4b) and the maximum value of K (See ‘Materials and Methods’ section). The RUV-III normalization led to RLE plots that were more uniform and centered around zero, and also to the separation of ileum from colorectal tissues in PCA plots (Figure 2B). This is now consistent with what is known about the biology of these tissues (21).
In order to determine whether the batch differences visible in Figure 2A are of any consequence, we performed a differential expression analysis for each disease state between pairs of batches, comparing the data normalized by Peloquin et al. with that normalized by RUV-III. The results (Figure 2C) are displayed in the form of volcano plots with -log10(P-value) plotted vertically against the log(fold-change) horizontally for each gene counted. More such plots can be found in Supplementary Figure S6. Ideally, we should see little evidence of differential expression in these plots, whereas we see a lot in the data normalized by Peloquin et al., far more than in the RUV-III normalized data.
Noble et al. (22)reported microarray gene expression data profiling colon tissue in some of the same states studied in Peloquin et al. This enabled us to compare the two normalization results using an orthogonal platform.
We note that the batch effects remaining in the data normalized by Peloquin et al. (Figure 3A) can influence downstream analyses. For example, these data suggest that the CCDC101 gene is upregulated in UC uninflamed colon compared to normal colon tissue, whereas we do not see this in either the RUV-III normalized data or the Noble et al. microarray data (Figure 3B). In Supplementary Figure S8 we see similar results for six other genes. The residual batch effect in the data normalized by Peloquin et al. clearly matters, and it is not present in the RUV-III normalized data.
Figure 3.
Impact of batch effects on differential expression analysis. (A) Expression pattern of CCDC101 gene across different batches of reagents. The Peloquin normalized Nanostring data showed a substantial difference between batch 3 and other batches whereas RUV-III largely removes this unwanted variation. (B) The expression pattern of the CCDC101 gene across different the disease states of colon samples. The gene is apparently upregulated in colon samples in the uninflamed ulcerative colitis state compared to healthy individuals in the Peloquin normalized data, whereas there is no evidence of differentially expression in the RUV-III normalized data or the Noble et al. microarray data.
Example 3: Human T-cell activation
For a discussion of the study by Ye et al. (23) of CD4+ T-cell conditions including activated 4 h, activated 48 h, INFβ 4 h, Th17 48 h and unstimulated T cells for 4 h, we refer to the supplementary file. The Nanostring data consisted of 1788 assays generated over 4 months in 2012 and 2013 (Supplementary Figure S9a). We found only 46 technical duplicates samples, distributed across Nanostring cartridges in 2013 only (Supplementary Figure S9b).
The Average Plot (Supplementary Figure S10) of the unnormalized data show a clear downward shift in expression values from 2013 compared to 2012 (hereafter called time effects); this is most clear in the positive spike-in controls. The RLE plots of the same data show that the majority of samples with 48 h conditions were shifted up compared to those with the 4 h conditions (Supplementary Figure S11a), and the individual expression patterns of HK (Supplementary Figure S12a) and gender genes (data not shown) confirm this.
The pattern observed in the raw data is strikingly reversed in the data normalized by Ye et al. (Supplementary Figure S11a), where samples under the 48 h conditions now have generally lower values compared to those with 4 h conditions, and this too is reflected in the housekeeping gene expression patterns (Supplementary Figure S12b). This is likely the result of using HK genes for normalization across cartridges. We retrieved the authors’ normalized gene expression microarray data from GEO, and produced RLE plots for the 236 genes used in their nCounter assays (Supplementary Figure S11b). These RLE plots are very different from those of the Nanostring data normalized by Ye et al.
Our earlier strategy of using all genes as negative controls and all technical replicates failed to produce a reasonable RLE plot, so we used the nine (from 236) genes with lowest variance in the microarray data as a set of negative controls and all technical replicates to normalize the Nanostring data using RUV-III (k = 1). The RUV-III normalization largely removed the technical variation between the T-cell conditions, but the time effects remained in the data due to not having technical replicate across 2012 and 2013. Enlarging the number of negative control genes from 9 to 100 produced little change (Supplementary Figure S11a).
Next, we carried out a differential expression analysis between pairs of conditions to examine the concordance between log fold-changes found using the data normalized by Ye et al. and the RUV-III normalized data and the corresponding results from the microarray data. The result for one of 10 pairwise comparisons is seen in Figure 4A while those for the other 9 are in the supplementary file (Supplementary Figure S13). This was repeated for the 100 least variable genes (Supplementary Figure S14). In 17/20 comparisons, the RUV-III normalized data give results closer to those from the microarray data.
Figure 4.
Differential expression analysis between activated 48 h and unstimulated 4 h conditions and the expression pattern of SOCS1 gene. (A) Scatter plots of log fold changes obtained by differential expression analysis between activated 48 h and unstimulated conditions for Ye-normalized data and RUV-III normalized data, each compared to the corresponding comparison from Ye et al. microarray data. The dotted red line is the 45° line. (B) Boxplot of log fold change (Ye)—log fold change (microarray) and log fold change (RUV-III)—log fold change (microarray). (C) Expression pattern of SOCS1 gene across all the T cell conditions in Ye-normalized data, RUV-III normalized data and Ye et al. microarray data.
We also display several genes whose expression levels differ across the conditions, and compare the patterns of differences seen in Ye-normalized, RUV-III normalized and the microarray data (Figure 4B and Supplementary Figure S15). In all of these comparisons, the RUV-III normalized data showed better agreement with the microarray data than did the Ye-normalized data.
Example 4: Dendritic cell study
The final dataset we examined is from the study by Lee et al. (24) of four different CD14+ T cell conditions, unstimulated for 0 h (UNS 0h), Escherichia coli bacterial lipopolysaccharide for 5 h (LPS 5 h), influenza virus for 10 h (FLU 10 h) and interferon beta (INFβ) for 6.5 h. We refer to the supplementary file for fuller details, particularly Supplementary Figure S16b for sample collection times and Supplementary Figure S17 for the TRL plot.
We began our analysis with average and RLE plots of the raw and Lee-normalized data (Supplementary Figure S18a and 19), and we saw that the UNS samples really stood out. Not only were they very spread out in time (Supplementary Figure S16b), we noticed that they consisted of 165 that were assayed under the UNS condition alone (U), 276 that were assayed under all four conditions (ULVI), with smaller numbers for another four types (Supplementary Figure S16a). We were led to define 11 sample usage types, see supplementary file for a full explanation of this term, and Supplementary Figure S16a for their numbers.
In Figure 5A we present PCA plots of the Lee-normalized data stratified by condition and colored by gender (row 1) and by usage type (row 2), while Supplementary Figure S20b has the same data with the initial RUV-III normalization.
Figure 5.
Scatter plots of first two principal components of Lee-normalized data and RUV-III normalized data with all technical replicates and 10 pseudo-replicate pairs. (A) Principal component analysis of each condition colored by gender (first row) and by usage type (second row). Ideally, PCA plots within condition should have two clear clusters corresponding to males and females, preferably defined by PC1. (B) Same as A, for RUV-III normalized data using all technical replicate samples and 10 pairs of pseudo technical replicate across U and ULVI types of the UNS condition.
A differential expression analysis comparing the U-samples with the rest of the samples showed striking heterogeneity of Lee-normalized gene expression data under the UNS condition (Supplementary Figure S21a). By definition, there cannot be replicate pairs spanning the U and the ULVI sample usage types, so we created 10 carefully matched pseudo-replicate pairs that did so (See ‘Materials and Methods’ section). We then used RUV-III with all technical replicates and the 10 pseudo-replicate pairs, the 340 least variable genes as negative controls and k = 10. The resulting RLE plot is in Supplementary Figure S19 and the corresponding PCA plots are in rows 3 and 4 of Figure 5.
When we normalized using RUV-III with the pseudo-replicates spanning the U and ULVI sample usage types, the resulting PCA plots split into two clusters on PC1 corresponding to gender for three of the four conditions (Figure 5B). It seems likely that there is heterogeneity under the LPS 5 h condition which could be removed by creating suitable pseudo-replicates that would lead to a gender split on PC1 for that condition too, but we did not explore that. These clusterings, the RLE plots in Supplementary Figure S19 and the greatly reduced gene expression heterogeneity evident in Supplementary Figure S21 demonstrate the value of using pseudo-replicates with RUV-III.
DISCUSSION
Normalization is key to deriving meaningful biological results from complex gene expression datasets, especially when the data is compromised by unwanted variation. A normalization method for Nanostring gene expression data must be able to adjust for sample loading differences, variations in assay efficiency, the use of different Nanostring CodeSet batches and other factors.
Our goal in this paper is to compare our new way of normalizing Nanostring data based upon the use of technical replicates with other normalizations in the literature. In order to do so, we made use of our own data on lung adenocarcinoma samples and three published Nanostring datasets. Our comparisons are based on statistical summaries, biological positive controls and concordance with previous results.
In the lung cancer study, in the summary of all 84 nCounter normalization options (Supplementary Figure S3), NNN and some other options have reasonable narrow TRA plots and reasonable (RRM1, ERCC1) correlation close to that of the RUV-III normalization, but RLE plots for these options include many boxes far from centered (blue), while with RUV-III they are all centered (Figure 1A, and extreme right of Supplementary Figure S3).
Peloquin et al. (19) compared their results for the healthy patients with the corresponding ones from the microarray data, and found concordance. We note that all but four of the normal samples in their comparison were from batch 2 (Supplementary Figure S4), and that if they had used other groups in this comparison, the agreement may not have been so good.
We noticed that the different experimental conditions were not uniformly distributed across the 167 Nanostring cartridges (batches) in the T-cell study by Ye et al. The majority of samples in the 48 h condition were run together, and the majority of samples with 4 h conditions were also run together (Supplementary Figure S9a). This suggests that the study design may have led to a confounding between biological factors of interest and the Nanostring cartridges, though we cannot offer an explanation for what we see. The patterns of expression across conditions seen in the HK genes from the microarray data did not resemble that seen in either the raw or the Ye et al-normalized data (Supplementary Figure S12).
Although there were plenty of technical replicates, these cannot bridge conditions, and so we had to rely more heavily on negative control genes for RUV-III. We had great trouble finding suitable ones using just the Nanostring data, but the nine genes exhibiting least variation across conditions in the microarray data worked well, and replacing 9 by 100 was almost as good.
There are some quite noticeable differences between the log fold changes obtained using the Ye normalization and the microarray data, whereas the agreement between the RUV-III normalized data and the microarray data is much better (Figure 4A; Supplementary Figures S13 and 14). We conclude that the Ye normalization has shortcomings, whereas using RUV-III, we obtain much better concordance with the microarray data, and that this normalization greatly reduced, but did not completely remove the impact of the likely confounding effects.
The challenge normalizing the data from the dendritic study by Lee et al. resembled that just discussed. We felt that a good normalization of all the data should lead to PCA plots clearly separating the four conditions, and that PCA plots within condition should have two clear clusters corresponding to males and females, ideally defined by PC1. The Lee-normalization did not fully achieve this (Figure 5A), and neither did our initial RUV-III normalization (Supplementary Figure S20). A major obstacle was the unstimulated (UNS) condition, which turned out to be extremely heterogeneous, consisting of samples with very different collection times and usages (Figure 5A and Supplementary Figure S16). The heterogeneity was dramatic enough for there to be many genes extremely significantly differentially expressed between samples in the UNS condition that were only measured under that condition and those what were measured under the other three conditions as well. We can offer no explanation as to why this might be so, but careful choice of pseudo-replicates bridging these two subsets of samples led to Figure 5B, see also Supplementary Figure S21.
We will discuss design issues more fully elsewhere, but certain clear principles should have emerged from the above discussion. The inclusion of carefully chosen endogenous negative control genes in the code set, say 10% of all genes, will more than repay the extra expense. Likewise, the strategic inclusion of at least 10% technical replicates, beginning with at least one in each cartridge, will suffice to permit RUV-III to do its job. Exactly what ‘strategic’ means in any given study will depend on the nature of the inevitable unwanted variation, whether it be CodeSet batch, as with the IBD data, time as in the T cell and dendritic cell data, or other highly specific features such as in the last mentioned, which might be hard to anticipate, but definitely need to be considered.
If an nCounter gene expression dataset has very few or no replicates, RUV-III cannot be used. In such cases, analysts might care to use our approach to assessing their own normalization, one of the 84 nCounter options, or one of the methods presented in (11) which do not require replicates.
In summary, we have shown that the use of technical replicates, pseudo-replicates where necessary, and suitably chosen negative control genes in RUV-III can lead to satisfactory normalization of Nanostring data where other methods exhibit shortcomings. We have shown a variety of ways of assessing normalizations, and inter alia, given hints for better designing largish Nanostring studies. As shown in the examples we presented, RUV-III can profitably be used to re-analyze existing datasets to yield new insights into the data.
Software availability
RUV-III is implemented in the open-source R package ruv, with source code freely available through the CRAN (https://cran.r-project.org/package=ruv). All computational source code required for reproducing all results presented in this paper are available in https://github.com/RMolania/NanostringNormalization.
DATA AVAILABILITY
The publicly available datasets used in this study are available through the following addresses: The TCGA lung cancer adenocarcinoma RNA-SeqV2 in the Broad GDAC Firehose (https://gdac.broadinstitute.org), data version 2016/01/28; Expression data for none-small cell lung cancer Affymetrix microarray data by Hou et al. (25), GEO GSE19188; Inflammatory bowel disease (IBD) study Nanostring data by Peloquin et al. (19), GEO GSE73094; Colon biopsies from UC patients and healthy controls Agilent microarray data by Noble et al. (22), GEO GSE11223; T-cell study Nanostring data by Ye et al.(23), GEO GSE60341; T-cell study Affymetrix microarray data by Ye et al. (23) GEO GSE60235; Dendritic study Nanostring data by Lee et al. (24), GEO GSE53165.
Supplementary Material
ACKNOWLEDGEMENTS
We thank Dr Chun Jimmie Ye and Dr Gautam Goel for their comments on the near final draft. This study acknowledges support by the Victorian Government's Operational Infrastructure Support Program to the Olivia Newton-John Cancer Research Institute. In particular, the authors thank groups who have made the raw and normalized datasets publicly available and the TCGA Research Network for generating the data used in this study. Dr Gavin Wright provided the lung cancer samples.
Author Contributions: R.M., A.D. and T.P.S. designed the overall approach. J.G.B and T.P.S. developed the RUV-III method. R.M. performed data analysis, A.D. provided data from the lung cancer study and carried out Nanostring lung study; R.M., J.G. B, A.D. and T.P.S. drafted the manuscript, which was revised and approved by all authors.
SUPPLEMENTARY DATA
Supplementary Data are available at NAR Online.
FUNDING
National Health and Medical Research Council of Australia Program Grant [1054618 to T.P.S.]; Cancer Australia for the Lung Cancer DNA Repair Study (to A.D.); The University of Melbourne international Australian postgraduate scholarships (MIRS and MIFRS) (to R.M.); Cancer Therapeutics CRC CTx PhD Top Up Scholarship (to R.M.). Funding for open access charge: Walter & Eliza Hall Institute and NHMRC Grant.
Conflict of interest statement. None declared.
REFERENCES
- 1. Geiss G.K., Bumgarner R.E., Birditt B., Dahl T., Dowidar N., Dunaway D.L., Fell H.P., Ferree S., George R.D., Grogan T. et al.. Direct multiplexed measurement of gene expression with color-coded probe pairs. Nat. Biotechnol. 2008; 26:317–325. [DOI] [PubMed] [Google Scholar]
- 2. Scott D.W., Wright G.W., Williams P.M., Lih C.J., Walsh W., Jaffe E.S., Rosenwald A., Campo E., Chan W.C., Connors J.M. et al.. Determining cell-of-origin subtypes of diffuse large B-cell lymphoma using gene expression in formalin-fixed paraffin-embedded tissue. Blood. 2014; 123:1214–1217. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 3. Urrutia A., Duffy D., Rouilly V., Posseme C., Djebali R., Illanes G., Libri V., Albaud B., Gentien D., Piasecka B. et al.. Standardized whole-blood transcriptional profiling enables the deconvolution of complex induced immune responses. Cell Rep. 2016; 16:2777–2791. [DOI] [PubMed] [Google Scholar]
- 4. Wallden B., Storhoff J., Nielsen T., Dowidar N., Schaper C., Ferree S., Liu S., Leung S., Geiss G., Snider J. et al.. Development and verification of the PAM50-based Prosigna breast cancer gene signature assay. BMC Med. Genomics. 2015; 8:54. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 5. NanoStringTechnologies Reference Genes for Normalization of Expression Data. 2009; Seattle: NanoString Technologies, Inc. [Google Scholar]
- 6. Waggott D., Chu K., Yin S., Wouters B.G., Liu F.F., Boutros P.C.. NanoStringNorm: an extensible R package for the pre-processing of NanoString mRNA and miRNA data. Bioinformatics. 2012; 28:1546–1548. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 7. Ku H.H. Precision Measurement and Calibration: Selected NBS Papers on Statistical Concepts and Procedures. 1969; National Bureau of Standards. [Google Scholar]
- 8. Ringner M. What is principal component analysis. Nat. Biotechnol. 2008; 26:303–304. [DOI] [PubMed] [Google Scholar]
- 9. Gandolfo L.C., Speed T.P.. RLE plots: visualizing unwanted variation in high dimensional data. PLoS One. 2018; 13:e0191629. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 10. Gagnon-Bartsch J.A., Speed T.P.. Using control genes to correct for unwanted variation in microarray data. Biostatistics. 2012; 13:539–552. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 11. Jacob L., Gagnon-Bartsch J.A., Speed T.P.. Correcting gene expression data when neither the unwanted variation nor the factor of interest are observed. Biostatistics. 2016; 17:16–28. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 12. Risso D., Schwartz K., Sherlock G., Dudoit S.. GC-content normalization for RNA-Seq data. BMC Bioinformatics. 2011; 12:480. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 13. Ritchie M.E., Phipson B., Wu D., Hu Y., Law C.W., Shi W., Smyth G.K.. limma powers differential expression analyses for RNA-sequencing and microarray studies. Nucleic Acids Res. 2015; 43:e47. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 14. Zheng Z., Chen T., Li X., Haura E., Sharma A., Bepler G.. DNA synthesis and repair genes RRM1 and ERCC1 in lung cancer. N. Engl. J. Med. 2007; 356:800–808. [DOI] [PubMed] [Google Scholar]
- 15. Ceppi P., Volante M., Novello S., Rapa I., Danenberg K.D., Danenberg P.V., Cambieri A., Selvaggi G., Saviozzi S., Calogero R. et al.. ERCC1 and RRM1 gene expressions but not EGFR are predictive of shorter survival in advanced non-small-cell lung cancer treated with cisplatin and gemcitabine. Ann. Oncol. 2006; 17:1818–1825. [DOI] [PubMed] [Google Scholar]
- 16. Bepler G., Olaussen K.A., Vataire A.L., Soria J.C., Zheng Z., Dunant A., Pignon J.P., Schell M.J., Fouret P., Pirker R. et al.. ERCC1 and RRM1 in the international adjuvant lung trial by automated quantitative in situ analysis. Am. J. Pathol. 2011; 178:69–78. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 17. Tryfonidis K., Papadaki C., Assele S., Lagoudaki E., Menis J., Koutsopoulos A., Trypaki M., Tsakalaki E., Sfakianaki M., Hasan B. et al.. Association of BRCA1, ERCC1, RAP80, PKM2, RRM1, RRM2, TS, TSP1, and TXR1 mRNA expression levels between primary tumors and infiltrated regional lymph nodes in patients with resectable non-small cell lung cancer. Pharmacogenomics J. 2018; 19:15–24. [DOI] [PubMed] [Google Scholar]
- 18. Vandesompele J., De Preter K., Pattyn F., Poppe B., Van Roy N., De Paepe A., Speleman F.. Accurate normalization of real-time quantitative RT-PCR data by geometric averaging of multiple internal control genes. Genome Biol. 2002; 3:RESEARCH0034. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 19. Peloquin J.M., Goel G., Kong L., Huang H., Haritunians T., Sartor R.B., Daly M.J., Newberry R.D., McGovern D.P., Yajnik V. et al.. Characterization of candidate genes in inflammatory bowel disease-associated risk loci. JCI Insight. 2016; 1:e87899. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 20. Jolliffe I.T., Cadima J.. Principal component analysis: a review and recent developments. Philos. Trans. A Math Phys. Eng. Sci. 2016; 374:20150202. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 21. Weiser M., Simon J.M., Kochar B., Tovar A., Israel J.W., Robinson A., Gipson G.R., Schaner M.S., Herfarth H.H., Sartor R.B. et al.. Molecular classification of Crohn's disease reveals two clinically relevant subtypes. Gut. 2018; 67:36–42. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 22. Noble C.L., Abbas A.R., Cornelius J., Lees C.W., Ho G.T., Toy K., Modrusan Z., Pal N., Zhong F., Chalasani S. et al.. Regional variation in gene expression in the healthy colon is dysregulated in ulcerative colitis. Gut. 2008; 57:1398–1405. [DOI] [PubMed] [Google Scholar]
- 23. Ye C.J., Feng T., Kwon H.K., Raj T., Wilson M.T., Asinovski N., McCabe C., Lee M.H., Frohlich I., Paik H.I. et al.. Intersection of population variation and autoimmunity genetics in human T cell activation. Science. 2014; 345:1254665. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 24. Lee M.N., Ye C., Villani A.C., Raj T., Li W., Eisenhaure T.M., Imboywa S.H., Chipendo P.I., Ran F.A., Slowikowski K. et al.. Common genetic variants modulate pathogen-sensing responses in human dendritic cells. Science. 2014; 343:1246980. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 25. Hou J., Aerts J., den Hamer B., van Ijcken W., den Bakker M., Riegman P., van der Leest C., van der Spek P., Foekens J.A., Hoogsteden H.C. et al.. Gene expression-based classification of non-small cell lung carcinomas and survival prediction. PLoS One. 2010; 5:e10312. [DOI] [PMC free article] [PubMed] [Google Scholar]
Associated Data
This section collects any data citations, data availability statements, or supplementary materials included in this article.
Supplementary Materials
Data Availability Statement
The publicly available datasets used in this study are available through the following addresses: The TCGA lung cancer adenocarcinoma RNA-SeqV2 in the Broad GDAC Firehose (https://gdac.broadinstitute.org), data version 2016/01/28; Expression data for none-small cell lung cancer Affymetrix microarray data by Hou et al. (25), GEO GSE19188; Inflammatory bowel disease (IBD) study Nanostring data by Peloquin et al. (19), GEO GSE73094; Colon biopsies from UC patients and healthy controls Agilent microarray data by Noble et al. (22), GEO GSE11223; T-cell study Nanostring data by Ye et al.(23), GEO GSE60341; T-cell study Affymetrix microarray data by Ye et al. (23) GEO GSE60235; Dendritic study Nanostring data by Lee et al. (24), GEO GSE53165.