The SARTools R package which generated this report has been developped at PF2 - Institut Pasteur by M.-A. Dillies and H. Varet () and modified by Cenny Taslim (). Thanks to cite H. Varet, L. Brillet-Guéguen, J.-Y. Coppee and M.-A. Dillies, SARTools: A DESeq2- and EdgeR-Based R Pipeline for Comprehensive Differential Analysis of RNA-Seq Data, PLoS One, 2016, doi: http://dx.doi.org/10.1371/journal.pone.0157022 when using this tool for any analysis published.

1 Introduction

The analyses reported in this document are part of the RNA-seq_differential_analysis project. The aim is to find features that are differentially expressed between iEF_empty, iEF_EF and iEF_EE4. The statistical analysis process includes data normalization, graphical exploration of raw and normalized data, test for differential expression for each feature between the conditions, raw p-value adjustment and export of lists of features having a significant differential expression between the conditions. In this analysis, the rep effect will be taken into account in the statistical models.

The analysis is performed using the R software [1], Bioconductor [2] packages including DESeq2 [3,4] and the SARTools package developed at PF2 - Institut Pasteur. Normalization and differential analysis are carried out according to the DESeq2 model and package. This report comes with additional tab-delimited text files that contain lists of differentially expressed features.

For more details about the DESeq2 methodology, please refer to its related publications [3,4].

2 Description of raw data

The count data files and associated biological conditions are listed in the following table.

Table 1: Data files and associated biological conditions.
label files group rep
iEF_emptyrep1 iEF_empty_rep1_counts.txt iEF_empty rep1
iEF_emptyrep2 iEF_empty_rep2_counts.txt iEF_empty rep2
iEF_EFrep1 iEF_EF_rep1_counts.txt iEF_EF rep1
iEF_EFrep2 iEF_EF_rep2_counts.txt iEF_EF rep2
iEF_EE4rep1 iEF_EE4_rep1_counts.txt iEF_EE4 rep1
iEF_EE4rep2 iEF_EE4_rep2_counts.txt iEF_EE4 rep2

After loading the data we first have a look at the raw data table itself. The data table contains one row per annotated feature and one column per sequenced sample. Row names of this table are feature IDs (unique identifiers). The table contains raw count values representing the number of reads that map onto the features. For this project, there are 28265 features in the count data table.

Table 2: Partial view of the count data table.
iEF_emptyrep1 iEF_emptyrep2 iEF_EFrep1 iEF_EFrep2 iEF_EE4rep1 iEF_EE4rep2
A1BG 0 0 0 0 0 0
A1BG-AS1 0 0 0 0 0 0
A1CF 0 0 0 0 0 0
A2M 1 0 0 0 0 0
A2M-AS1 0 0 0 0 0 0
A2ML1 0 0 0 0 0 0

Looking at the summary of the count table provides a basic description of these raw counts (min and max values, median, etc).

Table 3: Summary of the raw counts.
Min. 1st Qu. Median Mean 3rd Qu. Max.
iEF_emptyrep1 0 0 0 0 0 413
iEF_emptyrep2 0 0 0 0 0 606
iEF_EFrep1 0 0 0 0 0 379
iEF_EFrep2 0 0 0 0 0 469
iEF_EE4rep1 0 0 0 0 0 320
iEF_EE4rep2 0 0 0 0 0 414

Figure 1 shows the total number of mapped and counted reads for each sample. We expect total read counts to be similar within conditions, they may be different across conditions. Total counts sometimes vary widely between replicates. This may happen for several reasons, including:

  • different rRNA contamination levels between samples (even between biological replicates);
  • slight differences between library concentrations, since they may be difficult to measure with high precision.

Figure 1: Number of mapped reads per sample. Colors refer to the biological condition of the sample.

Figure 2 shows the percentage of features with no read count in each sample. We expect this percentage to be similar within conditions. Features with null read counts in the 6 samples are left in the data but are not taken into account for the analysis with DESeq2. Here, 18461 features (65.31%) are in this situation (dashed line). Results for those features (fold-change and p-values) are set to NA in the results files.

Figure 2: Percentage of features with null read counts in each sample.

Figure 3 shows the distribution of read counts for each sample (on a log scale to improve readability). Again we expect replicates to have similar distributions. In addition, this figure shows if read counts are preferably low, medium or high. This depends on the organisms as well as the biological conditions under consideration.

Figure 3: Density distribution of read counts.

It may happen that one or a few features capture a high proportion of reads (up to 20% or more). This phenomenon should not influence the normalization process. The DESeq2 normalization has proved to be robust to this situation [Dillies, 2012]. Anyway, we expect these high count features to be the same across replicates. They are not necessarily the same across conditions. Figure 4 and table 4 illustrate the possible presence of such high count features in the data set. Please check to make sure the feature with high proportion of reads (usually 20% or more) is NOT rRNA. If it is, you may have contamination.

Figure 4: Percentage of reads associated with the sequence having the highest count (provided in each box on the graph) for each sample.

Table 4: Percentage of reads associated with the sequences having the highest counts.
FN1 RN7SL1 RN7SK RN7SL2
iEF_emptyrep1 3.27 2.96 1.56 1.41
iEF_emptyrep2 4.54 2.55 2.05 1.18
iEF_EFrep1 0.72 2.91 1.74 1.37
iEF_EFrep2 0.79 3.34 2.12 1.66
iEF_EE4rep1 0.90 2.54 1.60 1.29
iEF_EE4rep2 1.13 3.05 2.43 1.44

We may wish to assess the similarity between samples across conditions. A pairwise scatter plot is produced (figure 5) to show how replicates and samples from different biological conditions are similar or different (using a log scale). Moreover, as the Pearson correlation has been shown not to be relevant to measure the similarity between replicates, the SERE statistic has been proposed as a similarity index between RNA-Seq samples [5]. It measures whether the variability between samples is random Poisson variability or higher. Pairwise SERE values are printed in the lower triangle of the pairwise scatter plot. The value of the SERE statistic is:

  • 0 when samples are identical (no variability at all: this may happen in the case of a sample duplication);

  • 1 for technical replicates (technical variability follows a Poisson distribution);

  • greater than 1 for biological replicates and samples from different biological conditions (biological variability is higher than technical one, data are over-dispersed with respect to Poisson). The higher the SERE value, the lower the similarity. It is expected to be lower between biological replicates than between samples of different biological conditions. Hence, the SERE statistic can be used to detect inversions between samples.

Figure 5: Pairwise comparison of samples (not produced when more than 12 samples).

3 Variability within the experiment: data exploration

The main variability within the experiment is expected to come from biological differences between the samples. This can be checked in two ways. The first one is to perform a hierarchical clustering of the whole sample set. This is performed after a transformation of the count data which can be either a Variance Stabilizing Transformation (VST) or a regularized log transformation (rlog) [3,4].

A VST is a transformation of the data that makes them homoscedastic, meaning that the variance is then independent of the mean. It is performed in two steps: (i) a mean-variance relationship is estimated from the data with the same function that is used to normalize count data and (ii) from this relationship, a transformation of the data is performed in order to get a dataset in which the variance is independent of the mean. The homoscedasticity is a prerequisite for the use of some data analysis methods, such as hierarchical clustering or Principal Component Analysis (PCA). The regularized log transformation is based on a GLM (Generalized Linear Model) on the counts and has the same goal as a VST but is more robust in the case when the size factors vary widely.

Figure 6 shows the dendrogram obtained from VST-transformed data. An euclidean distance is computed between samples, and the dendrogram is built upon the Ward criterion. We expect this dendrogram to group replicates and separate biological conditions.

Figure 6: Sample clustering based on normalized data.

Another way of visualizing the experiment variability is to look at the first principal components of the PCA, as shown on the figure 7. On this figure, the first principal component (PC1) is expected to separate samples from the different biological conditions, meaning that the biological variability is the main source of variance in the data.

Figure 7: First two components of a Principal Component Analysis, with percentages of variance associated with each axis.

For the statistical analysis, we need to take into account the batch effect (i.e. the rep parameter). Statistical models and tests will thus be adjusted on it.
As a comparison, Figure 7b below shows the PCA plot after batch effect adjustment estimated using limma package.

Figure 7b: First two components of a Principal Component Analysis (after batch adjustment), with percentages of variance associated with each axis.

4 Normalization

Normalization aims at correcting systematic technical biases in the data, in order to make read counts comparable across samples. The normalization proposed by DESeq2 relies on the hypothesis that most features are not differentially expressed. It computes a scaling factor for each sample. Normalized read counts are obtained by dividing raw read counts by the scaling factor associated with the sample they belong to. Scaling factors around 1 mean (almost) no normalization is performed. Scaling factors lower than 1 will produce normalized counts higher than raw ones, and the other way around. Two options are available to compute scaling factors: locfunc=“median” (default) or locfunc=“shorth”. Here, the normalization was performed with locfunc=“median”.

Table 5: Normalization factors.
iEF_emptyrep1 iEF_emptyrep2 iEF_EFrep1 iEF_EFrep2 iEF_EE4rep1 iEF_EE4rep2
Size factor 0.96 0.93 1.05 1.12 1.01 1.03

The histograms (figure 8) can help to validate the choice of the normalization parameter (“median” or “shorth”). Under the hypothesis that most features are not differentially expressed, each size factor represented by a red line is expected to be close to the mode of the distribution of the counts divided by their geometric means across samples.

Figure 8: Diagnostic of the estimation of the size factors.

The figure 9 shows that the scaling factors of DESeq2 and the total count normalization factors may not perform similarly.

Figure 9: Plot of the estimated size factors and the total number of reads per sample.

Boxplots are often used as a qualitative measure of the quality of the normalization process, as they show how distributions are globally affected during this process. We expect normalization to stabilize distributions across samples. Figure 10 shows boxplots of raw (left) and normalized (right) data respectively.

Figure 10: Boxplots of raw (left) and normalized (right) read counts.

5 Differential analysis

5.1 Modelisation

DESeq2 aims at fitting one linear model per feature. For this project, the design used is counts ~ rep + group and the goal is to estimate the models’ coefficients which can be interpreted as \(\log_2(\texttt{FC})\). These coefficients will then be tested to get p-values and adjusted p-values.

5.2 Outlier detection

Model outliers are features for which at least one sample seems unrelated to the experimental or study design. For every feature and for every sample, the Cook’s distance [6] reflects how the sample matches the model. A large value of the Cook’s distance indicates an outlier count and p-values are not computed for the corresponding feature.

5.3 Dispersions estimation

The DESeq2 model assumes that the count data follow a negative binomial distribution which is a robust alternative to the Poisson law when data are over-dispersed (the variance is higher than the mean). The first step of the statistical procedure is to estimate the dispersion of the data. Its purpose is to determine the shape of the mean-variance relationship. The default is to apply a GLM (Generalized Linear Model) based method (fitType=“parametric”), which can handle complex designs but may not converge in some cases. The alternative is to use fitType=“local” as described in the original paper [3] or fitType=“mean”. The parameter used for this project is fitType=“local”. Then, DESeq2 imposes a Cox Reid-adjusted profile likelihood maximization [7 and McCarthy, 2012] and uses the maximum a posteriori (MAP) of the dispersion [Wu, 2013].

Figure 11: Dispersion estimates (left) and diagnostic of log-normality (right).

The left panel on figure 11 shows the result of the dispersion estimation step. The x- and y-axes represent the mean count value and the estimated dispersion respectively. Black dots represent empirical dispersion estimates for each feature (from the observed counts). The red dots show the mean-variance relationship function (fitted dispersion value) as estimated by the model. The blue dots are the final estimates from the maximum a posteriori and are used to perform the statistical test. Blue circles (if any) point out dispersion outliers. These are features with a very high empirical variance (computed from observed counts). These high dispersion values fall far from the model estimation. For these features, the statistical test is based on the empirical variance in order to be more conservative than with the MAP dispersion. These features will have low chance to be declared significant. The figure on the right panel allows to check the hypothesis of log-normality of the dispersions.

5.4 Statistical test for differential expression

Once the dispersion estimation and the model fitting have been done, DESeq2 can perform the statistical testing. Figure 12 shows the distributions of raw p-values computed by the statistical test for the comparison(s) done. This distribution is expected to be a mixture of a uniform distribution on \([0,1]\) and a peak around 0 corresponding to the differentially expressed features. If raw p-values doesn’t follow the expected distribution, FDR can be re-estimated using fdrtool [8].

Figure 12: Distribution(s) of raw p-values.

5.5 Independent filtering

DESeq2 can perform an independent filtering to increase the detection power of differentially expressed features at the same experiment-wide type I error. Since features with very low counts are not likely to see significant differences typically due to high dispersion, it defines a threshold on the mean of the normalized counts irrespective of the biological condition. This procedure is independent because the information about the variables in the design formula is not used [4].

Table 6 reports the thresholds used for each comparison and the number of features discarded by the independent filtering. Adjusted p-values of discarded features are then set to NA.
Table 6: Number of features discarded by the independent filtering for each comparison.
Test vs Ref BaseMean Threshold # discarded
iEF EF vs iEF empty 1.99 6167
iEF EE4 vs iEF empty 0.3 47
iEF EE4 vs iEF EF 0.3 47

5.6 Final results

A p-value adjustment is performed to take into account multiple testing and control the false positive rate to a chosen level \(\alpha\). For this analysis, a BH p-value adjustment was performed [9 and BY2001] and the level of False Discovery Rate (FDR) was set to 0.05.

Table 7: Number of up-, down- and total number of differentially expressed features for each comparison.
Test vs Ref min baseMean # down # up # total
iEF EF vs iEF empty 5.06 13 1 14
iEF EE4 vs iEF empty 16.41 5 0 5
iEF EE4 vs iEF EF 29.59 0 1 1

Table 8: View of differentially expressed features. Each table below shows top and bottom two (up- and down-regulated) significant features in each comparison. These tables can serve as a diagnostic tool to make sure significant features are indeed different in the samples compared.

Table 8.1: iEF_EF vs iEF_empty(ref)
Id geneSymbol iEF_emptyrep1 iEF_emptyrep2 iEF_EFrep1 iEF_EFrep2 norm.iEF_emptyrep1 norm.iEF_emptyrep2 norm.iEF_EFrep1 norm.iEF_EFrep2 mean.norm.iEF_empty mean.norm.iEF_EF FoldChange log2FoldChange pvalue padj dispGeneEst dispFit dispMAP dispersion betaConv maxCooks
CCND1 NA 8 9 32 35 8 10 31 31 9 31 3.437 1.781 4.64e-04 4.66e-02 0.0000 0.0626 0.0505 0.0505 TRUE NA
CCND1 NA 8 9 32 35 8 10 31 31 9 31 3.437 1.781 4.64e-04 4.66e-02 0.0000 0.0626 0.0505 0.0505 TRUE NA
BGN NA 12 16 0 0 13 17 0 0 15 0 -86.750 -6.439 8.02e-05 1.25e-02 0.0000 0.2874 0.2447 0.2447 TRUE NA
NT5E NA 8 18 0 0 8 19 0 0 14 0 -81.064 -6.341 2.72e-04 2.95e-02 1.0448 0.3386 0.4192 0.4192 TRUE NA
FN1 NA 413 606 94 111 432 648 90 99 540 94 -5.659 -2.500 1.16e-44 1.63e-41 0.0083 0.0097 0.0094 0.0094 TRUE NA
AHNAK NA 25 43 10 6 26 46 10 5 36 8 -4.911 -2.296 4.68e-05 9.42e-03 0.1793 0.0525 0.0758 0.0758 TRUE NA
Table 8.2: iEF_EE4 vs iEF_empty(ref)
Id geneSymbol iEF_emptyrep1 iEF_emptyrep2 iEF_EE4rep1 iEF_EE4rep2 norm.iEF_emptyrep1 norm.iEF_emptyrep2 norm.iEF_EE4rep1 norm.iEF_EE4rep2 mean.norm.iEF_empty mean.norm.iEF_EE4 FoldChange log2FoldChange pvalue padj dispGeneEst dispFit dispMAP dispersion betaConv maxCooks
SPARC NA 28 46 5 7 29 49 5 7 39 6 -6.654 -2.734 1.18e-06 2.23e-03 0.0000 0.0640 0.0535 0.0535 TRUE NA
TNC NA 75 160 18 42 78 171 18 41 124 30 -4.273 -2.095 1.14e-14 4.31e-11 0.0000 0.0153 0.0132 0.0132 TRUE NA
FN1 NA 413 606 114 153 432 648 113 148 540 130 -4.110 -2.039 1.47e-32 1.12e-28 0.0083 0.0097 0.0094 0.0094 TRUE NA
COL1A1 NA 48 70 24 23 50 75 24 22 62 23 -2.691 -1.428 1.56e-05 2.37e-02 0.0207 0.0230 0.0227 0.0227 TRUE NA
Table 8.3: iEF_EE4 vs iEF_EF(ref)
Id geneSymbol iEF_EFrep1 iEF_EFrep2 iEF_EE4rep1 iEF_EE4rep2 norm.iEF_EFrep1 norm.iEF_EFrep2 norm.iEF_EE4rep1 norm.iEF_EE4rep2 mean.norm.iEF_EF mean.norm.iEF_EE4 FoldChange log2FoldChange pvalue padj dispGeneEst dispFit dispMAP dispersion betaConv maxCooks
COL1A1 NA 3 4 24 23 3 4 24 22 4 23 7.188 2.846 5.1e-06 3.87e-02 0.0207 0.023 0.0227 0.0227 TRUE NA
COL1A1 NA 3 4 24 23 3 4 24 22 4 23 7.188 2.846 5.1e-06 3.87e-02 0.0207 0.023 0.0227 0.0227 TRUE NA

Figure 13 represents the MA-plot of the data for the comparisons done, where differentially expressed features are highlighted in red. A MA-plot represents the log ratio of differential expression as a function of the mean intensity for each feature. Triangles correspond to features having a too low/high \(\log_2(\text{FC})\) to be displayed on the plot.

Figure 13: MA-plot(s) of each comparison. Red dots represent significantly differentially expressed features.

Figure 14 shows the volcano plots for the comparisons performed and differentially expressed features are still highlighted in red. A volcano plot represents the log of the adjusted P value as a function of the log ratio of differential expression.

Figure 14: Volcano plot(s) of each comparison. Red dots represent significantly differentially expressed features.

Heatmaps showing the rlog normalized counts of up-/down-regulated genes in each sample can be found in figures/diffPlot.pdf. This plot again can serve as a diagnostic tool to make sure the normalized counts in all of the replicates are higher/lower compared to control for up-/down-regulated genes, respectively.

Full results as well as lists of differentially expressed features are provided in the following text files which can be easily read in a spreadsheet. For each comparison:

  • TestVsRef.complete.txt contains results for all the features;
  • TestVsRef.up.txt contains results for significantly up-regulated features. Features are ordered from the most significant adjusted p-value to the less significant one;
  • TestVsRef.down.txt contains results for significantly down-regulated features. Features are ordered from the most significant adjusted p-value to the less significant one.

These files contain the following columns:

  • Id: unique feature identifier;
  • sampleName: raw counts per sample;
  • norm.sampleName: rounded normalized counts per sample;
  • baseMean: base mean over all samples;
  • iEF_empty, iEF_EF and iEF_EE4: means (rounded) of normalized counts of the biological conditions;
  • FoldChange: fold change of expression, calculated as \(2^{\log_2(\text{FC})}\);
  • log2FoldChange: \(\log_2(\text{FC})\) as estimated by the GLM model. It reflects the differential expression between Test and Ref and can be interpreted as \(\log_2(\frac{\text{Test}}{\text{Ref}})\). If this value is:
    • around 0: the feature expression is similar in both conditions;
    • positive: the feature is up-regulated (\(\text{Test} > \text{Ref}\));
    • negative: the feature is down-regulated (\(\text{Test} < \text{Ref}\));
  • stat: Wald statistic for the coefficient tested;
  • pvalue: raw p-value from the statistical test;
  • padj: adjusted p-value on which the cut-off \(\alpha\) is applied;
  • dispGeneEst: dispersion parameter estimated from feature counts (i.e. black dots on figure 11);
  • dispFit: dispersion parameter estimated from the model (i.e. red dots on figure 11);
  • dispMAP: dispersion parameter estimated from the Maximum A Posteriori model;
  • dispersion: final dispersion parameter used to perform the test (i.e. blue dots and circles on figure 11);
  • betaConv: convergence of the coefficients of the model (TRUE or FALSE);
  • maxCooks: maximum Cook’s distance of the feature.

6 R session information and parameters

The versions of the R software and Bioconductor packages used for this analysis are listed below. It is important to save them if one wants to re-perform the analysis in the same conditions.

  • R version 4.0.3 (2020-10-10), x86_64-conda-linux-gnu
  • Locale: LC_CTYPE=en_US.UTF-8, LC_NUMERIC=C, LC_TIME=en_US.UTF-8, LC_COLLATE=en_US.UTF-8, LC_MONETARY=en_US.UTF-8, LC_MESSAGES=en_US.UTF-8, LC_PAPER=en_US.UTF-8, LC_NAME=C, LC_ADDRESS=C, LC_TELEPHONE=C, LC_MEASUREMENT=en_US.UTF-8, LC_IDENTIFICATION=C
  • Running under: Rocky Linux 9.0 (Blue Onyx)
  • Matrix products: default
  • BLAS/LAPACK: /opt/miniforge3/envs/sartools_env/lib/libopenblasp-r0.3.28.so
  • Base packages: base, datasets, graphics, grDevices, grid, methods, parallel, stats, stats4, utils
  • Other packages: AnnotationDbi 1.52.0, AnnotationFilter 1.14.0, Biobase 2.50.0, BiocGenerics 0.36.1, DESeq2 1.30.1, edgeR 3.32.1, EnsDb.Hsapiens.v86 2.99.0, ensembldb 2.14.1, fdrtool 1.2.18, GenomeInfoDb 1.26.7, GenomicFeatures 1.42.3, GenomicRanges 1.42.0, ggplot2 3.5.1, gridExtra 2.3, IRanges 2.24.1, kableExtra 1.4.0, limma 3.46.0, MatrixGenerics 1.2.1, matrixStats 1.4.1, pheatmap 1.0.12, Polychrome 1.5.1, RColorBrewer 1.1-3, S4Vectors 0.28.1, SARTools 1.7.3, SummarizedExperiment 1.20.0, tibble 3.2.1
  • Loaded via a namespace (and not attached): annotate 1.68.0, askpass 1.2.1, BiocFileCache 1.14.0, BiocParallel 1.24.1, biomaRt 2.46.3, Biostrings 2.58.0, bit 4.5.0, bit64 4.5.2, bitops 1.0-9, blob 1.2.4, bslib 0.8.0, cachem 1.1.0, cli 3.6.3, colorspace 2.1-1, compiler 4.0.3, crayon 1.5.3, curl 5.2.3, DBI 1.2.3, dbplyr 2.5.0, DelayedArray 0.16.3, digest 0.6.37, dplyr 1.1.4, evaluate 1.0.1, fansi 1.0.6, farver 2.1.2, fastmap 1.2.0, genefilter 1.72.1, geneplotter 1.68.0, generics 0.1.3, GenomeInfoDbData 1.2.4, GenomicAlignments 1.26.0, GGally 2.0.0, ggdendro 0.2.0, ggrepel 0.9.6, glue 1.8.0, gtable 0.3.6, highr 0.11, hms 1.1.3, htmltools 0.5.8.1, httr 1.4.7, jquerylib 0.1.4, jsonlite 1.8.9, knitr 1.48, labeling 0.4.3, lattice 0.22-6, lazyeval 0.2.2, lifecycle 1.0.4, locfit 1.5-9.4, magrittr 2.0.3, MASS 7.3-58.1, Matrix 1.4-1, memoise 2.0.1, munsell 0.5.1, openssl 2.2.2, pillar 1.9.0, pkgconfig 2.0.3, plyr 1.8.9, prettyunits 1.2.0, progress 1.2.3, ProtGenerics 1.22.0, R6 2.5.1, rappdirs 0.3.3, Rcpp 1.0.13, RCurl 1.98-1.16, reshape 0.8.9, rlang 1.1.4, rmarkdown 2.28, Rsamtools 2.6.0, RSQLite 2.3.7, rstudioapi 0.17.1, rtracklayer 1.50.0, sass 0.4.9, scales 1.3.0, scatterplot3d 0.3-44, splines 4.0.3, stringi 1.8.4, stringr 1.5.1, survival 3.7-0, svglite 2.1.3, systemfonts 1.0.4, tidyselect 1.2.1, tools 4.0.3, utf8 1.2.4, vctrs 0.6.5, viridisLite 0.4.0, withr 3.0.2, xfun 0.48, XML 3.99-0.17, xml2 1.3.6, xtable 1.8-4, XVector 0.30.0, yaml 2.3.10, zlibbioc 1.36.0

Parameter values used for this analysis are:

  • workDir: /mnt/outputs/diff_analysis_rslt
  • projectName: RNA-seq_differential_analysis
  • author: NA
  • targetFile: target.txt
  • rawDir: ../STAR_2pass/Pass2
  • featuresToRemove: alignment_not_unique, ambiguous, no_feature, not_aligned, too_low_aQual
  • varInt: group
  • condRef: iEF_empty, iEF_empty, iEF_empty, iEF_empty
  • batch: rep
  • fitType: local
  • cooksCutoff: TRUE
  • independentFiltering: TRUE
  • alpha: 0.05
  • pAdjustMethod: BH
  • typeTrans: VST
  • locfunc: median
  • colors: #ADD8E6, #FFA500, #C71585

Bibliography

1.
R Core Team. R: A language and environment for statistical computing. Vienna, Austria : R Foundation for Statistical Computing, 2017 :
2.
Gentleman RC, Carey VJ, Bates DM, et al. Bioconductor: Open software development for computational biology and bioinformatics. Genome Biology 2004 ; 5 : R80.
3.
Anders S, Huber W. Differential expression analysis for sequence count data. Genome Biology 2010 ; 11 : R106.
4.
Love MI, Huber W, Anders S. Moderated estimation of fold change and dispersion for RNA-seq data with DESeq2. Genome Biology 2014 ; 15 : 550.
5.
Schulze SK, Kanwar R, Gölzenleuchter M, et al. SERE: Single-parameter quality control and sample comparison for RNA-seq. BMC Genomics 2012 ; 13 : 524.
6.
Cook RD. Detection of influential observation in linear regression. Technometrics 1977 ; 19 : 15–18.
7.
Cox DR, Reid N. Parameter orthogonality and approximate conditional inference. Journal of the Royal Statistical Society. Series B (Methodological) 1987 ; 49 : 1–39.
8.
9.
Benjamini Y, Hochberg Y. Controlling the false discovery rate: A practical and powerful approach to multiple testing. Journal of the Royal Statistical Society. Series B (Methodological) 1995 ; 57 : 289–300.