load("Report2.Rdata")

1 Summary Table

Sequence files below are set as inputs of the pipeline.

Case files:

Control files:

Summerized infomation on sequence files has been shown showed below. You can see details in later sections

Item Case Control Reference
Sequence Files Type paired end (PE) paired end (PE) SE / PE
Original total reads 30.3M 28.8M
– Reads after adapter removing (ratio) 30.3M (100.00%) 28.8M (100.00%) >99%
– – Total mapped reads (ratio of original reads) 29.6M (97.65%) 28.0M (97.46%) >95%
– – – Unique locations mapped uniquely by reads 15.6M 13.0M
– – – Uniquely mappable reads 20.8M 18.1M
– – – Non-Redundant Fraction (NRF) 0.75 0.72 >0.7
– – – Locations with only 1 reads mapping uniquely 13.6M 11.6M
– – – Locations with only 2 reads mapping uniquely 1.5M 1.0M
– – – PCR Bottlenecking Coefficients 1 (PBC1) 0.87 0.89 >0.7
– – – PCR Bottlenecking Coefficients 2 (PBC2) 8.85 11.67 >3
– – – Non-mitochondrial reads (ratio) 21.0M (70.99%) 18.2M (64.94%) >70%
– – – – Unique mapped reads (ratio) 16.5M (55.64%) 13.2M (46.95%)
– – – – – Duplicate removed reads (final for use) 14.6M (49.39%) 12.1M (43.07%) >25M
– – – – – – Nucleosome free reads (<100bp) 5.7M (38.92%) 4.3M (36.02%)
– – – – – – – Total peaks 116102 114569
– – – – – – – Peaks overlaped with union DHS ratio 83.1% 86.4%
– – – – – – – Peaks overlaped with blacklist ratio 0.1% 0.1%
– – – – – – Fraction of reads in peaks (FRiP) 56.9% 67.8%

A nucleosome free region (NFR) must be present. A mononucleosome peak must be present in the fragment length distribution. These are reads that span a single nucleosome, so they are longer than 147 bp but shorter than 147*2 bp. Good ATAC-seq datasets have reads that span nucleosomes (which allows for calling nucleosome positions in addition to open regions of chromatin).

  • Case

  • Control

2 Sequence Statistics

2.1 FastQC

Quality control for the sequence data

Click to Visit Report for case

Click to Visit Report for control

2.2 Remove adapter

The adapter sequence are shown below. For paired end reads, if adapters were not setted, the adapters below are identified by AdapterRemoval.

  • Adapter for case
Item Value
adapter1 TTGTCATTTTTAAATTATATAAAATTAAAATTAAAATAAT
adapter2 CTGTCTCTTTTAAATTATATAAAATTAAAATTAAAATAAT
  • Adapter for control
Item Value
adapter1 TTGTCATTTTAAAATTATATAAAATTAAATTTATAATAAT
adapter2 TTGTCTTTTTTAAATTATATAAATTTAAATTTATAATAAT

The statistic of adapter removing are show below.

Items Case Control
Total number of read pairs 30308983 28750759
Number of unaligned read pairs 13491924 12113590
Number of well aligned read pairs 16817059 16637169
Number of discarded mate 1 reads 0 2
Number of singleton mate 1 reads 0 0
Number of discarded mate 2 reads 0 2
Number of singleton mate 2 reads 0 0
Number of reads with adapters[1] 225206 257949
Number of retained reads 60617966 57501514
Number of retained nucleotides 3002145413 2836808896
Average length of retained reads 49.5257 49.3345

For detail, you can visit Website of AdapterRemoval on Github.

3 Reads Alignment Statistics

3.1 Bowtie2 alignment log

  • For case
## [1] "30308983 reads; of these:"                                
## [2] "  30308983 (100.00%) were paired; of these:"              
## [3] "    713067 (2.35%) aligned concordantly 0 times"          
## [4] "    20792835 (68.60%) aligned concordantly exactly 1 time"
## [5] "    8803081 (29.04%) aligned concordantly >1 times"       
## [6] "97.65% overall alignment rate"
  • For control
## [1] "28750757 reads; of these:"                                
## [2] "  28750757 (100.00%) were paired; of these:"              
## [3] "    728979 (2.54%) aligned concordantly 0 times"          
## [4] "    18060564 (62.82%) aligned concordantly exactly 1 time"
## [5] "    9961214 (34.65%) aligned concordantly >1 times"       
## [6] "97.46% overall alignment rate"

3.2 Library complexity

Items Case Control Reference
Total mapped reads (ratio of original reads) 29.6M (29595916) 28.0M (28021778)
Unique locations mapped uniquely by reads 15.6M (15566819) 13.0M (12989757)
Uniquely mappable reads 20.8M (20786314) 18.1M (18053298)
Non-Redundant Fraction (NRF) 0.75 0.72 >0.7
Locations with only 1 reads mapping uniquely 13.6M (13576805) 11.6M (11597756)
Locations with only 2 reads mapping uniquely 1.5M (1533927) 1.0M (993861)
PCR Bottlenecking Coefficients 1 (PBC1) 0.87 0.89 >0.7
PCR Bottlenecking Coefficients 2 (PBC2) 8.85 11.67 >3
The annotation you can see in section 1.

3.3 Filtering statistics

Item Case Control Reference
Original total reads 30.3M (30308983) 28.8M (28750759)
Reads after adapter removing (ratio) 30.3M (100.00%, 30308983 / 30308983) 28.8M (100.00%, 28750757 / 28750759) >99%
Total mapped reads (ratio of original reads) 29.6M (97.65%, 29595916 / 30308983) 28.0M (97.46%, 28021778 / 28750759) >95%
– Non-mitochondrial reads (ratio) 21.0M (70.99%, 21009162 / 29595916) 18.2M (64.94%, 18198637 / 28021778) >70%
– – Unique mapped reads (ratio) 16.5M (55.64%, 16468586 / 29595916) 13.2M (46.95%, 13155966 / 28021778) >60%
– – – Duplicate removed reads (ratio final for use) 14.6M (49.39%, 14618814 / 29595916) 12.1M (43.07%, 12069484 / 28021778) >25M,>60%

3.4 Fragment size distribution

library(ggplot2)
library(stats)
load("Report2.Rdata")

getFsdG1G2 <- function(readsCounts){
       
    
    
    strength<-Mod(fft(readsCounts$counts))/length(readsCounts$counts)
    periodx<-length(readsCounts$counts)/(1:(length(readsCounts$counts)-1))
    strength<-strength[2:length(strength)]
    
    rs1<-as.data.frame(cbind(periodx[periodx<20&periodx>2],strength[periodx<20&periodx>2],0))
    rs2<-as.data.frame(cbind(periodx[periodx<400&periodx>2],strength[periodx<400&periodx>2],1))
    rs<-rbind(rs1,rs2)
    colnames(rs)<-c("period","strength","check")
    
    g1<-ggplot(rs[rs["check"]==0,]) + geom_vline(xintercept = 10.4, linetype=2)+ geom_line(aes(x=period,y=strength),color="Red")+ theme_bw() + theme(panel.grid =element_blank()) + annotate("text", x = 10.4, y = max(rs[rs["check"]==0,2]), label = "10.4bp") +xlab("period") + ylab("strength")+ labs(title = "the Pitch of the DNA Helix") + theme(plot.title = element_text(hjust = 0.5))
    
    g2<-ggplot(rs[rs["check"]==1,]) + geom_vline(xintercept = 186, linetype=2)+ geom_line(aes(x=period,y=strength),color="Red")+ theme_bw() + theme(panel.grid =element_blank()) + annotate("text", x = 186, y = max(rs[rs["check"]==1,2]), label = "186bp") +xlab("period") + ylab("strength")+ labs(title = "Nucleosome") + theme(plot.title = element_text(hjust = 0.5))
    return(list(g1,g2))
}
readsCounts1<-getReportVal(caselist$atacProcs$fragLenDistr,"readsCounts")
readsCounts2<-getReportVal(ctrllist$atacProcs$fragLenDistr,"readsCounts")
ggplot(readsCounts1[1:1000,], aes(length,counts))+geom_path(color="Red")+xlab("Fragment length (bp)")+ylab("Read counts") + theme_bw() + theme(panel.grid =element_blank()) + labs(title = "Fragment Length Distribution") + theme(plot.title = element_text(hjust = 0.5))

ggplot(readsCounts2[1:1000,], aes(length,counts))+geom_path(color="Red")+xlab("Fragment length (bp)")+ylab("Read counts") + theme_bw() + theme(panel.grid =element_blank()) + labs(title = "Fragment Length Distribution") + theme(plot.title = element_text(hjust = 0.5))

g112<-getFsdG1G2(readsCounts1)
g212<-getFsdG1G2(readsCounts2)

library(gridExtra)
grid.arrange(g112[[1]], g212[[1]],ncol=2)

grid.arrange(g112[[2]], g212[[2]],ncol=2)

3.5 TSS enrichment

The nucleosome free reads (<100bp) and monnucleosome span reads (180~247bp) enrichment around transcription starting site (TSS) are shown below.

library(ggplot2)
library(gridExtra)
load("Report2.Rdata")
df<-getReportVal(caselist$atacProcs$tssqc100,"tss")
g11<-ggplot(df,aes(pos,counts))+geom_line()+ geom_vline(xintercept = 0, linetype=2)+xlab("upstream<-TSS->downstream")+ylab("reads count")+theme_bw() + theme(panel.grid =element_blank()) + labs(title = "Nucleosome Free Reads") + theme(plot.title = element_text(hjust = 0.5))
df<-getReportVal(caselist$atacProcs$tssqc180_247,"tss")
g12<-ggplot(df,aes(pos,counts))+geom_line()+ geom_vline(xintercept = 0, linetype=2)+xlab("upstream<-TSS->downstream")+ylab("reads count")+theme_bw() + theme(panel.grid =element_blank()) + labs(title = "Monnucleosome Span Reads") + theme(plot.title = element_text(hjust = 0.5))

df<-getReportVal(caselist$atacProcs$tssqc100,"tss")
g21<-ggplot(df,aes(pos,counts))+geom_line()+ geom_vline(xintercept = 0, linetype=2)+xlab("upstream<-TSS->downstream")+ylab("reads count")+theme_bw() + theme(panel.grid =element_blank()) + labs(title = "Nucleosome Free Reads") + theme(plot.title = element_text(hjust = 0.5))
df<-getReportVal(caselist$atacProcs$tssqc180_247,"tss")
g22<-ggplot(df,aes(pos,counts))+geom_line()+ geom_vline(xintercept = 0, linetype=2)+xlab("upstream<-TSS->downstream")+ylab("reads count")+theme_bw() + theme(panel.grid =element_blank()) + labs(title = "Monnucleosome Span Reads") + theme(plot.title = element_text(hjust = 0.5))
grid.arrange(g11, g21, ncol=2)

grid.arrange(g12, g22, ncol=2)

4 Peak Statistics

4.1 Blacklist ratio

Items Case Control
Total peaks 116102 114569
Blacklist regions 73 63
Ratio 0.00 0.00

4.2 DHS ratio

Items Case Control
Total peaks 116102 114569
DHS regions 96501 99028
Ratio 0.83 0.86

4.3 Fraction of reads in peaks (FRiP)

Items Case Control
The number of reads in peak 3234957 2945477
The number of total reads 5689342 4347435
The number of total peaks 116102 114569
FRiP 0.57 0.68

4.4 Peak annotation

  • For case

  • For control

5 Case Control Peak Compare

The following is the peak comparation result for case and control.

The total peaks in case are 116102, specific peaks in case are 56899.

The total peaks in control are 114569, specific peaks in control are 56836.

The overlap peaks are merged to 55685 peaks.

6 GO Analysis

Gene ontology analysis for all genes around specific peak regions of case and control.

6.1 Significant GO terms of genes associated with case specific peaks

ID Description GeneRatio pvalue qvalue
GO:0051345 positive regulation of hydrolase activity 403/13414 4.88e-38 9.87e-35
GO:0044057 regulation of system process 412/13414 2.26e-35 2.28e-32
GO:0045666 positive regulation of neuron differentiation 350/13414 4.53e-34 3.06e-31
GO:0061564 axon development 383/13414 9.44e-34 4.78e-31
GO:0023061 signal release 372/13414 2.62e-32 1.06e-29
GO:0031346 positive regulation of cell projection organization 348/13414 1.5e-31 5.06e-29
GO:0001501 skeletal system development 395/13414 1.14e-30 3.29e-28
GO:0007409 axonogenesis 356/13414 1.92e-30 4.87e-28
GO:0043410 positive regulation of MAPK cascade 384/13414 2.16e-30 4.87e-28
GO:0030900 forebrain development 310/13414 3.58e-30 7.25e-28
GO:0022604 regulation of cell morphogenesis 376/13414 4.11e-29 7.56e-27
GO:0048568 embryonic organ development 388/13414 7.59e-29 1.28e-26
GO:0042326 negative regulation of phosphorylation 367/13414 8.8e-29 1.37e-26
GO:0001525 angiogenesis 362/13414 1.01e-28 1.46e-26
GO:0007264 small GTPase mediated signal transduction 341/13414 5.63e-28 7.6e-26

Click to Visit Case Differential Go Analysis file

6.2 Significant GO terms of genes associated with control specific peaks

ID Description GeneRatio pvalue qvalue
GO:0044089 positive regulation of cellular component biogenesis 378/12269 9.79e-32 2.41e-28
GO:0031346 positive regulation of cell projection organization 328/12269 6.5e-30 7.99e-27
GO:0045666 positive regulation of neuron differentiation 325/12269 2.31e-29 1.49e-26
GO:0022604 regulation of cell morphogenesis 357/12269 2.43e-29 1.49e-26
GO:0007264 small GTPase mediated signal transduction 326/12269 3.41e-29 1.68e-26
GO:0061564 axon development 352/12269 1.62e-27 6.64e-25
GO:1905114 cell surface receptor signaling pathway involved in cell-cell signaling 363/12269 3.09e-27 1.09e-24
GO:0010976 positive regulation of neuron projection development 258/12269 2.04e-26 6.28e-24
GO:0035239 tube morphogenesis 315/12269 3.31e-26 9.04e-24
GO:0030900 forebrain development 288/12269 4.07e-26 1e-23
GO:0033674 positive regulation of kinase activity 344/12269 2.95e-25 6.6e-23
GO:0048568 embryonic organ development 358/12269 2.18e-24 4.48e-22
GO:0007409 axonogenesis 326/12269 2.44e-24 4.61e-22
GO:0032870 cellular response to hormone stimulus 350/12269 6.11e-24 1.07e-21
GO:0045860 positive regulation of protein kinase activity 317/12269 1.95e-23 2.94e-21

Click to Visit Ctrl Differential Go Analysis file

7 Motif Enrichment Analysis

This function takes case and control specific peaks as foreground respectively, overlap peaks between case and control as background.

7.1 Significant motifs of case specific peaks

motif motif length p_value
CTCF 19 6.9e-63

7.2 Significant motifs of control specific peaks

motif motif length p_value
CTCF 19 3.01e-44

8 Genomic Footprint

The following is the footprint for motif occurance of case&control peaks.

For all footprint of case sample, The absolute path is /home/zwei/esATAC_test/mm10CC/esATAC_pipeline/intermediate_results/Footprint_Case_data/FP_PDF_Case_data.

For all footprint of control sample, The absolute path is /home/zwei/esATAC_test/mm10CC/esATAC_pipeline/intermediate_results/Footprint_Control_data/FP_PDF_Control_data.

The following is the footprint for motif occurance of case&control specific peaks.

For all footprint of case specific, The absolute path is /home/zwei/esATAC_test/mm10CC/esATAC_pipeline/intermediate_results/Footprint_Case_specific/FP_PDF_Case_specific.

For all footprint of control specific, The absolute path is /home/zwei/esATAC_test/mm10CC/esATAC_pipeline/intermediate_results/Footprint_Control_specific/FP_PDF_Control_specific.

9 Annotation of Items in Table

For single end sequencing data, esATAC will counts reads number.

For paired end sequencing data, esATAC will counts read pairs or fragment number.

  • Sequence files type is the type of sequencing data: single end data and paired end data. If paired end reads are stored in one file interleavedly rather than two files, “it is call”interleaved.

  • Original total reads is the sample’s raw total reads (pairs) number.

  • Reads after adapter removing (ratio) is the reads (pairs) number after adapter removing and the percentage of retained reads in original total reads. The larger value shows the better quality.

  • Total mapped reads (ratio)
    is the reads (pairs) number mapped to reference genome and the percentage of mapped reads in original total reads (alignment rate). ENCODE recommend that the alignment rate, or percentage of mapped reads, should be greater than 95%, though values >80% may be acceptable.

  • Unique locations mapped uniquely
    is the number of distinct uniquely mapping reads (i.e. after removing duplicates).

  • Non-Redundant Fraction (NRF) is the value of: Unique locations mapped uniquely (the number of positions in the genome that uniquely mappable reads map to) / the total number of uniquely mappable reads.

\(NRF\) value range Complexity
\(NRF<0.7\) Concerning
\(0.7\le NRF \le 0.9\) Acceptable
\(NRF>0.7\) Ideal
  • Locations with only 1 reads mapping uniquely is the number of genomic locations where exactly one read maps uniquely.

  • Locations with only 2 reads mapping uniquely is the number of genomic locations where two reads map uniquely.

  • PCR Bottlenecking Coefficients 1 (PBC1) is the value of: Locations with only 1 reads mapping uniquely / Unique locations mapped uniquely. ENCODE recommend that PBC1>0.9 for ATAC-seq data.

\(PBC1\) value range Bottlenecking level
\(PBC1<0.7\) Severe
\(0.7\le PBC1 \le 0.9\) Moderate
\(PBC1>0.7\) None
  • PCR Bottlenecking Coefficients 2 (PBC2) is the value of: Locations with only 1 reads mapping uniquely / Locations with only 2 reads mapping uniquely. ENCODE recommend that PBC2>3 for ATAC-seq data.
\(PBC2\) value range Bottlenecking level
\(PBC2<1\) Severe
\(1\le PBC2 \le 3\) Moderate
\(PBC2>3\) None
  • Non-mitochondrial reads (ratio) is the percentage of non-mitochondrial read in total mapped reads. (mitochondrial reads removed).The larger value shows the better quality.

  • Unique mapped reads (ratio) is the percentage of non-mitochondrial unique mapped read in total mapped reads (multi-mapped reads removed). The larger value shows the better quality.

  • Duplicate removed reads (final for use) is the percentage of non-mitochondrial, unique mapped and non-duplicate reads in total mapped reads (duplicate reads removed). These reads are ready to use and storage at final. The larger value shows the better quality.

  • Nucleosome free reads (<100bp) is the nucleosome free reads reads shorter than 100bp for peak calling
  • Total peaks is the number of peak called by using nucleosome free reads (<100bp)
  • Peaks overlaped with union DHS (ratio) is the percentage of called peak overlaped with blacklist. The larger value shows the better quality.

  • Peaks overlaped with blacklist (ratio) is the percentage of called peak overlaped with blacklist. The smaller value shows the better quality.

  • Fraction of reads in peaks (FRiP) is the fraction of nucleosome free reads (<100bp) in peak. The larger value shows the better quality.

10 Session Info

sessionInfo()
## R version 3.4.3 (2017-11-30)
## Platform: x86_64-pc-linux-gnu (64-bit)
## Running under: Red Hat Enterprise Linux Server 7.2 (Maipo)
## 
## Matrix products: default
## BLAS: /home/software/R/R-3.4.3/lib64/R/lib/libRblas.so
## LAPACK: /home/software/R/R-3.4.3/lib64/R/lib/libRlapack.so
## 
## locale:
##  [1] LC_CTYPE=en_US.utf8          LC_NUMERIC=C                
##  [3] LC_TIME=en_US.utf8           LC_COLLATE=en_US.utf8       
##  [5] LC_MONETARY=en_US.utf8       LC_MESSAGES=en_US.utf8      
##  [7] LC_PAPER=en_US.utf8          LC_NAME=en_US.utf8          
##  [9] LC_ADDRESS=en_US.utf8        LC_TELEPHONE=en_US.utf8     
## [11] LC_MEASUREMENT=en_US.utf8    LC_IDENTIFICATION=en_US.utf8
## 
## attached base packages:
##  [1] grid      stats4    parallel  methods   stats     graphics  grDevices
##  [8] utils     datasets  base     
## 
## other attached packages:
##  [1] VennDiagram_1.6.18                      
##  [2] futile.logger_1.4.3                     
##  [3] ChIPseeker_1.14.1                       
##  [4] gridExtra_2.3                           
##  [5] ggplot2_2.2.1                           
##  [6] TxDb.Mmusculus.UCSC.mm10.knownGene_3.4.0
##  [7] GenomicFeatures_1.30.3                  
##  [8] org.Mm.eg.db_3.5.0                      
##  [9] AnnotationDbi_1.40.0                    
## [10] BSgenome.Mmusculus.UCSC.mm10_1.4.0      
## [11] BSgenome_1.46.0                         
## [12] rtracklayer_1.38.3                      
## [13] esATAC_1.0.17                           
## [14] ShortRead_1.36.0                        
## [15] GenomicAlignments_1.14.1                
## [16] SummarizedExperiment_1.8.1              
## [17] DelayedArray_0.4.1                      
## [18] matrixStats_0.53.1                      
## [19] Biobase_2.38.0                          
## [20] BiocParallel_1.12.0                     
## [21] Rsamtools_1.30.0                        
## [22] Biostrings_2.46.0                       
## [23] XVector_0.18.0                          
## [24] GenomicRanges_1.30.1                    
## [25] GenomeInfoDb_1.14.0                     
## [26] IRanges_2.12.0                          
## [27] S4Vectors_0.16.0                        
## [28] BiocGenerics_0.24.0                     
## 
## loaded via a namespace (and not attached):
##   [1] backports_1.1.2                        
##   [2] fastmatch_1.1-0                        
##   [3] corrplot_0.84                          
##   [4] VGAM_1.0-5                             
##   [5] plyr_1.8.4                             
##   [6] igraph_1.1.2                           
##   [7] lazyeval_0.2.1                         
##   [8] splines_3.4.3                          
##   [9] gridBase_0.4-7                         
##  [10] TFBSTools_1.16.0                       
##  [11] digest_0.6.15                          
##  [12] BiocInstaller_1.28.0                   
##  [13] htmltools_0.3.6                        
##  [14] GOSemSim_2.4.1                         
##  [15] viridis_0.5.0                          
##  [16] GO.db_3.5.0                            
##  [17] gdata_2.18.0                           
##  [18] magrittr_1.5                           
##  [19] memoise_1.1.0                          
##  [20] JASPAR2016_1.6.0                       
##  [21] readr_1.1.1                            
##  [22] annotate_1.56.1                        
##  [23] R.utils_2.6.0                          
##  [24] prettyunits_1.0.2                      
##  [25] colorspace_1.3-2                       
##  [26] blob_1.1.0                             
##  [27] dplyr_0.7.4                            
##  [28] RCurl_1.95-4.10                        
##  [29] jsonlite_1.5                           
##  [30] TxDb.Hsapiens.UCSC.hg19.knownGene_3.2.2
##  [31] bindr_0.1                              
##  [32] TFMPvalue_0.0.6                        
##  [33] brew_1.0-6                             
##  [34] glue_1.2.0                             
##  [35] gtable_0.2.0                           
##  [36] zlibbioc_1.24.0                        
##  [37] UpSetR_1.3.3                           
##  [38] Rook_1.1-1                             
##  [39] scales_0.5.0                           
##  [40] DOSE_3.4.0                             
##  [41] futile.options_1.0.0                   
##  [42] DBI_0.7                                
##  [43] Rcpp_0.12.15                           
##  [44] plotrix_3.7                            
##  [45] viridisLite_0.3.0                      
##  [46] xtable_1.8-2                           
##  [47] progress_1.1.2                         
##  [48] bit_1.1-12                             
##  [49] htmlwidgets_1.0                        
##  [50] httr_1.3.1                             
##  [51] DiagrammeR_0.9.2                       
##  [52] fgsea_1.4.1                            
##  [53] gplots_3.0.1                           
##  [54] RColorBrewer_1.1-2                     
##  [55] pkgconfig_2.0.1                        
##  [56] XML_3.98-1.9                           
##  [57] rJava_0.9-9                            
##  [58] R.methodsS3_1.7.1                      
##  [59] labeling_0.3                           
##  [60] rlang_0.1.6                            
##  [61] reshape2_1.4.3                         
##  [62] munsell_0.4.3                          
##  [63] tools_3.4.3                            
##  [64] visNetwork_2.0.3                       
##  [65] downloader_0.4                         
##  [66] DirichletMultinomial_1.20.0            
##  [67] RSQLite_2.0                            
##  [68] evaluate_0.10.1                        
##  [69] stringr_1.2.0                          
##  [70] yaml_2.1.16                            
##  [71] knitr_1.19                             
##  [72] bit64_0.9-7                            
##  [73] caTools_1.17.1                         
##  [74] purrr_0.2.4                            
##  [75] KEGGREST_1.18.1                        
##  [76] bindrcpp_0.2                           
##  [77] R.oo_1.21.0                            
##  [78] poweRlaw_0.70.1                        
##  [79] DO.db_2.9                              
##  [80] biomaRt_2.34.2                         
##  [81] compiler_3.4.3                         
##  [82] rstudioapi_0.7                         
##  [83] rgexf_0.15.3                           
##  [84] png_0.1-7                              
##  [85] Rbowtie2_1.0.1                         
##  [86] tibble_1.4.2                           
##  [87] stringi_1.1.6                          
##  [88] highr_0.6                              
##  [89] lattice_0.20-35                        
##  [90] CNEr_1.14.0                            
##  [91] Matrix_1.2-12                          
##  [92] pillar_1.1.0                           
##  [93] data.table_1.10.4-3                    
##  [94] bitops_1.0-6                           
##  [95] qvalue_2.10.0                          
##  [96] R6_2.2.2                               
##  [97] latticeExtra_0.6-28                    
##  [98] hwriter_1.3.2                          
##  [99] RMySQL_0.10.13                         
## [100] KernSmooth_2.23-15                     
## [101] lambda.r_1.2                           
## [102] boot_1.3-20                            
## [103] gtools_3.5.0                           
## [104] assertthat_0.2.0                       
## [105] seqLogo_1.44.0                         
## [106] rprojroot_1.3-2                        
## [107] GenomeInfoDbData_1.0.0                 
## [108] hms_0.4.1                              
## [109] influenceR_0.1.0                       
## [110] clusterProfiler_3.6.0                  
## [111] tidyr_0.8.0                            
## [112] rmarkdown_1.8                          
## [113] rvcheck_0.0.9