Skip to content

Commit

Permalink
version 1.1.0 release
Browse files Browse the repository at this point in the history
Major update. For changes and additions, please consult the README file.
  • Loading branch information
bvieth committed Mar 29, 2018
1 parent 0e31927 commit cc52447
Show file tree
Hide file tree
Showing 77 changed files with 6,132 additions and 1,776 deletions.
55 changes: 37 additions & 18 deletions DESCRIPTION
@@ -1,28 +1,47 @@
Package: powsimR
Type: Package
Title: Power Simulations for RNA-sequencing
Description: This package provides simulation based methods for evaluating the statistical power
to detect differential expression in bulk and single cell RNA-seq experiments.
Version: 1.0.0.907
Imports: methods, stats, matrixStats, moments, minpack.lm, glmnet, cluster, mclust, MASS,
S4Vectors, gtools, DEDS, AnnotationDbi, Biobase, BiocGenerics, SummarizedExperiment,
BiocParallel, doParallel, parallel, snow, reshape2, plyr, dplyr, tidyr, tibble,
data.table, ggplot2, grid, ggthemes, ggExtra, cowplot, scales, cobs, msir, drc,
DrImpute, RUVSeq, scran, scater, SingleCellExperiment, SCnorm, Linnorm, edgeR, limma,
DESeq2, baySeq, NOISeq, NBPSeq, EBSeq, BASiCS, MAST, scde, scDD, ROTS, BPSC, monocle,
VGAM, IHW, qvalue
Remotes: nghiavtr/BPSC, catavallejos/BASiCS, rhondabacher/SCnorm, bioc::S4Vectors, bioc::DEDS,
bioc::AnnotationDbi, bioc::Biobase, bioc::BiocGenerics, bioc::SummarizedExperiment,
bioc::BiocParallel, bioc::RUVSeq, bioc::scran, bioc::scater,
bioc::SingleCellExperiment, bioc::Linnorm, bioc::edgeR, bioc::limma, bioc::DESeq2,
bioc::baySeq, bioc::NOISeq, bioc::EBSeq, bioc::MAST, bioc::scde, bioc::scDD,
bioc::ROTS, bioc::monocle, bioc::IHW, bioc::qvalue
Depends: R (>= 3.4.0)
Description: Recent development of very sensitive RNA-seq protocols, such as Smart-seq2 and CEL-seq allows
transcriptional profiling at single-cell resolution and droplet devices make single cell
transcriptomics high-throughput, allowing to characterize thousands or even millions of single
cells. In powsimR, we have implemented a flexible tool to assess power and sample size
requirements for differential expression (DE) analysis of single cell and bulk RNA-seq
experiments. For our read count simulations, we (1) reliably model the mean, dispersion and
dropout distributions as well as the relationship between those factors from the data. (2)
Simulate read counts from the empirical mean-variance and dropout relations, while offering
flexible choices of the number of differentially expressed genes, effect sizes and DE testing
method. (3) Finally, we evaluate the power over various sample sizes. The number of replicates
required to achieve the desired statistical power is mainly determined by technical noise and
biological variability and both are considerably larger if the biological replicates are single
cells. powsimR can not only estimate sample sizes necessary to achieve a certain power, but
also informs about the power to detect DE in a data set at hand. We believe that this type of
posterior analysis will become more and more important, if results from different studies are
to be compared. Often enough researchers are left to wonder why there is a lack of overlap in
DE-genes across similar experiments. PowsimR will allow the researcher to distinguish between
actual discrepancies and incongruities due to lack of power.
Version: 1.1.0
Imports: AnnotationDbi, baySeq, bbmle, Biobase, BiocGenerics, BiocParallel, broom, BPSC, cidr, cluster,
cobs, cowplot, data.table, DECENT, DEDS, DESeq2, doParallel, dplyr, drc, DrImpute, EBSeq,
edgeR, fastICA, fitdistrplus, foreach, ggExtra, ggplot2, ggthemes, glmnet, grDevices, grid,
gtools, Hmisc, IHW, kernlab, limma, Linnorm, MASS, MAST, matrixStats, mclust, methods,
minpack.lm, moments, monocle, msir, NBPSeq, NOISeq, nonnest2, parallel, penalized, plyr, pscl,
qvalue, reshape2, ROCR, ROTS, Rtsne, RUVSeq, S4Vectors, SAVER, scales, scater, scDD, scde,
SCnorm, scone, scran, Seurat, SingleCellExperiment, snow, stats, SummarizedExperiment, tibble,
tidyr, VGAM, ZIM, zinbwave, zingeR, zoo
Remotes: nghiavtr/BPSC, VCCRI/CIDR, cz-ye/DECENT, mohuangx/SAVER, rhondabacher/SCnorm statOmics/zingeR,
bioc::AnnotationDbi, bioc::baySeq, bioc::Biobase, bioc::BiocGenerics, bioc::BiocParallel,
bioc::DEDS, bioc::DESeq2, bioc::EBSeq, bioc::edgeR, bioc::IHW, bioc::limma, bioc::Linnorm,
bioc::MAST, bioc::monocle, bioc::NOISeq, bioc::qvalue, bioc::ROTS, bioc::RUVSeq,
bioc::S4Vectors, bioc::scater, bioc::scDD, bioc::scde, bioc::scone, bioc::scran,
bioc::SingleCellExperiment, bioc::SummarizedExperiment, bioc::zinbwave
Depends: R (>= 3.4), gamlss.dist
Suggests: BiocStyle, knitr
LazyData: TRUE
Encoding: UTF-8
VignetteBuilder: knitr
License: GPL
NeedsCompilation: no
Author: Beate Vieth
Date: 2017-11-30
Date: 2018-03-29
Maintainer: Beate Vieth <vieth.beate@gmail.com>
RoxygenNote: 6.0.1
117 changes: 108 additions & 9 deletions NAMESPACE
Expand Up @@ -5,41 +5,55 @@ export(SimSetup)
export(estimateParam)
export(estimateSpike)
export(evaluateDE)
export(evaluateDist)
export(evaluateROC)
export(evaluateSim)
export(insilicoNBParam)
export(plotCounts)
export(plotEvalDE)
export(plotEvalDist)
export(plotEvalSim)
export(plotParam)
export(plotSpike)
export(plotTime)
export(printEvalRes)
export(printEvalDE)
export(simulateCounts)
export(simulateDE)
import(ZIM)
importFrom(AnnotationDbi,as.list)
importFrom(BASiCS,BASiCS_DenoisedCounts)
importFrom(BASiCS,BASiCS_Filter)
importFrom(BASiCS,BASiCS_MCMC)
importFrom(BASiCS,newBASiCS_Data)
importFrom(BPSC,BPglm)
importFrom(Biobase,exprs)
importFrom(BiocGenerics,"sizeFactors<-")
importFrom(BiocGenerics,counts)
importFrom(BiocGenerics,estimateDispersions)
importFrom(BiocGenerics,sizeFactors)
importFrom(BiocParallel,MulticoreParam)
importFrom(BiocParallel,SerialParam)
importFrom(BiocParallel,bpparam)
importFrom(BiocParallel,register)
importFrom(DECENT,fitDE)
importFrom(DECENT,fitNoDE)
importFrom(DECENT,lrTest)
importFrom(DEDS,comp.FC)
importFrom(DESeq2,DESeq)
importFrom(DESeq2,DESeqDataSetFromMatrix)
importFrom(DESeq2,counts)
importFrom(DESeq2,estimateDispersions)
importFrom(DESeq2,estimateSizeFactors)
importFrom(DESeq2,nbinomWaldTest)
importFrom(DESeq2,results)
importFrom(DESeq2,sizeFactors)
importFrom(DrImpute,DrImpute)
importFrom(DrImpute,preprocessSC)
importFrom(EBSeq,EBTest)
importFrom(EBSeq,MedianNorm)
importFrom(Hmisc,binconf)
importFrom(IHW,adj_pvalues)
importFrom(IHW,ihw)
importFrom(Linnorm,Linnorm.Norm)
importFrom(MASS,fitdistr)
importFrom(MASS,glm.nb)
importFrom(MASS,isoMDS)
importFrom(MASS,rlm)
importFrom(MAST,FromMatrix)
importFrom(MAST,lrTest)
Expand All @@ -48,17 +62,38 @@ importFrom(MAST,zlm.SingleCellAssay)
importFrom(NBPSeq,nbp.test)
importFrom(NOISeq,noiseqbio)
importFrom(NOISeq,readData)
importFrom(ROCR,performance)
importFrom(ROCR,prediction)
importFrom(ROTS,ROTS)
importFrom(RUVSeq,RUVg)
importFrom(Rtsne,Rtsne)
importFrom(S4Vectors,SimpleList)
importFrom(S4Vectors,mcols)
importFrom(SAVER,saver)
importFrom(SCnorm,SCnorm)
importFrom(Seurat,AddImputedScore)
importFrom(Seurat,CreateSeuratObject)
importFrom(Seurat,ExpMean)
importFrom(Seurat,LogVMR)
importFrom(SingleCellExperiment,SingleCellExperiment)
importFrom(SingleCellExperiment,isSpike)
importFrom(SummarizedExperiment,SummarizedExperiment)
importFrom(SummarizedExperiment,assays)
importFrom(VGAM,negbinomial.size)
importFrom(VGAM,tobit)
importFrom(baySeq,getLikelihoods)
importFrom(baySeq,getPriors.NB)
importFrom(baySeq,topCounts)
importFrom(bbmle,mle2)
importFrom(broom,glance)
importFrom(cidr,cidrPcoa)
importFrom(cidr,determineDropoutCandidates)
importFrom(cidr,nPC)
importFrom(cidr,scCluster)
importFrom(cidr,scDataConstructor)
importFrom(cidr,scDissim)
importFrom(cidr,wThreshold)
importFrom(cluster,pam)
importFrom(cobs,cobs)
importFrom(cowplot,add_sub)
importFrom(cowplot,ggdraw)
Expand All @@ -67,103 +102,158 @@ importFrom(data.table,data.table)
importFrom(doParallel,registerDoParallel)
importFrom(doParallel,stopImplicitCluster)
importFrom(dplyr,arrange)
importFrom(dplyr,bind_rows)
importFrom(dplyr,do)
importFrom(dplyr,filter)
importFrom(dplyr,group_by)
importFrom(dplyr,left_join)
importFrom(dplyr,mutate)
importFrom(dplyr,rename_)
importFrom(dplyr,select)
importFrom(dplyr,slice)
importFrom(dplyr,summarise)
importFrom(dplyr,ungroup)
importFrom(edgeR,DGEList)
importFrom(edgeR,calcNormFactors)
importFrom(edgeR,cpm)
importFrom(edgeR,cpm.DGEList)
importFrom(edgeR,estimateDisp)
importFrom(edgeR,estimateGLMRobustDisp)
importFrom(edgeR,glmFit)
importFrom(edgeR,glmLRT)
importFrom(edgeR,glmQLFTest)
importFrom(edgeR,glmQLFit)
importFrom(edgeR,topTags)
importFrom(ggExtra,ggMarginal)
importFrom(edgeR,zscoreNBinom)
importFrom(fastICA,fastICA)
importFrom(fitdistrplus,fitdist)
importFrom(fitdistrplus,gofstat)
importFrom(foreach,"%dopar%")
importFrom(foreach,foreach)
importFrom(gamlss.dist,ZINBI)
importFrom(gamlss.dist,ZIP)
importFrom(ggplot2,aes)
importFrom(ggplot2,annotate)
importFrom(ggplot2,annotation_logticks)
importFrom(ggplot2,coord_flip)
importFrom(ggplot2,element_blank)
importFrom(ggplot2,element_text)
importFrom(ggplot2,facet_wrap)
importFrom(ggplot2,geom_bar)
importFrom(ggplot2,geom_boxplot)
importFrom(ggplot2,geom_density)
importFrom(ggplot2,geom_hline)
importFrom(ggplot2,geom_line)
importFrom(ggplot2,geom_point)
importFrom(ggplot2,geom_pointrange)
importFrom(ggplot2,geom_smooth)
importFrom(ggplot2,ggplot)
importFrom(ggplot2,ggtitle)
importFrom(ggplot2,guide_legend)
importFrom(ggplot2,guides)
importFrom(ggplot2,labs)
importFrom(ggplot2,position_dodge)
importFrom(ggplot2,scale_fill_gradientn)
importFrom(ggplot2,scale_fill_manual)
importFrom(ggplot2,scale_x_discrete)
importFrom(ggplot2,scale_x_log10)
importFrom(ggplot2,scale_y_continuous)
importFrom(ggplot2,scale_y_log10)
importFrom(ggplot2,stat_density2d)
importFrom(ggplot2,theme)
importFrom(ggplot2,theme_bw)
importFrom(ggplot2,theme_classic)
importFrom(ggplot2,theme_minimal)
importFrom(ggplot2,xlab)
importFrom(ggplot2,ylab)
importFrom(ggplot2,ylim)
importFrom(ggthemes,theme_base)
importFrom(glmnet,cv.glmnet)
importFrom(glmnet,predict.cv.glmnet)
importFrom(grDevices,blues9)
importFrom(grDevices,colorRampPalette)
importFrom(grid,unit)
importFrom(gtools,mixedsort)
importFrom(kernlab,specc)
importFrom(limma,eBayes)
importFrom(limma,lmFit)
importFrom(limma,topTable)
importFrom(limma,voom)
importFrom(matrixStats,rowSds)
importFrom(mclust,adjustedRandIndex)
importFrom(methods,is)
importFrom(methods,new)
importFrom(minpack.lm,nlsLM)
importFrom(moments,moment)
importFrom(monocle,differentialGeneTest)
importFrom(monocle,newCellDataSet)
importFrom(monocle,relative2abs)
importFrom(msir,loess.sd)
importFrom(nonnest2,vuongtest)
importFrom(parallel,detectCores)
importFrom(parallel,makeCluster)
importFrom(parallel,mclapply)
importFrom(parallel,mcmapply)
importFrom(parallel,stopCluster)
importFrom(penalized,penalized)
importFrom(penalized,predict)
importFrom(plyr,aaply)
importFrom(pscl,vuong)
importFrom(pscl,zeroinfl)
importFrom(qvalue,qvalue)
importFrom(reshape2,melt)
importFrom(scDD,scDD)
importFrom(scales,percent)
importFrom(scater,calcAverage)
importFrom(scater,calculateQCMetrics)
importFrom(scater,isOutlier)
importFrom(scater,normalize)
importFrom(scde,scde.error.models)
importFrom(scde,scde.expression.difference)
importFrom(scde,scde.expression.prior)
importFrom(scone,SconeExperiment)
importFrom(scone,estimate_ziber)
importFrom(scone,impute_expectation)
importFrom(scone,scone)
importFrom(scran,DM)
importFrom(scran,computeSpikeFactors)
importFrom(scran,computeSumFactors)
importFrom(scran,decomposeVar)
importFrom(scran,quickCluster)
importFrom(scran,trendVar)
importFrom(snow,makeCluster)
importFrom(snow,stopCluster)
importFrom(stats,AIC)
importFrom(stats,aggregate)
importFrom(stats,approx)
importFrom(stats,as.dist)
importFrom(stats,cmdscale)
importFrom(stats,coef)
importFrom(stats,coefficients)
importFrom(stats,complete.cases)
importFrom(stats,cor)
importFrom(stats,dbinom)
importFrom(stats,density)
importFrom(stats,dgamma)
importFrom(stats,dist)
importFrom(stats,dnbinom)
importFrom(stats,dnorm)
importFrom(stats,dpois)
importFrom(stats,ecdf)
importFrom(stats,fitted)
importFrom(stats,glm)
importFrom(stats,kmeans)
importFrom(stats,lm)
importFrom(stats,logLik)
importFrom(stats,mad)
importFrom(stats,median)
importFrom(stats,model.matrix)
importFrom(stats,na.exclude)
importFrom(stats,na.omit)
importFrom(stats,nls.control)
importFrom(stats,p.adjust)
importFrom(stats,p.adjust.methods)
importFrom(stats,pchisq)
importFrom(stats,pnorm)
importFrom(stats,poisson)
importFrom(stats,prcomp)
importFrom(stats,predict)
importFrom(stats,quantile)
importFrom(stats,rbeta)
Expand All @@ -181,7 +271,16 @@ importFrom(stats,uniroot)
importFrom(stats,var)
importFrom(tibble,rownames_to_column)
importFrom(tidyr,"%>%")
importFrom(tidyr,gather)
importFrom(tidyr,separate)
importFrom(tidyr,spread)
importFrom(utils,capture.output)
importFrom(utils,stack)
importFrom(zinbwave,computeObservationalWeights)
importFrom(zinbwave,glmWeightedF)
importFrom(zinbwave,zinbFit)
importFrom(zingeR,glmWeightedF)
importFrom(zingeR,zeroWeightsLS)
importFrom(zoo,rollmean)
importMethodsFrom(DESeq2,sizeFactors)
importMethodsFrom(baySeq,libsizes)

0 comments on commit cc52447

Please sign in to comment.