Coder Social home page Coder Social logo

bvieth / powsimr Goto Github PK

View Code? Open in Web Editor NEW
104.0 8.0 23.0 74.26 MB

Power analysis is essential to optimize the design of RNA-seq experiments and to assess and compare the power to detect differentially expressed genes. PowsimR is a flexible tool to simulate and evaluate differential expression from bulk and especially single-cell RNA-seq data making it suitable for a priori and posterior power analyses.

Home Page: https://bvieth.github.io/powsimR/

License: Artistic License 2.0

R 15.30% TeX 0.65% HTML 84.05%
gene-expression single-cell rna-seq simulation-framework simulation power experimental-design power-analysis r

powsimr's Introduction

powsimR
Power analysis for bulk and
single cell RNA-seq experiments

Please also consult my Github Page of powsimR made with pkgdown!

⏬ Installation Guide

For the installation, the R package devtools is needed.

install.packages("devtools")
library(devtools)

I recommend to install first the dependencies manually and then powsimR. If you plan to use MAGIC for imputation, then please follow their instruction to install the python implementation before installing powsimR.

ipak <- function(pkg, repository = c("CRAN", "Bioconductor", "github")) {
    new.pkg <- pkg[!(pkg %in% installed.packages()[, "Package"])]
    # new.pkg <- pkg
    if (length(new.pkg)) {
        if (repository == "CRAN") {
            install.packages(new.pkg, dependencies = TRUE)
        }
        if (repository == "Bioconductor") {
            if (strsplit(version[["version.string"]], " ")[[1]][3] > "4.0.0") {
                if (!requireNamespace("BiocManager")) {
                  install.packages("BiocManager")
                }
                BiocManager::install(new.pkg, dependencies = TRUE, ask = FALSE)
            }
            if (strsplit(version[["version.string"]], " ")[[1]][3] < "3.6.0") {
                stop(message("powsimR depends on packages and functions that are only available in R 4.0.0 and higher."))
            }
        }
        if (repository == "github") {
            devtools::install_github(new.pkg, build_vignettes = FALSE, force = FALSE,
                dependencies = TRUE)
        }
    }
}

# CRAN PACKAGES
cranpackages <- c("broom", "cobs", "cowplot", "data.table", "doParallel", "dplyr",
    "DrImpute", "fastICA", "fitdistrplus", "foreach", "future", "gamlss.dist", "ggplot2",
    "ggpubr", "ggstance", "grDevices", "grid", "Hmisc", "kernlab", "MASS", "magrittr",
    "MBESS", "Matrix", "matrixStats", "mclust", "methods", "minpack.lm", "moments",
    "msir", "NBPSeq", "nonnest2", "parallel", "penalized", "plyr", "pscl", "reshape2",
    "Rmagic", "rsvd", "Rtsne", "scales", "Seurat", "snow", "sctransform", "stats",
    "tibble", "tidyr", "truncnorm", "VGAM", "ZIM", "zoo")
ipak(cranpackages, repository = "CRAN")

# BIOCONDUCTOR
biocpackages <- c("bayNorm", "baySeq", "BiocGenerics", "BiocParallel", "DESeq2",
    "EBSeq", "edgeR", "IHW", "iCOBRA", "limma", "Linnorm", "MAST", "monocle", "NOISeq",
    "qvalue", "ROTS", "RUVSeq", "S4Vectors", "scater", "scDD", "scde", "scone", "scran",
    "SCnorm", "SingleCellExperiment", "SummarizedExperiment", "zinbwave")
ipak(biocpackages, repository = "Bioconductor")

# GITHUB
githubpackages <- c("cz-ye/DECENT", "nghiavtr/BPSC", "mohuangx/SAVER", "statOmics/zingeR",
    "Vivianstats/scImpute")
ipak(githubpackages, repository = "github")

To check whether all dependencies are installed, you can run the following lines:

powsimRdeps <- data.frame(Package = c(cranpackages, 
                                      biocpackages, 
                                      sapply(strsplit(githubpackages, "/"), "[[", 2)), 
                          stringsAsFactors = F)

ip <- as.data.frame(installed.packages()[,c(1,3:4)], stringsAsFactors = F)

ip.check <- cbind(powsimRdeps, 
                  Version = ip[match(powsimRdeps$Package, rownames(ip)),"Version"]) 

table(is.na(ip.check$Version))  # all should be FALSE

After installing the dependencies, powsimR can be installed by using devtools as well.

devtools::install_github("bvieth/powsimR", build_vignettes = TRUE, dependencies = FALSE)
library("powsimR")

Alternative, you can try to install powsimR and its dependencies directly using devtools:

devtools::install_github("bvieth/powsimR")

📖 User Guide

For examples and tips on using the package, please consult the vignette after successful installation by

browseVignettes("powsimR")

Some users have experienced issues installing powsimR due to vignette compilation errors or because they are missing the necessary R packages to build the vignette, i.e. knitr and rmdformats. If that is the case, you can either install these dependencies or leave out building the vignette (by setting build_vignettes to FALSE) and read it on my Github Page of powsimR or download it as a html file here.

DLLs and ulimit

Note that the error “maximal number of DLLs reached…” might occur due to the loading of many shared objects by Bioconductor packages. Restarting the R session after installing dependencies / powsimR will help. Starting with R version 3.4.0, one can set the environmental variable ‘R_MAX_NUM_DLLS’ to a higher number. See ?Startup() for more information. I recommend to increase the maximum number of DLLs that can be loaded to 500. The environmental variable R_MAX_NUM_DLLS can be set in R_HOME/etc/Renviron prior to starting R. For that locate the Renviron file and add the following line: R_MAX_NUM_DLLS=xy where xy is the number of DLLs. On my Ubuntu machine, the Renviron file is in /usr/lib/R/etc/ and I can set it to 500.

In addition, the user limits for open files (unix: ulimit) might have to be set to a higher number to accomodate the increase in DLLs. Please check out the help pages for MACs and Linux for guidance.

📜 Citation

Please use the following entry for citing powsimR.

citation("powsimR")

powsimR is published in Bioinformatics. A preprint paper is also on bioRxiv.

📨 Notes

Please send bug reports and feature requests by opening a new issue on this page. I try to keep up to date with new developments / changes of methods implemented in powsimR, but if you encounter run errors while using a certain tool (e.g. for imputation), then I appreciate if you can post this as an issue.

R Session Info

library(powsimR)
#> Loading required package: gamlss.dist
#> Loading required package: MASS
#> Registered S3 method overwritten by 'gdata':
#>   method         from  
#>   reorder.factor gplots
#> Warning: replacing previous import 'DECENT::lrTest' by 'MAST::lrTest' when
#> loading 'powsimR'
#> Warning: replacing previous import 'penalized::predict' by 'stats::predict' when
#> loading 'powsimR'
#> Warning: replacing previous import 'zinbwave::glmWeightedF' by
#> 'zingeR::glmWeightedF' when loading 'powsimR'
sessionInfo()
#> R version 4.1.2 (2021-11-01)
#> Platform: x86_64-pc-linux-gnu (64-bit)
#> Running under: Ubuntu 18.04.6 LTS
#> 
#> Matrix products: default
#> BLAS:   /usr/lib/x86_64-linux-gnu/openblas/libblas.so.3
#> LAPACK: /usr/lib/x86_64-linux-gnu/libopenblasp-r0.2.20.so
#> 
#> locale:
#>  [1] LC_CTYPE=en_US.UTF-8       LC_NUMERIC=C              
#>  [3] LC_TIME=de_DE.UTF-8        LC_COLLATE=en_US.UTF-8    
#>  [5] LC_MONETARY=de_DE.UTF-8    LC_MESSAGES=en_US.UTF-8   
#>  [7] LC_PAPER=de_DE.UTF-8       LC_NAME=C                 
#>  [9] LC_ADDRESS=C               LC_TELEPHONE=C            
#> [11] LC_MEASUREMENT=de_DE.UTF-8 LC_IDENTIFICATION=C       
#> 
#> attached base packages:
#> [1] stats     graphics  grDevices utils     datasets  methods   base     
#> 
#> other attached packages:
#> [1] powsimR_1.2.3     gamlss.dist_6.0-1 MASS_7.3-54      
#> 
#> loaded via a namespace (and not attached):
#>   [1] mixtools_1.2.0              softImpute_1.4-1           
#>   [3] minpack.lm_1.2-1            lattice_0.20-45            
#>   [5] vctrs_0.3.8                 fastICA_1.2-3              
#>   [7] mgcv_1.8-38                 penalized_0.9-51           
#>   [9] blob_1.2.2                  survival_3.2-13            
#>  [11] prodlim_2019.11.13          Rmagic_2.0.3               
#>  [13] later_1.3.0                 nloptr_1.2.2.3             
#>  [15] DBI_1.1.1                   R.utils_2.11.0             
#>  [17] rappdirs_0.3.3              SingleCellExperiment_1.16.0
#>  [19] Linnorm_2.18.0              dqrng_0.3.0                
#>  [21] jpeg_0.1-9                  zlibbioc_1.40.0            
#>  [23] MatrixModels_0.5-0          htmlwidgets_1.5.4          
#>  [25] mvtnorm_1.1-3               future_1.23.0              
#>  [27] UpSetR_1.4.0                parallel_4.1.2             
#>  [29] scater_1.22.0               irlba_2.3.3                
#>  [31] DEoptimR_1.0-9              Rcpp_1.0.7                 
#>  [33] KernSmooth_2.23-20          DT_0.20                    
#>  [35] promises_1.2.0.1            gdata_2.18.0               
#>  [37] DDRTree_0.1.5               DelayedArray_0.20.0        
#>  [39] limma_3.50.0                vegan_2.5-7                
#>  [41] Hmisc_4.6-0                 ShortRead_1.52.0           
#>  [43] apcluster_1.4.8             RSpectra_0.16-0            
#>  [45] msir_1.3.3                  mnormt_2.0.2               
#>  [47] digest_0.6.28               png_0.1-7                  
#>  [49] bluster_1.4.0               qlcMatrix_0.9.7            
#>  [51] sctransform_0.3.2           cowplot_1.1.1              
#>  [53] pkgconfig_2.0.3             docopt_0.7.1               
#>  [55] DelayedMatrixStats_1.16.0   gower_0.2.2                
#>  [57] ggbeeswarm_0.6.0            iterators_1.0.13           
#>  [59] minqa_1.2.4                 lavaan_0.6-9               
#>  [61] reticulate_1.22             SummarizedExperiment_1.24.0
#>  [63] spam_2.7-0                  beeswarm_0.4.0             
#>  [65] modeltools_0.2-23           xfun_0.28                  
#>  [67] zoo_1.8-9                   tidyselect_1.1.1           
#>  [69] ZIM_1.1.0                   reshape2_1.4.4             
#>  [71] purrr_0.3.4                 kernlab_0.9-29             
#>  [73] EDASeq_2.28.0               viridisLite_0.4.0          
#>  [75] snow_0.4-4                  rtracklayer_1.54.0         
#>  [77] rlang_0.4.12                hexbin_1.28.2              
#>  [79] glue_1.5.0                  RColorBrewer_1.1-2         
#>  [81] fpc_2.2-9                   matrixStats_0.61.0         
#>  [83] MatrixGenerics_1.6.0        stringr_1.4.0              
#>  [85] lava_1.6.10                 fields_13.3                
#>  [87] ggsignif_0.6.3              DESeq2_1.34.0              
#>  [89] recipes_0.1.17              SparseM_1.81               
#>  [91] httpuv_1.6.3                class_7.3-19               
#>  [93] BPSC_0.99.2                 BiocNeighbors_1.12.0       
#>  [95] annotate_1.72.0             jsonlite_1.7.2             
#>  [97] XVector_0.34.0              tmvnsim_1.0-2              
#>  [99] bit_4.0.4                   mime_0.12                  
#> [101] gridExtra_2.3               gplots_3.1.1               
#> [103] Rsamtools_2.10.0            zingeR_0.1.0               
#> [105] stringi_1.7.5               gmodels_2.18.1             
#> [107] rhdf5filters_1.6.0          bitops_1.0-7               
#> [109] maps_3.4.0                  RSQLite_2.2.8              
#> [111] tidyr_1.1.4                 pheatmap_1.0.12            
#> [113] data.table_1.14.2           rstudioapi_0.13            
#> [115] GenomicAlignments_1.30.0    nlme_3.1-153               
#> [117] qvalue_2.26.0               scran_1.22.1               
#> [119] fastcluster_1.2.3           locfit_1.5-9.4             
#> [121] scone_1.18.0                listenv_0.8.0              
#> [123] cobs_1.3-4                  R.oo_1.24.0                
#> [125] prabclus_2.3-2              segmented_1.3-4            
#> [127] dbplyr_2.1.1                BiocGenerics_0.40.0        
#> [129] lifecycle_1.0.1             timeDate_3043.102          
#> [131] ROTS_1.22.0                 munsell_0.5.0              
#> [133] hwriter_1.3.2               R.methodsS3_1.8.1          
#> [135] moments_0.14                caTools_1.18.2             
#> [137] codetools_0.2-18            coda_0.19-4                
#> [139] Biobase_2.54.0              GenomeInfoDb_1.30.0        
#> [141] vipor_0.4.5                 htmlTable_2.3.0            
#> [143] bayNorm_1.12.0              rARPACK_0.11-0             
#> [145] xtable_1.8-4                SAVER_1.1.2                
#> [147] ROCR_1.0-11                 diptest_0.76-0             
#> [149] formatR_1.11                lpsymphony_1.22.0          
#> [151] abind_1.4-5                 FNN_1.1.3                  
#> [153] parallelly_1.29.0           RANN_2.6.1                 
#> [155] sparsesvd_0.2               CompQuadForm_1.4.3         
#> [157] BiocIO_1.4.0                GenomicRanges_1.46.1       
#> [159] tibble_3.1.6                ggdendro_0.1.22            
#> [161] cluster_2.1.2               future.apply_1.8.1         
#> [163] Matrix_1.3-4                ellipsis_0.3.2             
#> [165] prettyunits_1.1.1           shinyBS_0.61               
#> [167] lubridate_1.8.0             NOISeq_2.38.0              
#> [169] shinydashboard_0.7.2        mclust_5.4.8               
#> [171] igraph_1.2.9                ggstance_0.3.5             
#> [173] slam_0.1-49                 testthat_3.1.0             
#> [175] doSNOW_1.0.19               htmltools_0.5.2            
#> [177] BiocFileCache_2.2.0         GenomicFeatures_1.46.1     
#> [179] yaml_2.2.1                  utf8_1.2.2                 
#> [181] XML_3.99-0.8                ModelMetrics_1.2.2.2       
#> [183] ggpubr_0.4.0                DrImpute_1.0               
#> [185] foreign_0.8-81              withr_2.4.2                
#> [187] scuttle_1.4.0               fitdistrplus_1.1-6         
#> [189] BiocParallel_1.28.2         aroma.light_3.24.0         
#> [191] bit64_4.0.5                 foreach_1.5.1              
#> [193] robustbase_0.93-9           outliers_0.14              
#> [195] Biostrings_2.62.0           combinat_0.0-8             
#> [197] rsvd_1.0.5                  ScaledMatrix_1.2.0         
#> [199] iCOBRA_1.22.1               memoise_2.0.1              
#> [201] evaluate_0.14               VGAM_1.1-5                 
#> [203] nonnest2_0.5-5              geneplotter_1.72.0         
#> [205] permute_0.9-5               caret_6.0-90               
#> [207] curl_4.3.2                  fdrtool_1.2.17             
#> [209] fansi_0.5.0                 conquer_1.2.1              
#> [211] edgeR_3.36.0                checkmate_2.0.0            
#> [213] cachem_1.0.6                truncnorm_1.0-8            
#> [215] tensorA_0.36.2              DECENT_1.1.0               
#> [217] ellipse_0.4.2               rjson_0.2.20               
#> [219] metapod_1.2.0               ggplot2_3.3.5              
#> [221] rstatix_0.7.0               ggrepel_0.9.1              
#> [223] scDD_1.18.0                 tools_4.1.2                
#> [225] sandwich_3.0-1              magrittr_2.0.1             
#> [227] RCurl_1.98-1.5              car_3.0-12                 
#> [229] pbivnorm_0.6.0              bayesm_3.1-4               
#> [231] xml2_1.3.2                  EBSeq_1.34.0               
#> [233] httr_1.4.2                  assertthat_0.2.1           
#> [235] rmarkdown_2.11              Rhdf5lib_1.16.0            
#> [237] boot_1.3-28                 globals_0.14.0             
#> [239] R6_2.5.1                    nnet_7.3-16                
#> [241] progress_1.2.2              genefilter_1.76.0          
#> [243] KEGGREST_1.34.0             gtools_3.9.2               
#> [245] statmod_1.4.36              beachmat_2.10.0            
#> [247] BiocSingular_1.10.0         rhdf5_2.38.0               
#> [249] splines_4.1.2               carData_3.0-4              
#> [251] colorspace_2.0-2            amap_0.8-18                
#> [253] generics_0.1.1              stats4_4.1.2               
#> [255] NBPSeq_0.3.0                compositions_2.0-2         
#> [257] base64enc_0.1-3             baySeq_2.28.0              
#> [259] pillar_1.6.4                HSMMSingleCell_1.14.0      
#> [261] GenomeInfoDbData_1.2.7      plyr_1.8.6                 
#> [263] dotCall64_1.0-1             gtable_0.3.0               
#> [265] SCnorm_1.16.0               monocle_2.22.0             
#> [267] restfulr_0.0.13             knitr_1.36                 
#> [269] RcppArmadillo_0.10.7.3.0    latticeExtra_0.6-29        
#> [271] biomaRt_2.50.1              IRanges_2.28.0             
#> [273] fastmap_1.1.0               doParallel_1.0.16          
#> [275] pscl_1.5.5                  flexmix_2.3-17             
#> [277] quantreg_5.86               AnnotationDbi_1.56.2       
#> [279] broom_0.7.10                filelock_1.0.2             
#> [281] scales_1.1.1                arm_1.12-2                 
#> [283] backports_1.4.0             plotrix_3.8-2              
#> [285] IHW_1.22.0                  S4Vectors_0.32.3           
#> [287] densityClust_0.3            ipred_0.9-12               
#> [289] lme4_1.1-27.1               hms_1.1.1                  
#> [291] Rtsne_0.15                  dplyr_1.0.7                
#> [293] shiny_1.7.1                 grid_4.1.2                 
#> [295] Formula_1.2-4               blockmodeling_1.0.5        
#> [297] crayon_1.4.2                MAST_1.20.0                
#> [299] RUVSeq_1.28.0               pROC_1.18.0                
#> [301] sparseMatrixStats_1.6.0     viridis_0.6.2              
#> [303] rpart_4.1-15                zinbwave_1.16.0            
#> [305] compiler_4.1.2

powsimr's People

Contributors

bvieth avatar giannimonaco avatar

Stargazers

 avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar

Watchers

 avatar  avatar  avatar  avatar  avatar  avatar  avatar  avatar

powsimr's Issues

could not find function "Githubpkg"

Hello. I am trying to install in R/3.4.3. I think I have all dependencies resolved, but now get the subject error message:

% R

R version 3.4.3 (2017-11-30) -- "Kite-Eating Tree"
Copyright (C) 2017 The R Foundation for Statistical Computing
Platform: x86_64-pc-linux-gnu (64-bit)

R is free software and comes with ABSOLUTELY NO WARRANTY.
You are welcome to redistribute it under certain conditions.
Type 'license()' or 'licence()' for distribution details.

Natural language support but running in an English locale

R is a collaborative project with many contributors.
Type 'contributors()' for more information and
'citation()' on how to cite R or R packages in publications.

Type 'demo()' for some demos, 'help()' for on-line help, or
'help.start()' for an HTML browser interface to help.
Type 'q()' to quit R.

library(devtools)
devtools::install_github("bvieth/powsimR", build_vignettes = TRUE, dependencies = FALSE)
Downloading GitHub repo bvieth/powsimR@master
from URL https://api.github.com/repos/bvieth/powsimR/zipball/master
Installing powsimR
'/sw/Pkgs/R/3.4.3/lib64/R/bin/R' --no-site-file --no-environ --no-save
--no-restore --quiet CMD build
'/tmp/Rtmp9JIlHZ/devtools5c872efbd8d0/bvieth-powsimR-f3e43ef'
--no-resave-data --no-manual

  • checking for file ‘/tmp/Rtmp9JIlHZ/devtools5c872efbd8d0/bvieth-powsimR-f3e43ef/DESCRIPTION’ ... OK
  • preparing ‘powsimR’:
  • checking DESCRIPTION meta-information ... OK
  • installing the package to build vignettes
  • creating vignettes ... ERROR
    Warning in engine$weave(file, quiet = quiet, encoding = enc) :
    Pandoc (>= 1.12.3) and/or pandoc-citeproc not available. Falling back to R Markdown v1.
    Quitting from lines 2-23 (powsimR.Rmd)
    Error: processing vignette 'powsimR.Rmd' failed with diagnostics:
    could not find function "Githubpkg"
    Execution halted
    Installation failed: Command failed (1)

Not sure what to do here. Any thoughts?

possible bug in plotEvalDE

hi beate,
i tried to run your package on a small RNA sequencing we did a while ago, and it went fine until i wanted to plot the eval (plotEvalDE()), there i got the error "function not found: n()"

i was able to hotfix it, the error is in the dplyr pipe for dat.marginal.calc, the standard error calculation says sqrt(n()) in the denominator. i am not familiar with this call, or if it needs a particular package to work, but i installed all dependencies as instructed. with my hotfix (substituting length(value) for n()) it works, though i am not sure if this is the intended use.

EDIT: first time was on mac, I repeated it on linux now, same result.

kind regards,
sebastian

SingleCellExperiment (scater)

I tried running the example code from the vignette, and get the following error with the estimateParam function:

Error in .run.checkup(countData = countData, batchData = batchData, spikeData = spikeData, :
no slot of name "assayData" for this object of class "SingleCellExperiment"
In addition: Warning message:
'newSCESet' is deprecated.
Use 'SingleCellExperiment' instead.
See help("Deprecated")

It looks like this may be due to an update in the scater package?
(Running R 3.4.2 on Windows)

could not find function ".bulk.NB.RNAseq_counts"

Hi. I am trying out the package to simulate some data, and I was able to estimate parameters fine according to pre-normalized data I have "norm_y". However, it seems like the "simulateCounts()" function is giving me the following error:

Error in .bulk.NB.RNAseq_counts(sim.options = simOptions, phenotype = phenotype, : could not find function ".bulk.NB.RNAseq_counts"

I basically followed the manual line by line, and i'm wondering if this function has been deleted from this package? Please advise. Thank you! Below is what I ran:

estparam <- estimateParam(countData = norm_y, Distribution = 'NB', Protocol = 'Read', RNAseq = 'bulk', Normalisation = 'none')

p.foo <- function(x) mvtnorm::rmvnorm(x, mean=c(4,2,1), sigma = matrix(c(4,2,2,2,3,2, 2, 2, 5), ncol=3))

b.foo <- function(x) rnorm(x, mean=0, sd=1.5)

sim.dat=simulateCounts(n=c(100,110,90), Thinning = NULL, ngenes=10000, p.DE=0.05, pLFC=p.foo, p.B=0.1, bLFC=b.foo, bPattern="uncorrelated", p.M=NULL, mLFC=NULL, params=estparam, LibSize='equal', spikeIns = FALSE, spike = NULL, thinSpike = FALSE, ActualMeans=FALSE, FillUp=FALSE, sim.seed=3, verbose=TRUE)

Issue with plotParam function

Hi Beate,

Really like the idea behind your program.

I have the current error message when running a bulk RNA-seq dataset

> simR.test <- estimateParam(countData = counts, Distribution = "NB", RNAseq = "bulk", normalisation = "TMM")
> plotParam(simR.test)
Error in ylim(c(0, 1)) : could not find function "ylim"

In addition when I run the example code from the vignette I don't get an error but I also do not get a plot.

Thanks,
-Dave

Issue with PowerSimR installation

Hello, I tried installing PowerSimR using instructions present at https://github.com/bvieth/powsimR but ran into the following error messages:

  • installing source package 'powsimR' ...
    ** using staged installation
    ** R
    ** data
    *** moving datasets to lazyload DB
    ** inst
    ** byte-compile and prepare package for lazy loading
    Warning: replacing previous import 'DECENT::lrTest' by 'MAST::lrTest' when loading 'powsimR'
    Error: object 'zlm.SingleCellAssay' is not exported by 'namespace:MAST'
    Execution halted
    ERROR: lazy loading failed for package 'powsimR'
  • removing 'C:/Users/folder/Documents/R/win-library/4.0/powsimR'
    Error: Failed to install 'powsimR' from GitHub:
    (converted from warning) installation of package ‘C:/Users/Public/TMP/RtmpoN0gRY/file3350321f5e53/powsimR_1.2.1.tar.gz’ had non-zero exit status

Cairo

Hi,
I have a new MacBook and try to install powsimR. I've install R using homebrew. I follow the manual instructions on your GitHub. I now get this error below. Do you know a way to solve this?

Best,

Sander

> ipak <- function(pkg, repository = c("CRAN", "Bioconductor", "github")) {
+     new.pkg <- pkg[!(pkg %in% installed.packages()[, "Package"])]
+     if (length(new.pkg)) {
+         if (repository == "CRAN") {
+             install.packages(new.pkg, dependencies = TRUE)
+         }
+         if (repository == "Bioconductor") {
+             source("https://bioconductor.org/biocLite.R")
+             biocLite(new.pkg, dependencies = TRUE, ask = FALSE)
+         }
+         if (repository == "github") {
+             devtools::install_github(new.pkg, build_vignettes = FALSE, dependencies = TRUE)
+         }
+     }
+ }
> cranpackages <- c("methods", "stats", "matrixStats", "Rtsne", "moments", "minpack.lm",
+     "glmnet", "cluster", "mclust", "MASS", "gtools", "doParallel", "parallel",
+     "snow", "reshape2", "plyr", "dplyr", "tidyr", "tibble", "data.table", "ggplot2",
+     "grid", "ggthemes", "ggExtra", "cowplot", "scales", "cobs", "msir", "drc",
+     "DrImpute", "VGAM", "NBPSeq")
> ipak(cranpackages, repository = "CRAN")
>
> biocpackages <- c("S4Vectors", "DEDS", "AnnotationDbi", "Biobase", "BiocGenerics",
+     "SummarizedExperiment", "BiocParallel", "RUVSeq", "scran", "scater", "SingleCellExperiment",
+     "Linnorm", "edgeR", "limma", "DESeq2", "baySeq", "NOISeq", "EBSeq", "MAST",
+     "scde", "scDD", "ROTS", "monocle", "IHW", "qvalue")
> ipak(biocpackages, repository = "Bioconductor")
Bioconductor version 3.6 (BiocInstaller 1.28.0), ?biocLite for help
BioC_mirror: https://bioconductor.org
Using Bioconductor 3.6 (BiocInstaller 1.28.0), R 3.4.3 (2017-11-30).
Installing package(s) ‘scde’
also installing the dependency ‘Cairo’

trying URL 'https://cran.rstudio.com/src/contrib/Cairo_1.5-9.tar.gz'
Content type 'application/x-gzip' length 86982 bytes (84 KB)
==================================================
downloaded 84 KB

trying URL 'https://bioconductor.org/packages/3.6/bioc/src/contrib/scde_2.6.0.tar.gz'
Content type 'application/x-gzip' length 1110245 bytes (1.1 MB)
==================================================
downloaded 1.1 MB

* installing *source* package ‘Cairo’ ...
** package ‘Cairo’ successfully unpacked and MD5 sums checked
checking for gcc... clang
checking whether the C compiler works... yes
checking for C compiler default output file name... a.out
checking for suffix of executables...
checking whether we are cross compiling... no
checking for suffix of object files... o
checking whether we are using the GNU C compiler... yes
checking whether clang accepts -g... yes
checking for clang option to accept ISO C89... none needed
checking how to run the C preprocessor... clang -E
checking for grep that handles long lines and -e... /usr/bin/grep
checking for egrep... /usr/bin/grep -E
checking for ANSI C header files... rm: conftest.dSYM: is a directory
rm: conftest.dSYM: is a directory
yes
checking for sys/wait.h that is POSIX.1 compatible... yes
checking for sys/types.h... yes
checking for sys/stat.h... yes
checking for stdlib.h... yes
checking for string.h... yes
checking for memory.h... yes
checking for strings.h... yes
checking for inttypes.h... yes
checking for stdint.h... yes
checking for unistd.h... yes
checking for string.h... (cached) yes
checking sys/time.h usability... yes
checking sys/time.h presence... yes
checking for sys/time.h... yes
checking for unistd.h... (cached) yes
checking for an ANSI C-conforming const... yes
checking for pkg-config... /usr/local/bin/pkg-config
checking whether pkg-config knows about cairo... no
configure: CAIRO_LIBS is unset, attempting to guess it.
configure: CAIRO_CFLAGS=-I/usr/local/include/cairo
checking if R was compiled with the RConn patch... no
checking cairo.h usability... yes
checking cairo.h presence... yes
checking for cairo.h... yes
checking for PNG support in Cairo... yes
checking for ATS font support in Cairo... no
configure: CAIRO_LIBS=-L/usr/local/lib -lcairo
checking for library containing deflate... -lz
checking whether Cairo programs can be compiled... yes
checking whether cairo_image_surface_get_format is declared... no
checking for FreeType support in cairo... yes
checking whether FreeType needs additional flags... yes
checking whether pkg-config knows about fontconfig or freetype2... yes
checking whether additional flags work... yes
checking wheter libjpeg works... yes
checking wheter libtiff works... yes
configure: creating ./config.status
config.status: creating src/Makevars
config.status: creating src/cconfig.h
** libs
clang -I/usr/local/Cellar/r/3.4.3/lib/R/include -DNDEBUG -I/usr/local/include/cairo  -I/usr/local/Cellar/fontconfig/2.12.6/include -I/usr/local/opt/freetype/include/freetype2 -I. -Iinclude  -I/usr/local/opt/gettext/include -I/usr/local/opt/readline/include -I/usr/local/include  -g -O2 -fPIC  -g -O2  -c cairobem.c -o cairobem.o
clang -I/usr/local/Cellar/r/3.4.3/lib/R/include -DNDEBUG -I/usr/local/include/cairo  -I/usr/local/Cellar/fontconfig/2.12.6/include -I/usr/local/opt/freetype/include/freetype2 -I. -Iinclude  -I/usr/local/opt/gettext/include -I/usr/local/opt/readline/include -I/usr/local/include  -g -O2 -fPIC  -g -O2  -c cairogd.c -o cairogd.o
clang -I/usr/local/Cellar/r/3.4.3/lib/R/include -DNDEBUG -I/usr/local/include/cairo  -I/usr/local/Cellar/fontconfig/2.12.6/include -I/usr/local/opt/freetype/include/freetype2 -I. -Iinclude  -I/usr/local/opt/gettext/include -I/usr/local/opt/readline/include -I/usr/local/include  -g -O2 -fPIC  -g -O2  -c cairotalk.c -o cairotalk.o
In file included from cairotalk.c:10:
In file included from ./xlib-backend.h:7:
/usr/local/include/cairo/cairo-xlib.h:44:10: fatal error: 'X11/Xlib.h' file not found
#include <X11/Xlib.h>
         ^~~~~~~~~~~~
1 error generated.
make: *** [cairotalk.o] Error 1
ERROR: compilation failed for package ‘Cairo’
* removing ‘/usr/local/Cellar/r/3.4.3/lib/R/library/Cairo’
ERROR: dependency ‘Cairo’ is not available for package ‘scde’
* removing ‘/usr/local/Cellar/r/3.4.3/lib/R/library/scde’

The downloaded source packages are in
	‘/private/var/folders/kh/0s66cjl5487fg_fhwgxqd2340000gn/T/Rtmp10xDSi/downloaded_packages’
Updating HTML index of packages in '.Library'
Making 'packages.html' ... done
Warning messages:
1: In install.packages(pkgs = doing, lib = lib, ...) :
  installation of package ‘Cairo’ had non-zero exit status
2: In install.packages(pkgs = doing, lib = lib, ...) :
  installation of package ‘scde’ had non-zero exit status

Error in scater::calculateQCMetrics(sce, nmads = 3)

Hi Beate,
it powsimR seems to be a very useful tool, thanks for developing it. I was able to install it in my machine but I keep receiving an error when I try to reproduce your example. See below. Do you have any hints on what may be causing it?
thanks,
Fernando

library('powsimR')

data("kolodziejczk_cnts")
kolodziejczk_cnts <- kolodziejczk_cnts[, grep('standard',

  •                                           colnames(kolodziejczk_cnts))]
    

TwoiLIF.params <- estimateParam(countData=kolodziejczk_cnts,

  •                             batchData = NULL,
    
  •                             spikeData = NULL,
    
  •                             spikeInfo = NULL,
    
  •                             Lengths = NULL,
    
  •                             MeanFragLengths = NULL,
    
  •                             Distribution = 'ZINB',
    
  •                             RNAseq = 'singlecell',
    
  •                             normalisation = 'TMM',
    
  •                             sigma = 1.96,
    
  •                             NCores = NULL)
    

Error in scater::calculateQCMetrics(sce, nmads = 3) :
unused argument (nmads = 3)

sessionInfo()
R version 3.5.0 (2018-04-23)
Platform: x86_64-apple-darwin15.6.0 (64-bit)
Running under: macOS High Sierra 10.13.4

Matrix products: default
BLAS: /System/Library/Frameworks/Accelerate.framework/Versions/A/Frameworks/vecLib.framework/Versions/A/libBLAS.dylib
LAPACK: /Library/Frameworks/R.framework/Versions/3.5/Resources/lib/libRlapack.dylib

locale:
[1] en_US.UTF-8/en_US.UTF-8/en_US.UTF-8/C/en_US.UTF-8/en_US.UTF-8

attached base packages:
[1] parallel stats4 stats graphics grDevices utils datasets methods base

other attached packages:
[1] scater_1.8.0 ggplot2_2.2.1 powsimR_1.1.1 gamlss.dist_5.0-6 MASS_7.3-50 SingleCellExperiment_1.2.0
[7] SummarizedExperiment_1.10.1 DelayedArray_0.6.0 BiocParallel_1.14.1 matrixStats_0.53.1 Biobase_2.40.0 GenomicRanges_1.32.3
[13] GenomeInfoDb_1.16.0 IRanges_2.14.10 S4Vectors_0.18.3 BiocGenerics_0.26.0

loaded via a namespace (and not attached):
[1] mixtools_1.1.0 softImpute_1.4 minpack.lm_1.2-1 pbapply_1.3-4 haven_1.1.1 lattice_0.20-35 fastICA_1.2-1
[8] mgcv_1.8-23 penalized_0.9-50 blob_1.1.1 survival_2.42-3 prodlim_2018.04.18 later_0.7.3 nloptr_1.0.4
[15] DBI_1.0.0 R.utils_2.6.0 Linnorm_2.4.0 bindr_0.1.1 zlibbioc_1.26.0 MatrixModels_0.4-1 pspline_1.0-18
[22] pcaMethods_1.72.0 SDMTools_1.1-221 htmlwidgets_1.2 mvtnorm_1.0-8 UpSetR_1.3.3 tclust_1.4-1 irlba_2.3.2
[29] DEoptimR_1.0-8 lars_1.2 Rcpp_0.12.17 KernSmooth_2.23-15 DT_0.4 promises_1.0.1 gdata_2.18.0
[36] DDRTree_0.1.5 limma_3.36.1 vegan_2.5-2 CVST_0.2-2 RcppParallel_4.4.0 Hmisc_4.1-1 ShortRead_1.38.0
[43] apcluster_1.4.7 RSpectra_0.13-1 msir_1.3.1 mnormt_1.5-5 ranger_0.10.1 digest_0.6.15 png_0.1-7
[50] qlcMatrix_0.9.7 cidr_0.1.5 cowplot_0.9.2 glmnet_2.0-16 pkgconfig_2.0.1 docopt_0.4.5 DelayedMatrixStats_1.2.0
[57] gower_0.1.2 ggbeeswarm_0.6.0 iterators_1.0.9 minqa_1.2.4 lavaan_0.6-1 reticulate_1.8 spam_2.1-4
[64] beeswarm_0.2.3 modeltools_0.2-21 RcppNumerical_0.3-2 zoo_1.8-1 tidyselect_0.2.4 clusterCrit_1.2.7 ZIM_1.0.3
[71] reshape2_1.4.3 purrr_0.2.5 kernlab_0.9-26 ica_1.0-2 pcaPP_1.9-73 EDASeq_2.14.0 viridisLite_0.3.0
[78] snow_0.4-2 rtracklayer_1.40.3 rlang_0.2.1 hexbin_1.27.2 manipulateWidget_0.9.0 NbClust_3.0 glue_1.2.0
[85] metap_0.9 RColorBrewer_1.1-2 registry_0.5 fpc_2.1-11 stringr_1.3.1 pkgmaker_0.27 lava_1.6.1
[92] fields_9.6 DESeq2_1.20.0 recipes_0.1.2 SparseM_1.77 httpuv_1.4.3 class_7.3-14 BPSC_0.99.1
[99] RMTstat_0.3 annotate_1.58.0 jsonlite_1.5 XVector_0.20.0 bit_1.1-14 mime_0.5 gridExtra_2.3
[106] gplots_3.0.1 Rsamtools_1.32.0 zingeR_0.1.0 stringi_1.2.2 gmodels_2.16.2 RcppRoll_0.3.0 gsl_1.9-10.3
[113] bitops_1.0-6 maps_3.3.0 RSQLite_2.1.1 tidyr_0.8.1 pheatmap_1.0.10 data.table_1.11.4 DEDS_1.54.0
[120] energy_1.7-4 rstudioapi_0.7 GenomicAlignments_1.16.0 sfsmisc_1.1-2 nlme_3.1-137 qvalue_2.12.0 scran_1.8.2
[127] fastcluster_1.1.25 scone_1.4.0 locfit_1.5-9.1 miniUI_0.1.1.1 cobs_1.3-3 R.oo_1.22.0 prabclus_2.2-6
[134] segmented_0.5-3.0 readxl_1.1.0 dimRed_0.1.0 timeDate_3043.102 ROTS_1.8.0 cellranger_1.1.0 munsell_0.4.3
[141] R.methodsS3_1.7.1 moments_0.14 hwriter_1.3.2 caTools_1.17.1 codetools_0.2-15 coda_0.19-1 magic_1.5-8
[148] diffusionMap_1.1-0 vipor_0.4.5 lmtest_0.9-36 htmlTable_1.12 rARPACK_0.11-0 xtable_1.8-2 SAVER_1.0.0
[155] ROCR_1.0-7 diptest_0.75-7 scatterplot3d_0.3-41 lpsymphony_1.8.0 abind_1.4-5 FNN_1.1 RANN_2.5.1
[162] sparsesvd_0.1-4 CompQuadForm_1.4.3 bibtex_0.4.2 rgl_0.99.16 tibble_1.4.2 ggdendro_0.1-20 cluster_2.0.7-1
[169] Seurat_2.3.1 Matrix_1.2-14 prettyunits_1.0.2 shinyBS_0.61 lubridate_1.7.4 ggridges_0.5.0 NOISeq_2.24.0
[176] shinydashboard_0.7.0 mclust_5.4 igraph_1.2.1 RcppEigen_0.3.3.4.0 slam_0.1-43 testthat_2.0.0 doSNOW_1.0.16
[183] geometry_0.3-6 htmltools_0.3.6 yaml_2.1.19 GenomicFeatures_1.32.0 XML_3.98-1.11 ModelMetrics_1.1.0 DrImpute_1.0
[190] foreign_0.8-70 withr_2.1.2 fitdistrplus_1.0-9 aroma.light_3.10.0 bit64_0.9-7 rngtools_1.3.1 doRNG_1.6.6
[197] foreach_1.4.4 robustbase_0.93-0 outliers_0.14 scde_2.8.0 Biostrings_2.48.0 combinat_0.0-8 iCOBRA_1.8.0
[204] memoise_1.1.0 VGAM_1.0-5 nonnest2_0.5-1 forcats_0.3.0 rio_0.5.10 geneplotter_1.58.0 permute_0.9-4
[211] caret_6.0-80 curl_3.2 fdrtool_1.2.15 trimcluster_0.1-2 acepack_1.4.1 edgeR_3.22.2 checkmate_1.8.5
[218] tensorA_0.36 DECENT_0.2.0 ellipse_0.4.1 rjson_0.2.20 openxlsx_4.1.0 ggrepel_0.8.0 distillery_1.0-4
[225] ade4_1.7-11 dtw_1.20-1 scDD_1.4.0 stabledist_0.7-1 Lmoments_1.2-3 tools_3.5.0 sandwich_2.4-0
[232] magrittr_1.5 RCurl_1.95-4.10 proxy_0.4-22 car_3.0-0 pbivnorm_0.6.0 ape_5.1 bayesm_3.1-0.1
[239] EBSeq_1.20.0 httr_1.3.1 assertthat_0.2.0 boot_1.3-20 R6_2.2.2 Rhdf5lib_1.2.1 nnet_7.3-12
[246] progress_1.1.2 tximport_1.8.0 genefilter_1.62.0 gtools_3.5.0 statmod_1.4.30 Rook_1.1-1 rhdf5_2.24.0
[253] splines_3.5.0 carData_3.0-1 colorspace_1.3-2 amap_0.8-16 NBPSeq_0.3.0 compositions_1.40-1 base64enc_0.1-3
[260] baySeq_2.14.0 pillar_1.2.3 HSMMSingleCell_0.114.0 bindrcpp_0.2.2 GenomeInfoDbData_1.1.0 plyr_1.8.4 extRemes_2.0-8
[267] dotCall64_0.9-5.2 gtable_0.2.0 zip_1.0.0 SCnorm_1.2.0 monocle_2.8.0 psych_1.8.4 knitr_1.20
[274] RcppArmadillo_0.8.500.0 latticeExtra_0.6-28 biomaRt_2.36.1 ADGofTest_0.3 copula_0.999-18 crosstalk_1.0.0 Cairo_1.5-9
[281] doParallel_1.0.11 pscl_1.5.2 flexmix_2.3-14 quantreg_5.36 AnnotationDbi_1.42.1 broom_0.4.4 scales_0.5.0
[288] arm_1.10-1 backports_1.1.2 IHW_1.8.0 densityClust_0.3 ipred_0.9-6 lme4_1.1-17 brew_1.0-6
[295] DESeq_1.32.0 Rtsne_0.13 dplyr_0.7.5 shiny_1.1.0 ddalpha_1.3.3 grid_3.5.0 numDeriv_2016.8-1
[302] bbmle_1.0.20 lazyeval_0.2.1 dynamicTreeCut_1.63-1 Formula_1.2-3 tsne_0.1-3 blockmodeling_0.3.1 DRR_0.0.3
[309] MAST_1.6.1 RUVSeq_1.14.0 viridis_0.5.1 rpart_4.1-13 zinbwave_1.2.0 compiler_3.5.0

Issue regarding "hd5" for Seurat

I've been getting an error on trying to do install.packages("Seurat")

This is what I got:
Installing package into ‘/home/ahmedmar/Rlibrary/3.4.1’
(as ‘lib’ is unspecified)
trying URL 'https://cran.r-project.org/src/contrib/Seurat_2.3.4.tar.gz'
Content type 'application/x-gzip' length 861959 bytes (841 KB)

downloaded 841 KB

  • installing source package ‘Seurat’ ...
    ** package ‘Seurat’ successfully unpacked and MD5 sums checked
    ** libs
    g++ -std=gnu++11 -I/sw/arcts/centos7/R/3.4.1/lib64/R/include -DNDEBUG -I"/home/ahmedmar/Rlibrary/3.4.1/Rcpp/include" -I"/home/ahmedmar/Rlibrary/3.4.1/RcppEigen/include" -I"/home/ahmedmar/Rlibrary/3.4.1/RcppProgress/include" -I/usr/local/include -fpic -g -O2 -c ModularityOptimizer.cpp -o ModularityOptimizer.o
    g++ -std=gnu++11 -I/sw/arcts/centos7/R/3.4.1/lib64/R/include -DNDEBUG -I"/home/ahmedmar/Rlibrary/3.4.1/Rcpp/include" -I"/home/ahmedmar/Rlibrary/3.4.1/RcppEigen/include" -I"/home/ahmedmar/Rlibrary/3.4.1/RcppProgress/include" -I/usr/local/include -fpic -g -O2 -c RModularityOptimizer.cpp -o RModularityOptimizer.o
    g++ -std=gnu++11 -I/sw/arcts/centos7/R/3.4.1/lib64/R/include -DNDEBUG -I"/home/ahmedmar/Rlibrary/3.4.1/Rcpp/include" -I"/home/ahmedmar/Rlibrary/3.4.1/RcppEigen/include" -I"/home/ahmedmar/Rlibrary/3.4.1/RcppProgress/include" -I/usr/local/include -fpic -g -O2 -c RcppExports.cpp -o RcppExports.o
    g++ -std=gnu++11 -I/sw/arcts/centos7/R/3.4.1/lib64/R/include -DNDEBUG -I"/home/ahmedmar/Rlibrary/3.4.1/Rcpp/include" -I"/home/ahmedmar/Rlibrary/3.4.1/RcppEigen/include" -I"/home/ahmedmar/Rlibrary/3.4.1/RcppProgress/include" -I/usr/local/include -fpic -g -O2 -c data_manipulation.cpp -o data_manipulation.o
    g++ -std=gnu++11 -I/sw/arcts/centos7/R/3.4.1/lib64/R/include -DNDEBUG -I"/home/ahmedmar/Rlibrary/3.4.1/Rcpp/include" -I"/home/ahmedmar/Rlibrary/3.4.1/RcppEigen/include" -I"/home/ahmedmar/Rlibrary/3.4.1/RcppProgress/include" -I/usr/local/include -fpic -g -O2 -c snn.cpp -o snn.o
    g++ -std=gnu++11 -shared -L/sw/arcts/centos7/R/3.4.1/lib64/R/lib -L/usr/local/lib64 -o Seurat.so ModularityOptimizer.o RModularityOptimizer.o RcppExports.o data_manipulation.o snn.o -L/sw/arcts/centos7/R/3.4.1/lib64/R/lib -lR
    installing to /home/ahmedmar/Rlibrary/3.4.1/Seurat/libs
    ** R
    ** data
    *** moving datasets to lazyload DB
    ** inst
    ** preparing package for lazy loading
    Error in dyn.load(file, DLLpath = DLLpath, ...) :
    unable to load shared object '/home/ahmedmar/Rlibrary/3.4.1/hdf5r/libs/hdf5r.so':
    /home/ahmedmar/Rlibrary/3.4.1/hdf5r/libs/hdf5r.so: invalid ELF header
    ERROR: lazy loading failed for package ‘Seurat’
  • removing ‘/home/ahmedmar/Rlibrary/3.4.1/Seurat’

The downloaded source packages are in
‘/tmp/RtmpXkgxMp/downloaded_packages’
Warning message:
In install.packages("Seurat", repos = "https://cran.r-project.org") :
installation of package ‘Seurat’ had non-zero exit status

Installation failure - package ‘stringi.so’ is not available (for R version 3.4.4)

  • installing source package ‘zingeR’ ...
    ** R
    ** data
    *** moving datasets to lazyload DB
    ** preparing package for lazy loading
    Error: package or namespace load failed for ‘DESeq2’ in library.dynam(lib, package, package.lib):
    shared object ‘stringi.so’ not found
    Error : package ‘DESeq2’ could not be loaded
    ERROR: lazy loading failed for package ‘zingeR’
  • removing ‘/Library/Frameworks/R.framework/Versions/3.4/Resources/library/zingeR’
    Installation failed: Command failed (1)

install.packages("stringi.so")
Warning in install.packages :
package ‘stringi.so’ is not available (for R version 3.4.4)

Do you have a workaround for the newer version of R?

simulateDE() is missing example options for the normalisation argument

Dear Author,

Thank you for developing this very useful tool.

I just wanted to leave you a note, I was looking at the simulateDE function with ?simulateDE and notice that the possibilities for the argument "normalisation" are missing in the documentation e.g.:

?simulateDE

Simulate Differential Expression
<...snip...>
Normalisation method to use. Available options are:

So far in your example code you use normalisation = "scran", perhaps you intended to have others as well? eg. TMM ? ( i just tried that now and it works with TMM)

Thanks again!

powsimR installation error

Dear Beate,

I followed this page to install powsimR: https://github.com/bvieth/powsimR/blob/master/vignettes/powsimR.Rmd

and got the following output with error Error : object ‘fitDE’ is not exported by 'namespace:DECENT' ERROR: lazy loading failed for package ‘powsimR’. I tried re-installing DECENT but that didn't help.

The output looks like this:

> devtools::install_github('bvieth/powsimR', 
+                          build_vignettes = TRUE, 
+                          dependencies=FALSE)
Downloading GitHub repo bvieth/powsimR@master
from URL https://api.github.com/repos/bvieth/powsimR/zipball/master
Installing powsimR
'/usr/lib/R/bin/R' --no-site-file --no-environ --no-save --no-restore --quiet CMD build '/tmp/Rtmp7stA6V/devtools34d029f5bcda/bvieth-powsimR-f3e43ef'  \
  --no-resave-data --no-manual 

* checking for file ‘/tmp/Rtmp7stA6V/devtools34d029f5bcda/bvieth-powsimR-f3e43ef/DESCRIPTION’ ... OK
* preparing ‘powsimR’:
* checking DESCRIPTION meta-information ... OK
* installing the package to build vignettes
      -----------------------------------
* installing *source* package ‘powsimR’ ...
** R
** data
*** moving datasets to lazyload DB
No protocol specified
Warning in rgl.init(initValue, onlyNULL) :
  RGL: unable to open X11 display
Warning: 'rgl_init' failed, running with rgl.useNULL = TRUE
** inst
** byte-compile and prepare package for lazy loading
Error : object ‘fitDE’ is not exported by 'namespace:DECENT'
ERROR: lazy loading failed for package ‘powsimR’
* removing ‘/tmp/RtmpYxTxl2/Rinst484acdd3492/powsimR’
      -----------------------------------
ERROR: package installation failed
Installation failed: Command failed (1)

Many thanks,
Xiuwei

License unclear

The DESCRIPTION file says that any version of the GPL applies to the code, yet the LICENSE.md file is a copy of the Artistic 2.0 license.

Could you please clarify which license actually applies?

could not find function "insilicoNBParam"

Hi. I'm trying to do some simulation to calculate power for a single cell RNA-seq study. I'm getting hung up with the in silico parameter simulation function.

Just running the example I get this:
insilico.singlecell <- insilicoNBParam(means=function(x) rgamma(x, 4, 2),
dispersion=function(x) 2 + 150/x,
dropout=NULL,
sf=function(x) 2^rnorm(n=x, mean=0, sd=0.5),
RNAseq='singlecell')

Error in insilicoNBParam(means = function(x) rgamma(x, 4, 2), dispersion = function(x) 2 + :
could not find function "insilicoNBParam"

Installation error:

Hi,

I'm trying to install your package. I'm getting the following error (see below). I don't get it, because as far as I can see scater is loaded. Do you know how to fix this?

Best,

Sander

ERROR

> devtools::install_github("bvieth/powsimR", build_vignettes = TRUE, dependencies = FALSE)
Downloading GitHub repo bvieth/powsimR@master
from URL https://api.github.com/repos/bvieth/powsimR/zipball/master
Installing powsimR
'/usr/local/Cellar/r/3.4.2/lib/R/bin/R' --no-site-file --no-environ --no-save  \
  --no-restore --quiet CMD build  \
  '/private/var/folders/7r/ns6f04xj55j72y97pvwtwxj0000_2q/T/RtmpE0h5HL/devtools5835033dab6/bvieth-powsimR-e5be519'  \
  --no-resave-data --no-manual

* checking for file ‘/private/var/folders/7r/ns6f04xj55j72y97pvwtwxj0000_2q/T/RtmpE0h5HL/devtools5835033dab6/bvieth-powsimR-e5be519/DESCRIPTION’ ... OK
* preparing ‘powsimR’:
* checking DESCRIPTION meta-information ... OK
* installing the package to build vignettes
      -----------------------------------
* installing *source* package ‘powsimR’ ...
** R
** inst
** preparing package for lazy loading
Error : object ‘sizeFactors’ is not exported by 'namespace:scater'
ERROR: lazy loading failed for package ‘powsimR’
* removing ‘/private/var/folders/7r/ns6f04xj55j72y97pvwtwxj0000_2q/T/RtmplEcg1I/Rinst68b411de6d5/powsimR’
      -----------------------------------
ERROR: package installation failed
Installation failed: Command failed (1)

My Session details

> sessionInfo()
R version 3.4.2 (2017-09-28)
Platform: x86_64-apple-darwin16.7.0 (64-bit)
Running under: macOS Sierra 10.12.6

Matrix products: default
BLAS: /System/Library/Frameworks/Accelerate.framework/Versions/A/Frameworks/vecLib.framework/Versions/A/libBLAS.dylib
LAPACK: /System/Library/Frameworks/Accelerate.framework/Versions/A/Frameworks/vecLib.framework/Versions/A/libLAPACK.dylib

locale:
[1] en_US.UTF-8/en_US.UTF-8/en_US.UTF-8/C/en_US.UTF-8/en_US.UTF-8

attached base packages:
[1] stats4    parallel  stats     graphics  grDevices utils     datasets
[8] methods   base

other attached packages:
 [1] scater_1.5.20               SingleCellExperiment_0.99.4
 [3] SummarizedExperiment_1.7.10 DelayedArray_0.3.21
 [5] matrixStats_0.52.2          GenomicRanges_1.29.15
 [7] GenomeInfoDb_1.13.5         IRanges_2.11.19
 [9] S4Vectors_0.15.14           ggplot2_2.2.1
[11] Biobase_2.37.2              BiocGenerics_0.23.4

loaded via a namespace (and not attached):
 [1] viridis_0.4.0           httr_1.3.1              edgeR_3.19.8
 [4] bit64_0.9-7             viridisLite_0.2.0       shiny_1.0.5.9000
 [7] assertthat_0.2.0        blob_1.1.0              GenomeInfoDbData_0.99.1
[10] vipor_0.4.5             progress_1.1.2          RSQLite_2.0
[13] lattice_0.20-35         glue_1.1.1              limma_3.33.14
[16] digest_0.6.12           XVector_0.17.2          colorspace_1.3-2
[19] htmltools_0.3.6         httpuv_1.3.5            Matrix_1.2-11
[22] plyr_1.8.4              XML_3.98-1.9            pkgconfig_2.0.1
[25] devtools_1.13.3         biomaRt_2.33.4          zlibbioc_1.23.0
[28] xtable_1.8-2            scales_0.5.0            git2r_0.19.0
[31] tibble_1.3.4            withr_2.0.0             lazyeval_0.2.0
[34] magrittr_1.5            mime_0.5                memoise_1.1.0
[37] beeswarm_0.2.3          shinydashboard_0.6.1    tools_3.4.2
[40] data.table_1.10.4-2     prettyunits_1.0.2       stringr_1.2.0
[43] munsell_0.4.3           locfit_1.5-9.1          AnnotationDbi_1.39.4
[46] bindrcpp_0.2            compiler_3.4.2          rlang_0.1.2
[49] rhdf5_2.21.6            grid_3.4.2              RCurl_1.95-4.8
[52] tximport_1.5.1          rjson_0.2.15            bitops_1.0-6
[55] gtable_0.2.0            DBI_0.7                 curl_3.0
[58] reshape2_1.4.2          R6_2.2.2                gridExtra_2.3
[61] knitr_1.17              dplyr_0.7.4             bit_1.1-12
[64] bindr_0.1               stringi_1.1.5           ggbeeswarm_0.6.0
[67] Rcpp_0.12.13

problem with evaluateDist function

Dear Beate,

Could you give me the instruction to fix the following error?
I tried your powsimR example code from the vignette. And when I was running the function evaluateDist, I got an error message. I am using R version 3.4.3 and Bioconductor version 3.6.

evaluateDist(cnts = kolodziejczk_cnts, RNAseq = "singlecell",

  •          ncores = 1, nsims = 1, frac.genes = 1, min.meancount = 1,
    
  •          min.libsize = 1000)
    

Error in evaluateDist(cnts = kolodziejczk_cnts, RNAseq = "singlecell", :
could not find function "evaluateDist"

Thank you,

Yoshi

install error

Hi, would you kindly help me sort out this install error? Thanks!

Downloading GitHub repo bvieth/powsimR@master
from URL https://api.github.com/repos/bvieth/powsimR/zipball/master
Installing powsimR
svn: E170013: Unable to connect to a repository at URL 'https://hedgehog.fhcrc.org/bioconductor/trunk/madman/Rpacks/S4Vectors'
svn: E230001: Server SSL certificate verification failed: issuer is not trusted
Installation failed: There was a problem retrieving the current SVN revision
Warning message:
running command ''/usr/bin/svn' info --xml --username readonly --password readonly https://hedgehog.fhcrc.org/bioconductor/trunk/madman/Rpacks/S4Vectors' had status 1

Installation issues -- non-R dependencies

I really wanted to try this package because it looks excellent, but the installation was difficult. Here's what I did to get it to work, and maybe this will help others.

  • Ensure libxml2 v2.9.1, geos 3.7.1, gcc 8.1.0, and gsl 2.4 are on the PATH
  • Ignore the errors about RcppParallel. They can lead to difficult issues such as RcppCore/RcppParallel#99 , and apparently it's not actually necessary, because my installation has now nominally worked without it.

Alternatively, would you consider either publishing a Docker or Singularity image for this package, or making more of the dependencies optional? Those would be easier and more reliable than having each user navigate the process separately.

vignette powsimR version 1.1.5

Hello,
Would it possible to have access to the new version of the vignette for powsimR 1.1.5
in your Github Page of powsimR or as an html file? Thank you.

Can't install in R v4.01

Hi,

I am trying to install the powsimR in R 4.01.
When I run this script:
biocpackages <- c("bayNorm", "baySeq", "BiocGenerics", "BiocParallel", "DEDS",
"DESeq2", "EBSeq", "edgeR", "IHW", "iCOBRA",
"limma", "Linnorm", "MAST", "monocle", "NOISeq", "qvalue", "ROTS", "RUVSeq",
"S4Vectors", "scater", "scDD", "scde", "scone", "scran", "SCnorm",
"SingleCellExperiment", "SummarizedExperiment", "zinbwave")
ipak(biocpackages, repository='Bioconductor')

I can't install the DEDS package, so I have tried to install it separately by the command: BiocManager::install("DEDS")
however, it still doesn't work (my bioconductor version is 3.11), get the warning message:

Warning message:
package ‘DEDS’ is not available (for R version 4.0.1)

How should I trouble shoot it?

Thank you very much!!

Shui

Installing on macOS

Hi,

Maybe this is not really an issue, rather a bug?

I've installed R via home-brew. And now I wanted to install the powsimR package. All in all, not an issue (on R-3.4.2), except for the PDF creation of the vignettes. Apparently one needs LaTeX for that. So to make it work I did this:

step 1

I made sure home-brew is up-to-date.

step 2

I installed a basic LaTeX package; following these instructions: https://tex.stackexchange.com/a/319572.

brew cask install basictex

step 3

I rebooted.

step 4

I updated tlmgr and after that install titling as root

sudo tlmgr update --self
sudo tlmgr install titling

step 5

It's recommended to also install the recommended font-collection.

sudo tlmgr install collection-fontsrecommended

step 6

I try to install powsimR:

devtools::install_github('bvieth/powsimR', build_vignettes = TRUE, dependencies = FALSE)

But now I get this message:

devtools::install_github('bvieth/powsimR', build_vignettes = TRUE, dependencies = FALSE)
Downloading GitHub repo bvieth/powsimR@master
from URL https://api.github.com/repos/bvieth/powsimR/zipball/master
Installing powsimR
'/usr/local/Cellar/r/3.4.3_1/lib/R/bin/R' --no-site-file --no-environ  \
  --no-save --no-restore --quiet CMD build  \
  '/private/var/folders/kh/0s66cjl5487fg_fhwgxqd2340000gn/T/RtmpIQ11b5/devtools5b223199244/bvieth-powsimR-0e31927'  \
  --no-resave-data --no-manual

* checking for file ‘/private/var/folders/kh/0s66cjl5487fg_fhwgxqd2340000gn/T/RtmpIQ11b5/devtools5b223199244/bvieth-powsimR-0e31927/DESCRIPTION’ ... OK
* preparing ‘powsimR’:
* checking DESCRIPTION meta-information ... OK
* installing the package to build vignettes
* creating vignettes ... ERROR
Warning: running command 'kpsewhich framed.sty' had status 1
Warning in test_latex_pkg("framed", system.file("misc", "framed.sty", package = "knitr")) :
  unable to find LaTeX package 'framed'; will use a copy from knitr
Error in texi2dvi(file = file, pdf = TRUE, clean = clean, quiet = quiet,  :
  Running 'texi2dvi' on 'powsimR.tex' failed.
LaTeX errors:
! LaTeX Error: File `beramono.sty' not found.

Type X to quit or <RETURN> to proceed,
or enter new name. (Default extension: sty)
Calls: <Anonymous> -> texi2pdf -> texi2dvi
Execution halted
Installation failed: Command failed (1)

Hope you have a solution? I know, building the vignettes is not strictly needed...nonetheless... :-)

Best,

Sander

Update from old powsim

Hi,

I am trying to install the old powsim package, as I am running an another package that is dependent on the older version of powsim, not powsimR. However, I am running into issues with installing NBGOF. I noticed that in the newer version of powsimR, does not use this package anymore. Was there any issues with the package, perhaps with installation by any chance?

I apologize for posting this on the powsimR page, but I was not sure if the other powsim page was still being maintained. Please let me know if this is an issue, so I can remove the post.

Thank you!

Installation Issue

Hello, I am working on an install and encountering the following error:

devtools::install_github("bvieth/powsimR")

Downloading GitHub repo bvieth/powsimR@master
from URL https://api.github.com/repos/bvieth/powsimR/zipball/master
Installing powsimR
svn: E170013: Unable to connect to a repository at URL 'https://hedgehog.fhcrc.org/bioconductor/trunk/madman/Rpacks/AnnotationDbi'
svn: E230001: Server SSL certificate verification failed: issuer is not trusted
Installation failed: There was a problem retrieving the current SVN revision
Warning message:
running command ''/usr/bin/svn' info --xml --username readonly --password readonly https://hedgehog.fhcrc.org/bioconductor/trunk/madman/Rpacks/AnnotationDbi' had status 1

estimateParam(): non-numeric argument to mathematical function error

Hi Beate,

I've been running into an issue with the estimateParam() function where I get the following error message:

Error in log10(metric) : non-numeric argument to mathematical function

Below is a working example (taken from your vignette) that reproduces the error (for me at least), as well as my sessionInfo. Thanks for your help and for all your work on this project!

library(powsimR)

# load counts data
data('kolodziejczk_cnts')

# create grouping variable
kolodziejczk_grps <- data.frame(Culture = c(rep("alternative", 194),
                                            rep("serum", 242),
                                            rep("standard", 433)),
                                row.names = colnames(kolodziejczk_cnts),
                                stringsAsFactors = F)

# estimate parameters
TwoiLIF.params <- estimateParam(countData=kolodziejczk_cnts,
                                batchData = kolodziejczk_grps,
                                spikeData = NULL,
                                spikeInfo = NULL,
                                Lengths = NULL,
                                MeanFragLengths = NULL,
                                Distribution = 'ZINB',
                                RNAseq = 'singlecell',
                                normalisation = 'TMM',
                                sigma = 1.96,
                                NCores = NULL,
                                verbose = TRUE)

=================================================================

sessionInfo()
R version 3.5.1 (2018-07-02)
Platform: x86_64-pc-linux-gnu (64-bit)
Running under: Ubuntu 16.04.5 LTS

Matrix products: default
BLAS: /usr/lib/libblas/libblas.so.3.6.0
LAPACK: /usr/lib/lapack/liblapack.so.3.6.0

locale:
 [1] LC_CTYPE=en_US.UTF-8       LC_NUMERIC=C              
 [3] LC_TIME=en_US.UTF-8        LC_COLLATE=en_US.UTF-8    
 [5] LC_MONETARY=en_US.UTF-8    LC_MESSAGES=en_US.UTF-8   
 [7] LC_PAPER=en_US.UTF-8       LC_NAME=C                 
 [9] LC_ADDRESS=C               LC_TELEPHONE=C            
[11] LC_MEASUREMENT=en_US.UTF-8 LC_IDENTIFICATION=C       

attached base packages:
[1] stats     graphics  grDevices utils     datasets  methods   base     

other attached packages:
[1] powsimR_1.1.3     gamlss.dist_5.1-0 MASS_7.3-51.1    

loaded via a namespace (and not attached):
  [1] mixtools_1.1.0              softImpute_1.4             
  [3] minpack.lm_1.2-1            pbapply_1.3-4              
  [5] lattice_0.20-38             haven_2.0.0                
  [7] fastICA_1.2-1               mgcv_1.8-25                
  [9] penalized_0.9-51            blob_1.1.1                 
 [11] survival_2.43-1             later_0.7.5                
 [13] nloptr_1.2.1                DBI_1.0.0                  
 [15] R.utils_2.7.0               SingleCellExperiment_1.4.0 
 [17] Linnorm_2.6.0               bindr_0.1.1                
 [19] zlibbioc_1.28.0             MatrixModels_0.4-1         
 [21] pspline_1.0-18              pcaMethods_1.74.0          
 [23] SDMTools_1.1-221            htmlwidgets_1.3            
 [25] mvtnorm_1.0-8               hdf5r_1.0.1                
 [27] UpSetR_1.3.3                parallel_3.5.1             
 [29] scater_1.10.0               irlba_2.3.2                
 [31] DEoptimR_1.0-8              lars_1.2                   
 [33] Rcpp_1.0.0                  KernSmooth_2.23-15         
 [35] DT_0.5                      promises_1.0.1             
 [37] gdata_2.18.0                DDRTree_0.1.5              
 [39] DelayedArray_0.8.0          limma_3.38.2               
 [41] vegan_2.5-3                 Hmisc_4.1-1                
 [43] ShortRead_1.40.0            apcluster_1.4.7            
 [45] RSpectra_0.13-1             msir_1.3.1                 
 [47] mnormt_1.5-5                digest_0.6.18              
 [49] png_0.1-7                   qlcMatrix_0.9.7            
 [51] cowplot_0.9.3               glmnet_2.0-16              
 [53] pkgconfig_2.0.2             docopt_0.6.1               
 [55] DelayedMatrixStats_1.4.0    ggbeeswarm_0.6.0           
 [57] iterators_1.0.10            minqa_1.2.4                
 [59] lavaan_0.6-3                reticulate_1.10            
 [61] SummarizedExperiment_1.12.0 spam_2.2-0                 
 [63] beeswarm_0.2.3              modeltools_0.2-22          
 [65] zoo_1.8-4                   tidyselect_0.2.5           
 [67] ZIM_1.1.0                   reshape2_1.4.3             
 [69] purrr_0.2.5                 kernlab_0.9-27             
 [71] ica_1.0-2                   pcaPP_1.9-73               
 [73] EDASeq_2.16.0               viridisLite_0.3.0          
 [75] snow_0.4-3                  rtracklayer_1.42.1         
 [77] rlang_0.3.0.1               hexbin_1.27.2              
 [79] manipulateWidget_0.10.0     glue_1.3.0                 
 [81] metap_1.0                   RColorBrewer_1.1-2         
 [83] registry_0.5                fpc_2.1-11.1               
 [85] matrixStats_0.54.0          stringr_1.3.1              
 [87] pkgmaker_0.27               fields_9.6                 
 [89] DESeq2_1.22.1               SparseM_1.77               
 [91] gbRd_0.4-11                 httpuv_1.4.5               
 [93] class_7.3-14                BPSC_0.99.2                
 [95] BiocNeighbors_1.0.0         RMTstat_0.3                
 [97] annotate_1.60.0             webshot_0.5.1              
 [99] jsonlite_1.5                XVector_0.22.0             
[101] bit_1.1-14                  mime_0.6                   
[103] gridExtra_2.3               gplots_3.0.1               
[105] Rsamtools_1.34.0            zingeR_0.1.0               
[107] stringi_1.2.4               gmodels_2.18.1             
[109] gsl_1.9-10.3                bitops_1.0-6               
[111] Rdpack_0.10-1               maps_3.3.0                 
[113] RSQLite_2.1.1               tidyr_0.8.2                
[115] pheatmap_1.0.10             data.table_1.11.8          
[117] DEDS_1.56.0                 energy_1.7-5               
[119] rstudioapi_0.8              GenomicAlignments_1.18.0   
[121] nlme_3.1-137                qvalue_2.14.0              
[123] scran_1.10.1                fastcluster_1.1.25         
[125] scone_1.6.0                 locfit_1.5-9.1             
[127] miniUI_0.1.1.1              cobs_1.3-3                 
[129] R.oo_1.22.0                 prabclus_2.2-6             
[131] segmented_0.5-3.0           BiocGenerics_0.28.0        
[133] readxl_1.1.0                ROTS_1.10.0                
[135] cellranger_1.1.0            munsell_0.5.0              
[137] R.methodsS3_1.7.1           moments_0.14               
[139] hwriter_1.3.2               caTools_1.17.1.1           
[141] codetools_0.2-15            coda_0.19-2                
[143] Biobase_2.42.0              GenomeInfoDb_1.18.1        
[145] vipor_0.4.5                 lmtest_0.9-36              
[147] htmlTable_1.12              rARPACK_0.11-0             
[149] lsei_1.2-0                  xtable_1.8-3               
[151] SAVER_1.1.1                 ROCR_1.0-7                 
[153] diptest_0.75-7              lpsymphony_1.10.0          
[155] abind_1.4-5                 FNN_1.1.2.1                
[157] RANN_2.6                    sparsesvd_0.1-4            
[159] CompQuadForm_1.4.3          GenomicRanges_1.34.0       
[161] bibtex_0.4.2                rgl_0.99.16                
[163] tibble_1.4.2                ggdendro_0.1-20            
[165] cluster_2.0.7-1             Seurat_2.3.4               
[167] Matrix_1.2-15               prettyunits_1.0.2          
[169] shinyBS_0.61                ggridges_0.5.1             
[171] NOISeq_2.26.0               shinydashboard_0.7.1       
[173] mclust_5.4.2                igraph_1.2.2               
[175] slam_0.1-43                 testthat_2.0.1             
[177] doSNOW_1.0.16               htmltools_0.3.6            
[179] GenomicFeatures_1.34.1      XML_3.98-1.16              
[181] DrImpute_1.0                foreign_0.8-71             
[183] withr_2.1.2                 fitdistrplus_1.0-11        
[185] BiocParallel_1.16.1         aroma.light_3.12.0         
[187] bit64_0.9-7                 rngtools_1.3.1             
[189] doRNG_1.7.1                 foreach_1.4.4              
[191] robustbase_0.93-3           outliers_0.14              
[193] scde_2.10.0                 Biostrings_2.50.1          
[195] combinat_0.0-8              rsvd_1.0.0                 
[197] iCOBRA_1.10.0               memoise_1.1.0              
[199] VGAM_1.0-6                  nonnest2_0.5-2             
[201] forcats_0.3.0               rio_0.5.16                 
[203] geneplotter_1.60.0          permute_0.9-4              
[205] curl_3.2                    fdrtool_1.2.15             
[207] trimcluster_0.1-2.1         acepack_1.4.1              
[209] edgeR_3.24.0                checkmate_1.8.5            
[211] npsurv_0.4-0                tensorA_0.36.1             
[213] DECENT_0.99.1               ellipse_0.4.1              
[215] ggplot2_3.1.0               rjson_0.2.20               
[217] openxlsx_4.1.0              ggrepel_0.8.0              
[219] distillery_1.0-4            dtw_1.20-1                 
[221] scDD_1.6.0                  stabledist_0.7-1           
[223] Lmoments_1.2-3              tools_3.5.1                
[225] sandwich_2.5-0              magrittr_1.5               
[227] RCurl_1.95-4.11             proxy_0.4-22               
[229] car_3.0-2                   pbivnorm_0.6.0             
[231] ape_5.2                     bayesm_3.1-0.1             
[233] EBSeq_1.22.0                httr_1.3.1                 
[235] assertthat_0.2.0            boot_1.3-20                
[237] R6_2.3.0                    Rhdf5lib_1.4.1             
[239] nnet_7.3-12                 progress_1.2.0             
[241] genefilter_1.64.0           gtools_3.8.1               
[243] statmod_1.4.30              Rook_1.1-1                 
[245] HDF5Array_1.10.0            rhdf5_2.26.0               
[247] splines_3.5.1               carData_3.0-2              
[249] colorspace_1.3-2            amap_0.8-16                
[251] stats4_3.5.1                NBPSeq_0.3.0               
[253] compositions_1.40-2         base64enc_0.1-3            
[255] baySeq_2.16.0               pillar_1.3.0               
[257] HSMMSingleCell_1.2.0        bindrcpp_0.2.2             
[259] GenomeInfoDbData_1.2.0      plyr_1.8.4                 
[261] extRemes_2.0-9              dotCall64_1.0-0            
[263] gtable_0.2.0                zip_1.0.0                  
[265] SCnorm_1.4.0                monocle_2.10.0             
[267] knitr_1.20                  RcppArmadillo_0.9.200.5.0  
[269] latticeExtra_0.6-28         biomaRt_2.38.0             
[271] IRanges_2.16.0              ADGofTest_0.3              
[273] copula_0.999-18             crosstalk_1.0.0            
[275] Cairo_1.5-9                 doParallel_1.0.14          
[277] pscl_1.5.2                  flexmix_2.3-14             
[279] quantreg_5.36               AnnotationDbi_1.44.0       
[281] broom_0.5.0                 scales_1.0.0               
[283] arm_1.10-1                  backports_1.1.2            
[285] IHW_1.10.0                  S4Vectors_0.20.1           
[287] densityClust_0.3            lme4_1.1-19                
[289] brew_1.0-6                  hms_0.4.2                  
[291] DESeq_1.34.0                Rtsne_0.15                 
[293] dplyr_0.7.8                 shiny_1.2.0                
[295] grid_3.5.1                  numDeriv_2016.8-1          
[297] bbmle_1.0.20                lazyeval_0.2.1             
[299] dynamicTreeCut_1.63-1       Formula_1.2-3              
[301] tsne_0.1-3                  blockmodeling_0.3.1        
[303] crayon_1.3.4                MAST_1.8.0                 
[305] RUVSeq_1.16.0               viridis_0.5.1              
[307] rpart_4.1-13                zinbwave_1.4.0             
[309] compiler_3.5.1 

RNA Bulk pipeline

Hi,

Is there a complete pipeline for bulk data? Tutorial gives only single cell data pipeline.

Inconsistent arguments to functions

Might be related to #35

The example at

powsimR/R/Evaluate.R

Lines 43 to 53 in 62acf47

#' @examples
#' \dontrun{
#' ## using example data set
#' data(kolodziejczk_cnts)
#' evaldist <- evaluateDist(countData = kolodziejczk_cnts,
#' RNAseq = "singlecell", Normalisation="scran",
#' frac.genes=1, min.meancount = 0.1,
#' max.dropout=0.7, min.libsize=1000,
#' verbose = TRUE)
#' plotEvalDist(evaldist, annot = TRUE)
#' }
doesn't run (with version 1.1.5), since the evaluateDist function does not provide a readData argument to .run.checkup. There are additional arguments that are not consistently added across the functions, e.g. Protocol, GeneFilter, SampleFilter.

Installation Issue

Hi,
I am trying to install "powsimR" in R version 4.0.0.
But I am encountering the following error. Can you please help me to resolve the issue.

devtools::install_github("bvieth/powsimR", build_vignettes = TRUE, dependencies = FALSE)
Downloading GitHub repo bvieth/powsimR@master
√ checking for file 'C:\Users\DrKRa\AppData\Local\Temp\Rtmpkvz7Mf\remotes3b2c2bb37131\bvieth-powsimR-dcbe954/DESCRIPTION' ...

  • preparing 'powsimR': (1.1s)
    √ checking DESCRIPTION meta-information ...
  • installing the package to build vignettes
    -----------------------------------
  • installing source package 'powsimR' ...
    ** using staged installation
    ** R
    ** data
    *** moving datasets to lazyload DB
    ** inst
    ** byte-compile and prepare package for lazy loading
    Warning: replacing previous import 'DECENT::lrTest' by 'MAST::lrTest' when loading 'powsimR'
    Error: object 'zlm.SingleCellAssay' is not exported by 'namespace:MAST'
    Execution halted
    ERROR: lazy loading failed for package 'powsimR'
  • removing 'C:/Users/DrKRa/AppData/Local/Temp/Rtmp6BoTWK/Rinst411473b81ffc/powsimR'
    -----------------------------------
    ERROR: package installation failed
    Error: Failed to install 'powsimR' from GitHub:
    System command 'Rcmd.exe' failed, exit status: 1, stdout + stderr (last 10 lines):
    E> *** moving datasets to lazyload DB
    E> ** inst
    E> ** byte-compile and prepare package for lazy loading
    E> Warning: replacing previous import 'DECENT::lrTest' by 'MAST::lrTest' when loading 'powsimR'
    E> Error: object 'zlm.SingleCellAssay' is not exported by 'namespace:MAST'
    E> Execution halted
    E> ERROR: lazy loading failed for package 'powsimR'
    E> * removing 'C:/Users/DrKRa/AppData/Local/Temp/Rtmp6BoTWK/Rinst411473b81ffc/powsimR'
    E> -----------------------------------
    E> ERROR: package installation failed

Thanks
Ramachandra

problems with the DLL max issue

Hello Beate,
I am trying to install powsimR and I am running into the max loaded DLL issues that you mentioned. If I restart R after installing dependencies, and I look at the number of DLL loaded >length(getLoadedDLLs())
12
there are only 12. I even unload stats and tools:
dyn.unload("/Library/Frameworks/R.framework/Versions/3.4/Resources/library/stats/libs/stats.so")
dyn.unload("/Library/Frameworks/R.framework/Versions/3.4/Resources/library/tools/libs/tools.so")

but I still get the same problem:
devtools::install_github("bvieth/powsimR")
Downloading GitHub repo bvieth/powsimR@master
from URL https://api.github.com/repos/bvieth/powsimR/zipball/master
Installing powsimR
'/Library/Frameworks/R.framework/Resources/bin/R' --no-site-file --no-environ --no-save --no-restore --quiet CMD INSTALL
'/private/var/folders/tw/kcbwlvs56ys_x3xnslrmfhrr0000gn/T/Rtmp4QyPQa/devtools1304d1c481da6/bvieth-powsimR-876dd55'
--library='/Library/Frameworks/R.framework/Versions/3.4/Resources/library' --install-tests

  • installing source package ‘powsimR’ ...
    ** R
    ** preparing package for lazy loading

For updates of the NBGOF package, please visit https://github.com/gu-mi/NBGOF

Error : .onLoad failed in loadNamespace() for 'mnormt', details:
call: dyn.load(file, DLLpath = DLLpath, ...)
error: unable to load shared object '/Library/Frameworks/R.framework/Versions/3.4/Resources/library/mnormt/libs/mnormt.so':
`maximal number of DLLs reached...
ERROR: lazy loading failed for package ‘powsimR’

  • removing ‘/Library/Frameworks/R.framework/Versions/3.4/Resources/library/powsimR’
    Installation failed: Command failed (1)

how many dependencies is powsimR loading? Do you have any additional recommendations?

thank you!
Omar

Issues installing

I'm trying to install the package after having installed all the depdencies.
the command

devtools::install_github("bvieth/powsimR", build_vignettes = TRUE, dependencies = FALSE)

fails becasue:

Installing powsimR
svn: E175002: Unable to connect to a repository at URL 'https://hedgehog.fhcrc.org/bioconductor/trunk/madman/Rpacks/S4Vectors'
svn: E175002: OPTIONS of 'https://hedgehog.fhcrc.org/bioconductor/trunk/madman/Rpacks/S4Vectors': could not connect to server (https://hedgehog.fhcrc.org)
Installation failed: There was a problem retrieving the current SVN revision
Warning message:
running command ''/bin/svn' info --xml --username readonly --password readonly https://hedgehog.fhcrc.org/bioconductor/trunk/madman/Rpacks/S4Vectors' had status 1

S4Vector is installed in my system an can be loaded:

> library('S4Vectors')
Loading required package: stats4
Loading required package: BiocGenerics
Loading required package: parallel

Attaching package: ‘BiocGenerics’
[....]

what is triggering the svn command?

error building vignette

Hello, I get some error messages when trying to install powsimR. I was able to build it in the end, but only when I left out the bit about build_vignettes=TRUE. When I had included build_vignettes=TRUE I got an error message that said:
E creating vignettes (lm 0.9s)
--- re-building 'powsimR.Rmd' using rmarkdown
Warning in engine$weave(file, quiet=quiet, enconding=enc):
Pandoc (>=1.12.3) and/or pandoc-citeproc not available. Falling back to R Markdown vi.
Quitting from lines 24-36 (powsimR.rmd)
Error: processing vignette 'powsimR.Rmd' failed with diagonostics:
there is no package called 'rmdformats'
--- failed re-building 'powsimR.Rmd'
SUMMARY: processing the following file failed:
'powsimR.Rmd'
Error: Vignette re-building failed.
Execution halted.
Error: Failed to install 'powsimR' from GitHub.

Here is my sessionInfo:

R version 4.0.2 (2020-06-22)
Platform: x86_64-w64-mingw32/x64 (64-bit)
Running under: Windows 10 x64 (build 18363)

Matrix products: default

locale:
[1] LC_COLLATE=English_United Kingdom.1252 LC_CTYPE=English_United Kingdom.1252 LC_MONETARY=English_United Kingdom.1252 LC_NUMERIC=C LC_TIME=English_United Kingdom.1252

attached base packages:
[1] stats graphics grDevices utils datasets methods base

other attached packages:
[1] powsimR_1.2.3 gamlss.dist_5.1-7 MASS_7.3-51.6 devtools_2.3.1 usethis_1.6.1

loaded via a namespace (and not attached):
[1] mixtools_1.2.0 softImpute_1.4 minpack.lm_1.2-1 lattice_0.20-41 haven_2.3.1 vctrs_0.3.4 fastICA_1.2-2
[8] mgcv_1.8-31 penalized_0.9-51 blob_1.2.1 survival_3.1-12 Rmagic_2.0.3 later_1.1.0.1 nloptr_1.2.2.2
[15] DBI_1.1.0 R.utils_2.10.1 SingleCellExperiment_1.10.1 rappdirs_0.3.1 Linnorm_2.12.0 dqrng_0.2.1 jpeg_0.1-8.1
[22] zlibbioc_1.34.0 MatrixModels_0.4-1 htmlwidgets_1.5.1 mvtnorm_1.1-1 future_1.18.0 UpSetR_1.4.0 parallel_4.0.2
[29] scater_1.16.2 irlba_2.3.3 DEoptimR_1.0-8 Rcpp_1.0.5 KernSmooth_2.23-17 DT_0.15 promises_1.1.1
[36] gdata_2.18.0 DDRTree_0.1.5 DelayedArray_0.14.1 limma_3.44.3 vegan_2.5-6 pkgload_1.1.0 Hmisc_4.4-1
[43] ShortRead_1.46.0 apcluster_1.4.8 RSpectra_0.16-0 fs_1.5.0 msir_1.3.2 mnormt_2.0.2 digest_0.6.25
[50] png_0.1-7 qlcMatrix_0.9.7 sctransform_0.2.1 cowplot_1.1.0 pkgconfig_2.0.3 docopt_0.7.1 DelayedMatrixStats_1.10.1
[57] ggbeeswarm_0.6.0 iterators_1.0.12 minqa_1.2.4 lavaan_0.6-7 reticulate_1.16 SummarizedExperiment_1.18.2 spam_2.5-1
[64] beeswarm_0.2.3 modeltools_0.2-23 xfun_0.17 zoo_1.8-8 tidyselect_1.1.0 ZIM_1.1.0 reshape2_1.4.4
[71] purrr_0.3.4 kernlab_0.9-29 EDASeq_2.22.0 viridisLite_0.3.0 snow_0.4-3 rtracklayer_1.48.0 pkgbuild_1.1.0
[78] rlang_0.4.7 hexbin_1.28.1 glue_1.4.2 RColorBrewer_1.1-2 fpc_2.2-7 matrixStats_0.56.0 stringr_1.4.0
[85] fields_11.4 ggsignif_0.6.0 DESeq2_1.28.1 SparseM_1.78 httpuv_1.5.4 class_7.3-17 BPSC_0.99.2
[92] BiocNeighbors_1.6.0 annotate_1.66.0 jsonlite_1.7.1 XVector_0.28.0 tmvnsim_1.0-2 bit_4.0.4 mime_0.9
[99] gridExtra_2.3 gplots_3.0.4 Rsamtools_2.4.0 zingeR_0.1.0 stringi_1.5.3 gmodels_2.18.1 processx_3.4.4
[106] bitops_1.0-6 cli_2.0.2 maps_3.3.0 RSQLite_2.2.0 tidyr_1.1.2 pheatmap_1.0.12 data.table_1.13.0
[113] rstudioapi_0.11 GenomicAlignments_1.24.0 nlme_3.1-148 qvalue_2.20.0 scran_1.16.0 fastcluster_1.1.25 locfit_1.5-9.4
[120] scone_1.12.0 listenv_0.8.0 cobs_1.3-4 R.oo_1.24.0 prabclus_2.3-2 segmented_1.2-0 dbplyr_1.4.4
[127] BiocGenerics_0.34.0 sessioninfo_1.1.1 readxl_1.3.1 lifecycle_0.2.0 ROTS_1.16.0 munsell_0.5.0 cellranger_1.1.0
[134] R.methodsS3_1.8.1 moments_0.14 hwriter_1.3.2 caTools_1.18.0 codetools_0.2-16 coda_0.19-3 Biobase_2.48.0
[141] GenomeInfoDb_1.24.2 vipor_0.4.5 htmlTable_2.0.1 bayNorm_1.6.0 rARPACK_0.11-0 xtable_1.8-4 SAVER_1.1.2
[148] ROCR_1.0-11 diptest_0.75-7 BiocManager_1.30.10 lpsymphony_1.16.0 abind_1.4-5 FNN_1.1.3 RANN_2.6.1
[155] askpass_1.1 sparsesvd_0.2 CompQuadForm_1.4.3 GenomicRanges_1.40.0 tibble_3.0.3 ggdendro_0.1.22 cluster_2.1.0
[162] future.apply_1.6.0 Matrix_1.2-18 ellipsis_0.3.1 prettyunits_1.1.1 shinyBS_0.61 NOISeq_2.31.0 shinydashboard_0.7.1
[169] mclust_5.4.6 igraph_1.2.5 ggstance_0.3.4 remotes_2.2.0 slam_0.1-47 testthat_2.3.2 doSNOW_1.0.18
[176] htmltools_0.5.0 BiocFileCache_1.12.1 GenomicFeatures_1.40.1 XML_3.99-0.5 ggpubr_0.4.0 DrImpute_1.0 foreign_0.8-80
[183] withr_2.2.0 fitdistrplus_1.1-1 BiocParallel_1.22.0 aroma.light_3.18.0 bit64_4.0.5 foreach_1.5.0 robustbase_0.93-6
[190] outliers_0.14 Biostrings_2.56.0 combinat_0.0-8 rsvd_1.0.3 iCOBRA_1.16.0 memoise_1.1.0 VGAM_1.1-3
[197] nonnest2_0.5-5 forcats_0.5.0 rio_0.5.16 geneplotter_1.66.0 permute_0.9-5 callr_3.4.4 ps_1.3.4
[204] curl_4.3 fdrtool_1.2.15 fansi_0.4.1 conquer_1.0.2 edgeR_3.30.3 checkmate_2.0.0 desc_1.2.0
[211] truncnorm_1.0-8 tensorA_0.36.1 DECENT_1.1.0 ellipse_0.4.2 ggplot2_3.3.2 openxlsx_4.1.5 rstatix_0.6.0
[218] ggrepel_0.8.2 scDD_1.12.0 rprojroot_1.3-2 tools_4.0.2 sandwich_2.5-1 magrittr_1.5 RCurl_1.98-1.2
[225] car_3.0-9 pbivnorm_0.6.0 bayesm_3.1-4 EBSeq_1.28.0 httr_1.4.2 assertthat_0.2.1 Rhdf5lib_1.10.1
[232] boot_1.3-25 globals_0.12.5 R6_2.4.1 nnet_7.3-14 progress_1.2.2 genefilter_1.70.0 gtools_3.8.2
[239] statmod_1.4.34 BiocSingular_1.4.0 rhdf5_2.32.2 splines_4.0.2 carData_3.0-4 colorspace_1.4-1 amap_0.8-18
[246] generics_0.0.2 stats4_4.0.2 NBPSeq_0.3.0 compositions_2.0-0 base64enc_0.1-3 baySeq_2.22.0 pillar_1.4.6
[253] HSMMSingleCell_1.8.0 GenomeInfoDbData_1.2.3 plyr_1.8.6 dotCall64_1.0-0 gtable_0.3.0 zip_2.1.1 SCnorm_1.10.0
[260] monocle_2.16.0 knitr_1.29 RcppArmadillo_0.9.900.3.0 latticeExtra_0.6-29 biomaRt_2.44.1 IRanges_2.22.2 fastmap_1.0.1
[267] doParallel_1.0.15 pscl_1.5.5 flexmix_2.3-15 quantreg_5.67 AnnotationDbi_1.50.3 broom_0.7.0 openssl_1.4.2
[274] scales_1.1.1 arm_1.11-2 backports_1.1.9 plotrix_3.7-8 IHW_1.16.0 S4Vectors_0.26.1 densityClust_0.3
[281] lme4_1.1-23 hms_0.5.3 DESeq_1.39.0 Rtsne_0.15 dplyr_1.0.2 shiny_1.5.0 grid_4.0.2
[288] Formula_1.2-3 blockmodeling_1.0.0 crayon_1.3.4 MAST_1.14.0 RUVSeq_1.22.0 viridis_0.5.1 rpart_4.1-15
[295] zinbwave_1.10.0 compiler_4.0.2

issue similar to the one Vivianstats posted

Hello!
I got your package to install on an older computer a couple months ago but it was too slow to do any simulations.

I have since tried to install powsimR on a computing cluster and a newer computer and have had many issues.

I get this problem on both installs. It seems to be related to the problem Vivianstats posted a few days back. Any ideas about what I should do?

Thanks so much!

sim1.params <- estimateParam(countData=cnts,
batchData = NULL,
spikeData = NULL,
spikeInfo = NULL,
Lengths = NULL,
MeanFragLengths = NULL,
Distribution = 'NB',
RNAseq = 'singlecell',
normalisation = 'scran',
sigma = 1.96,
NCores = NULL)
Error in scater::calculateQCMetrics(sce, nmads = 3) :
unused argument (nmads = 3)

sessionInfo()

Will not install on R 3.5.1

Looks like some packages have set R > 3.6.0 as requirement, thus fresh install of powsimR does not install on R 3.5.1 anymore.

I believe the problematic packages are fpc, amap, rngtools.

powsimR installation forces BASiCS download

Hello again,

I am just trying to install powsimR onto my work computer and although I already have BASiCS installed, the installation of powsimR overrides it and re-installs it again. Is there a way around this as it is creating a conflict with the various requirements of R versions? I attach the error below.
With many thanks,
Hania

devtools::install_github("bvieth/powsimR", build_vignettes = FALSE)
Downloading GitHub repo bvieth/powsimR@master
from URL https://api.github.com/repos/bvieth/powsimR/zipball/master
Installing powsimR
Skipping install for github remote, the SHA1 (d5d27442) has not changed since last install.
Use force = TRUE to force installation
Skipping install for github remote, the SHA1 (1fe6f32d) has not changed since last install.
Use force = TRUE to force installation
Downloading GitHub repo catavallejos/BASiCS@master
from URL https://api.github.com/repos/catavallejos/BASiCS/zipball/master
Installing BASiCS
Skipping 1 unavailable package: SingleCellExperiment
Skipping 1 package ahead of CRAN: AnnotationDbi
Installing 1 package: XML
trying URL 'https://cran.rstudio.com/src/contrib/XML_3.98-1.9.tar.gz'
Content type 'application/x-gzip' length 1599437 bytes (1.5 MB)
==================================================
downloaded 1.5 MB

  • installing source package ‘XML’ ...
    ** package ‘XML’ successfully unpacked and MD5 sums checked
    checking for gcc... gcc
    checking for C compiler default output file name... a.out
    checking whether the C compiler works... yes
    checking whether we are cross compiling... no
    checking for suffix of executables...
    checking for suffix of object files... o
    checking whether we are using the GNU C compiler... yes
    checking whether gcc accepts -g... yes
    checking for gcc option to accept ISO C89... none needed
    checking how to run the C preprocessor... gcc -E
    checking for sed... /bin/sed
    checking for pkg-config... /usr/bin/pkg-config
    checking for xml2-config... /ifs/devel/haniap/py35-v1/conda/envs/py35-v1/bin/xml2-config
    USE_XML2 = yes
    SED_EXTENDED_ARG: -E
    Minor 9, Patch 4 for 2.9.4
    Located parser file -I/ifs/devel/haniap/py35-v1/conda/envs/py35-v1/include/libxml2 -I/ifs/devel/haniap/py35-v1/conda/envs/py35-v1/include/parser.h
    Checking for 1.8: -I/ifs/devel/haniap/py35-v1/conda/envs/py35-v1/include/libxml2 -I/ifs/devel/haniap/py35-v1/conda/envs/py35-v1/include
    Using libxml2.*
    checking for gzopen in -lz... yes
    checking for xmlParseFile in -lxml2... yes
    You are trying to use a version 2.* edition of libxml
    but an incompatible library. The header files and library seem to be
    mismatched. If you have specified LIBXML_INCDIR, make certain to also
    specify an appropriate LIBXML_LIBDIR if the libxml2 library is not in the default
    directories.
    ERROR: configuration failed for package ‘XML’
  • removing ‘/ifs/devel/haniap/py35-v1/conda/envs/py35-v1/lib/R/library/XML’
  • restoring previous ‘/ifs/devel/haniap/py35-v1/conda/envs/py35-v1/lib/R/library/XML’

The downloaded source packages are in
‘/tmp/RtmpakBR97/downloaded_packages’
Updating HTML index of packages in '.Library'
Making 'packages.html' ... done
'/ifs/devel/haniap/py35-v1/conda/envs/py35-v1/lib/R/bin/R' --no-site-file --no-environ --no-save --no-restore
--quiet CMD INSTALL '/tmp/RtmpakBR97/devtools12d227c3df23/catavallejos-BASiCS-94c4666'
--library='/ifs/devel/haniap/py35-v1/conda/envs/py35-v1/lib/R/library' --install-tests

ERROR: this R is version 3.3.1, package 'BASiCS' requires R >= 3.4
Error: Command failed (1)
In addition: Warning message:
In utils::install.packages(pkgs, repos = repos, type = type, dependencies = dependencies, :
installation of package ‘XML’ had non-zero exit status

Issue regarding 'hdf5r' when installing

Hi,

I'm installing powsimR, but ran into the issue below. Do you have any suggestions on how to tackle this?

Thanks!

Sander

> cranpackages <- c("bbmle", "broom", "cluster", "cobs", "cowplot", "data.table",
+     "doParallel", "dplyr", "drc", "DrImpute", "fastICA", "fitdistrplus", "foreach",
+     "gamlss.dist", "ggExtra", "ggplot2", "ggthemes", "grDevices", "glmnet",
+     "grid", "gtools", "Hmisc", "kernlab", "MASS", "matrixStats", "mclust", "methods",
+     "minpack.lm", "moments", "msir", "NBPSeq", "nonnest2", "parallel", "penalized",
+     "plyr", "pscl", "reshape2", "ROCR", "Rtsne", "scales", "Seurat", "snow",
+     "stats", "tibble", "tidyr", "VGAM", "ZIM")
> ipak(cranpackages, repository = "CRAN")
Installing package into ‘/usr/local/lib/R/3.5/site-library’
(as ‘lib’ is unspecified)
Warning: dependency ‘loomR’ is not available
also installing the dependency ‘hdf5r’

trying URL 'https://cloud.r-project.org/src/contrib/hdf5r_1.0.0.tar.gz'
Content type 'application/x-gzip' length 1623251 bytes (1.5 MB)
==================================================
downloaded 1.5 MB

trying URL 'https://cloud.r-project.org/src/contrib/Seurat_2.3.2.tar.gz'
Content type 'application/x-gzip' length 1172401 bytes (1.1 MB)
==================================================
downloaded 1.1 MB

* installing *source* package ‘hdf5r’ ...
** package ‘hdf5r’ successfully unpacked and MD5 sums checked
checking for a sed that does not truncate output... /usr/bin/sed
checking for gawk... no
checking for mawk... no
checking for nawk... no
checking for awk... awk
checking for grep that handles long lines and -e... /usr/bin/grep
checking for gcc... gcc
checking whether the C compiler works... yes
checking for C compiler default output file name... a.out
checking for suffix of executables...
checking whether we are cross compiling... no
checking for suffix of object files... o
checking whether we are using the GNU C compiler... yes
checking whether gcc accepts -g... yes
checking for gcc option to accept ISO C89... none needed
checking how to run the C preprocessor... gcc -E
checking for egrep... /usr/bin/grep -E
checking for ANSI C header files... yes
checking for sys/types.h... yes
checking for sys/stat.h... yes
checking for stdlib.h... yes
checking for string.h... yes
checking for memory.h... yes
checking for strings.h... yes
checking for inttypes.h... yes
checking for stdint.h... yes
checking for unistd.h... yes
checking for h5cc... /usr/local/bin/h5cc
checking for HDF5 libraries... yes (version 1.10.2)
checking hdf5.h usability... yes
checking hdf5.h presence... yes
checking for hdf5.h... yes
checking for H5Fcreate in -lhdf5... yes
checking for hdf5_hl.h... yes
checking for H5LTpath_valid in -lhdf5_hl... yes
checking for main in -lhdf5_hl... yes
checking for matching HDF5 Fortran wrapper... no
Found hdf5 with version: 1.10.2
checking for ggrep... /usr/bin/grep
checking whether /usr/bin/grep accepts -o... yes
checking for ggrep... (cached) /usr/bin/grep
checking whether /usr/bin/grep accepts -o... yes
configure: creating ./config.status
config.status: creating src/Makevars
** libs
cp 1_10_0/*.c 1_10_0/*.h .
clang -I"/usr/local/Cellar/r/3.5.0_1/lib/R/include" -DNDEBUG -I/usr/local/Cellar/hdf5/1.10.2_1/include -I/usr/local/opt/szip/include   -I/usr/local/opt/gettext/include -I/usr/local/opt/readline/include -I/usr/local/include  -D_DEFINE_H5FREE_MEMORY_=0 -D__USE_MINGW_ANSI_STDIO -fPIC  -g -O2  -c const_export.c -o const_export.o
clang -I"/usr/local/Cellar/r/3.5.0_1/lib/R/include" -DNDEBUG -I/usr/local/Cellar/hdf5/1.10.2_1/include -I/usr/local/opt/szip/include   -I/usr/local/opt/gettext/include -I/usr/local/opt/readline/include -I/usr/local/include  -D_DEFINE_H5FREE_MEMORY_=0 -D__USE_MINGW_ANSI_STDIO -fPIC  -g -O2  -c datatype_export.c -o datatype_export.o
datatype_export.c:1496:12: error: use of undeclared identifier 'H5D_MPIO_FILTERS'
  myenum = H5D_MPIO_FILTERS;
           ^
1 error generated.
make: *** [datatype_export.o] Error 1
ERROR: compilation failed for package ‘hdf5r’
* removing ‘/usr/local/lib/R/3.5/site-library/hdf5r’
ERROR: dependency ‘hdf5r’ is not available for package ‘Seurat’
* removing ‘/usr/local/lib/R/3.5/site-library/Seurat’

The downloaded source packages are in
	‘/private/var/folders/cx/hpd8ycld4mv23s09ms_30rgc0000gn/T/Rtmphehs6F/downloaded_packages’
Warning messages:
1: In install.packages(new.pkg, dependencies = TRUE) :
  installation of package ‘hdf5r’ had non-zero exit status
2: In install.packages(new.pkg, dependencies = TRUE) :
  installation of package ‘Seurat’ had non-zero exit status

Not all packages installed?

Hello. Not sure if this is an issue. The website shows 331 lines of tools/packages after installation. My installation shows only 305. Would this be due to R version?

library(powsimR)
Loading required package: gamlss.dist
Loading required package: MASS
Warning messages:
1: replacing previous import ‘DECENT::lrTest’ by ‘MAST::lrTest’ when loading ‘powsimR’
2: replacing previous import ‘parallel::makeCluster’ by ‘snow::makeCluster’ when loading ‘powsimR’
3: replacing previous import ‘parallel::stopCluster’ by ‘snow::stopCluster’ when loading ‘powsimR’
4: replacing previous import ‘penalized::predict’ by ‘stats::predict’ when loading ‘powsimR’
5: replacing previous import ‘zinbwave::glmWeightedF’ by ‘zingeR::glmWeightedF’ when loading ‘powsimR’
sessionInfo()
R version 3.4.3 (2017-11-30)
Platform: x86_64-pc-linux-gnu (64-bit)
Running under: Scientific Linux 7.3 (Nitrogen)

Matrix products: default
BLAS: /usr/lib64/libblas.so.3.4.2
LAPACK: /usr/lib64/liblapack.so.3.4.2

locale:
[1] LC_CTYPE=en_US.UTF-8 LC_NUMERIC=C
[3] LC_TIME=en_US.UTF-8 LC_COLLATE=en_US.UTF-8
[5] LC_MONETARY=en_US.UTF-8 LC_MESSAGES=en_US.UTF-8
[7] LC_PAPER=en_US.UTF-8 LC_NAME=C
[9] LC_ADDRESS=C LC_TELEPHONE=C
[11] LC_MEASUREMENT=en_US.UTF-8 LC_IDENTIFICATION=C

attached base packages:
[1] stats graphics grDevices utils datasets methods base

other attached packages:
[1] powsimR_1.1.2 gamlss.dist_5.0-6 MASS_7.3-50

loaded via a namespace (and not attached):
[1] mixtools_1.1.0 softImpute_1.4
[3] minpack.lm_1.2-1 pbapply_1.3-4
[5] lattice_0.20-35 haven_1.1.2
[7] fastICA_1.2-1 mgcv_1.8-24
[9] penalized_0.9-51 blob_1.1.1
[11] survival_2.42-6 later_0.7.3
[13] nloptr_1.0.4 DBI_1.0.0
[15] R.utils_2.6.0 SingleCellExperiment_1.0.0
[17] Linnorm_2.2.0 bindr_0.1.1
[19] zlibbioc_1.24.0 MatrixModels_0.4-1
[21] pspline_1.0-18 pcaMethods_1.70.0
[23] SDMTools_1.1-221 htmlwidgets_1.2
[25] mvtnorm_1.0-8 hdf5r_1.0.0
[27] UpSetR_1.3.3 parallel_3.4.3
[29] scater_1.6.3 irlba_2.3.2
[31] DEoptimR_1.0-8 lars_1.2
[33] Rcpp_0.12.18 KernSmooth_2.23-15
[35] DT_0.4 promises_1.0.1
[37] gdata_2.18.0 DDRTree_0.1.5
[39] DelayedArray_0.4.1 limma_3.34.9
[41] vegan_2.5-2 Hmisc_4.1-1
[43] ShortRead_1.36.1 apcluster_1.4.7
[45] RSpectra_0.13-1 msir_1.3.1
[47] mnormt_1.5-5 digest_0.6.15
[49] RMySQL_0.10.15 png_0.1-7
[51] qlcMatrix_0.9.7 cowplot_0.9.3
[53] glmnet_2.0-16 pkgconfig_2.0.1
[55] docopt_0.6 ggbeeswarm_0.6.0
[57] iterators_1.0.10 minqa_1.2.4
[59] lavaan_0.6-2 reticulate_1.10
[61] SummarizedExperiment_1.8.1 spam_2.2-0
[63] beeswarm_0.2.3 modeltools_0.2-22
[65] RcppNumerical_0.3-2 zoo_1.8-3
[67] tidyselect_0.2.4 ZIM_1.0.3
[69] reshape2_1.4.3 purrr_0.2.5
[71] kernlab_0.9-26 ica_1.0-2
[73] pcaPP_1.9-73 EDASeq_2.12.0
[75] viridisLite_0.3.0 snow_0.4-2
[77] rtracklayer_1.38.3 rlang_0.2.1
[79] hexbin_1.27.2 manipulateWidget_0.10.0
[81] glue_1.3.0 metap_1.0
[83] RColorBrewer_1.1-2 registry_0.5
[85] fpc_2.1-11.1 matrixStats_0.54.0
[87] stringr_1.3.1 pkgmaker_0.27
[89] fields_9.6 DESeq2_1.18.1
[91] SparseM_1.77 gbRd_0.4-11
[93] httpuv_1.4.5 class_7.3-14
[95] BPSC_0.99.1 RMTstat_0.3
[97] annotate_1.56.2 webshot_0.5.0
[99] jsonlite_1.5 XVector_0.18.0
[101] bit_1.1-14 mime_0.5
[103] gridExtra_2.3 gplots_3.0.1
[105] Rsamtools_1.30.0 zingeR_0.1.0
[107] stringi_1.2.4 gmodels_2.18.1
[109] gsl_1.9-10.3 bitops_1.0-6
[111] Rdpack_0.9-0 maps_3.3.0
[113] RSQLite_2.1.1 tidyr_0.8.1
[115] pheatmap_1.0.10 data.table_1.11.4
[117] DEDS_1.52.0 energy_1.7-4
[119] rstudioapi_0.7 GenomicAlignments_1.14.2
[121] nlme_3.1-137 qvalue_2.10.0
[123] scran_1.6.9 fastcluster_1.1.25
[125] locfit_1.5-9.1 scone_1.2.0
[127] miniUI_0.1.1.1 cobs_1.3-3
[129] R.oo_1.22.0 prabclus_2.2-6
[131] segmented_0.5-3.0 BiocGenerics_0.24.0
[133] readxl_1.1.0 ROTS_1.6.0
[135] munsell_0.5.0 cellranger_1.1.0
[137] R.methodsS3_1.7.1 moments_0.14
[139] hwriter_1.3.2 caTools_1.17.1.1
[141] codetools_0.2-15 coda_0.19-1
[143] Biobase_2.38.0 GenomeInfoDb_1.14.0
[145] vipor_0.4.5 lmtest_0.9-36
[147] htmlTable_1.12 rARPACK_0.11-0
[149] xtable_1.8-2 SAVER_1.0.0
[151] ROCR_1.0-7 diptest_0.75-7
[153] lpsymphony_1.7.1 abind_1.4-5
[155] FNN_1.1.2 RANN_2.6
[157] sparsesvd_0.1-4 CompQuadForm_1.4.3
[159] GenomicRanges_1.30.3 bibtex_0.4.2
[161] rgl_0.99.16 tibble_1.4.2
[163] ggdendro_0.1-20 cluster_2.0.7-1
[165] Seurat_2.3.4 Matrix_1.2-14
[167] prettyunits_1.0.2 shinyBS_0.61
[169] ggridges_0.5.0 NOISeq_2.22.1
[171] shinydashboard_0.7.0 mclust_5.4.1
[173] igraph_1.2.2 slam_0.1-43
[175] testthat_2.0.0 doSNOW_1.0.16
[177] htmltools_0.3.6 GenomicFeatures_1.30.3
[179] XML_3.98-1.13 DrImpute_1.0
[181] foreign_0.8-71 withr_2.1.2
[183] fitdistrplus_1.0-9 BiocParallel_1.12.0
[185] aroma.light_3.8.0 bit64_0.9-7
[187] rngtools_1.3.1 doRNG_1.7.1
[189] foreach_1.4.4 robustbase_0.93-2
[191] outliers_0.14 scde_2.6.0
[193] Biostrings_2.46.0 combinat_0.0-8
[195] iCOBRA_1.6.0 memoise_1.1.0
[197] VGAM_1.0-5 nonnest2_0.5-1
[199] forcats_0.3.0 rio_0.5.10
[201] geneplotter_1.56.0 permute_0.9-4
[203] curl_3.2 fdrtool_1.2.15
[205] trimcluster_0.1-2.1 acepack_1.4.1
[207] edgeR_3.20.9 checkmate_1.8.5
[209] tensorA_0.36.1 DECENT_0.2.0
[211] ellipse_0.4.1 ggplot2_3.0.0
[213] rjson_0.2.20 openxlsx_4.1.0
[215] ggrepel_0.8.0 distillery_1.0-4
[217] dtw_1.20-1 scDD_1.2.0
[219] stabledist_0.7-1 Lmoments_1.2-3
[221] tools_3.4.3 sandwich_2.4-0
[223] magrittr_1.5 RCurl_1.95-4.11
[225] proxy_0.4-22 car_3.0-0
[227] pbivnorm_0.6.0 ape_5.1
[229] bayesm_3.1-0.1 EBSeq_1.18.0
[231] httr_1.3.1 assertthat_0.2.0
[233] boot_1.3-20 R6_2.2.2
[235] nnet_7.3-12 progress_1.2.0
[237] tximport_1.6.0 genefilter_1.60.0
[239] gtools_3.8.1 statmod_1.4.30
[241] Rook_1.1-1 rhdf5_2.22.0
[243] splines_3.4.3 carData_3.0-1
[245] colorspace_1.3-2 amap_0.8-16
[247] stats4_3.4.3 NBPSeq_0.3.0
[249] compositions_1.40-2 base64enc_0.1-3
[251] baySeq_2.12.0 pillar_1.3.0
[253] HSMMSingleCell_0.112.0 bindrcpp_0.2.2
[255] GenomeInfoDbData_1.0.0 plyr_1.8.4
[257] extRemes_2.0-9 dotCall64_1.0-0
[259] gtable_0.2.0 zip_1.0.0
[261] SCnorm_1.0.0 monocle_2.6.4
[263] knitr_1.20 RcppArmadillo_0.8.600.0.0
[265] latticeExtra_0.6-28 biomaRt_2.34.2
[267] IRanges_2.12.0 ADGofTest_0.3
[269] copula_0.999-18 crosstalk_1.0.0
[271] Cairo_1.5-9 doParallel_1.0.11
[273] pscl_1.5.2 flexmix_2.3-14
[275] quantreg_5.36 AnnotationDbi_1.40.0
[277] broom_0.5.0 scales_0.5.0
[279] arm_1.10-1 backports_1.1.2
[281] IHW_1.6.0 S4Vectors_0.16.0
[283] densityClust_0.3 lme4_1.1-17
[285] brew_1.0-6 hms_0.4.2
[287] DESeq_1.30.0 Rtsne_0.13
[289] dplyr_0.7.6 shiny_1.1.0
[291] grid_3.4.3 numDeriv_2016.8-1
[293] bbmle_1.0.20 lazyeval_0.2.1
[295] dynamicTreeCut_1.63-1 Formula_1.2-3
[297] tsne_0.1-3 blockmodeling_0.3.1
[299] crayon_1.3.4 MAST_1.4.1
[301] RUVSeq_1.12.0 viridis_0.5.1
[303] rpart_4.1-13 zinbwave_1.0.0
[305] compiler_3.4.3

installation error

Hello,

I got the following error while trying to install powsimR using the source package:

ERROR: dependency ‘DECENT’ is not available for package ‘powsimR’

I could not find DECENT either from CRAN or Bioconductor. Am I missing something here?

Thanks!

Max DLL issue revisited

I'm attempting to install powsimR on a Mac, and hitting the DLL limit even after setting it to the maximum number possible (153).

Here's the error message:

Error in dyn.load(file, DLLpath = DLLpath, ...) :
unable to load shared object '/Library/Frameworks/R.framework/Versions/3.4/Resources/library/nloptr/libs/nloptr.so':
`maximal number of DLLs reached...
ERROR: lazy loading failed for package ‘powsimR’

  • removing ‘/Library/Frameworks/R.framework/Versions/3.4/Resources/library/powsimR’
    Installation failed: Command failed (1)

And here's the sessionInfo() output:

R version 3.4.3 (2017-11-30)
Platform: x86_64-apple-darwin15.6.0 (64-bit)
Running under: macOS Sierra 10.12.6

Matrix products: default
BLAS: /System/Library/Frameworks/Accelerate.framework/Versions/A/Frameworks/vecLib.framework/Versions/A/libBLAS.dylib
LAPACK: /Library/Frameworks/R.framework/Versions/3.4/Resources/lib/libRlapack.dylib

locale:
[1] en_US.UTF-8/en_US.UTF-8/en_US.UTF-8/C/en_US.UTF-8/en_US.UTF-8

attached base packages:
[1] stats graphics grDevices utils datasets methods base

loaded via a namespace (and not attached):
[1] compiler_3.4.3 tools_3.4.3 yaml_2.1.18

Installation failed

Hi,
I have been trying to install powsimR however i am having some issues, i have read a few of the closed posts from other users and your advice but none of them helped thus far. I am using a windows machine with Rstudio and R version 3.4.4. version 3.5 doesnt work , apparently there is no version of Rtools currently available for R 3.5 or at least that is the error message i am getting. so i moved back to R 3.4.4. then I did exactly what was suggested but I am still having trouble.
any input will be greatly appreciated.
here is the log:

ipak <- function(pkg, repository = c("CRAN", "Bioconductor", "github")) {

  • new.pkg <- pkg[!(pkg %in% installed.packages()[, "Package"])]
    
  • # new.pkg <- pkg
    
  • if (length(new.pkg)) {
    
  •     if (repository == "CRAN") {
    
  •         install.packages(new.pkg, dependencies = TRUE)
    
  •     }
    
  •     if (repository == "Bioconductor") {
    
  •         source("https://bioconductor.org/biocLite.R")
    
  •         biocLite(new.pkg, dependencies = TRUE, ask = FALSE)
    
  •     }
    
  •     if (repository == "github") {
    
  •         devtools::install_github(new.pkg, build_vignettes = FALSE, dependencies = TRUE)
    
  •     }
    
  • }
    
  • }

CRAN PACKAGES

cranpackages <- c("bbmle", "broom", "cobs", "cowplot", "data.table", "devtools",

  •               "doParallel", "dplyr", "drc", "DrImpute", "fastICA", "fitdistrplus", "foreach", 
    
  •               "gamlss.dist", "ggExtra", "ggplot2", "ggthemes", "grDevices", "glmnet", 
    
  •               "grid", "gtools", "Hmisc", "kernlab", "MASS", "matrixStats", "mclust", "methods", 
    
  •               "minpack.lm", "moments", "msir", "NBPSeq", "nonnest2", "parallel", "penalized", 
    
  •               "plyr", "pscl", "reshape2", "ROCR", "Rtsne", "scales", "Seurat", "snow", 
    
  •               "stats", "tibble", "tidyr", "VGAM", "ZIM")
    

ipak(cranpackages, repository = "CRAN")

BIOCONDUCTOR

biocpackages <- c("AnnotationDbi", "baySeq", "Biobase", "BiocGenerics", "BiocParallel",

  •               "DEDS", "DESeq2", "EBSeq", "edgeR", "IHW", "iCOBRA", "limma", "Linnorm", 
    
  •               "MAST", "monocle", "NOISeq", "qvalue", "ROTS", "RUVSeq", "S4Vectors", "scater", 
    
  •               "scDD", "scde", "scone", "scran", "SCnorm", "SingleCellExperiment", "SummarizedExperiment", 
    
  •               "zinbwave")
    

ipak(biocpackages, repository = "Bioconductor")

GITHUB

githubpackages <- c("nghiavtr/BPSC", "cz-ye/DECENT", "mohuangx/SAVER", "statOmics/zingeR")
ipak(githubpackages, repository = "github")
Downloading GitHub repo nghiavtr/BPSC@master
from URL https://api.github.com/repos/nghiavtr/BPSC/zipball/master
Installing BPSC
"C:/PROGRA1/R/R-341.4/bin/x64/R" --no-site-file --no-environ --no-save --no-restore
--quiet CMD INSTALL
"C:/Users/gcrynen/AppData/Local/Temp/Rtmpg5DfOm/devtools2fe076323993/nghiavtr-BPSC-1fe6f32"
--library="C:/Users/gcrynen/Documents/R/win-library/3.4" --install-tests

  • installing source package 'BPSC' ...
    ** R
    ** inst
    ** preparing package for lazy loading
    ** help
    *** installing help indices
    converting help for package 'BPSC'
    finding HTML links ... done
    BPSC-package html
    BPfam html
    BPglm html
    estimateBP html
    estimateBPMatrix html
    getBPMCnull html
    getBPMCnullmatrix html
    getBin html
    getInitParam html
    getMCpval html
    getTbreak html
    meanBP html
    pBP html
    pBPi html
    rBP html
    summary.BPglm html
    varBP html
    ** building package indices
    ** installing vignettes
    'BPSC.Rnw'
    Warning in test_latex_pkg("framed", system.file("misc", "framed.sty", package = "knitr")) :
    unable to find LaTeX package 'framed'; will use a copy from knitr
    ** testing if installed package can be loaded
    *** arch - i386
    *** arch - x64

  • DONE (BPSC)
    In R CMD INSTALL
    Downloading GitHub repo cz-ye/DECENT@master
    from URL https://api.github.com/repos/cz-ye/DECENT/zipball/master
    Installing DECENT
    "C:/PROGRA1/R/R-341.4/bin/x64/R" --no-site-file --no-environ --no-save --no-restore
    --quiet CMD INSTALL
    "C:/Users/gcrynen/AppData/Local/Temp/Rtmpg5DfOm/devtools2fe0112a1c87/cz-ye-DECENT-fb9a045"
    --library="C:/Users/gcrynen/Documents/R/win-library/3.4" --install-tests

  • installing source package 'DECENT' ...
    ** libs

*** arch - i386
C:/RBuildTools/3.4/mingw_32/bin/g++ -I"C:/PROGRA1/R/R-341.4/include" -DNDEBUG -I"C:/Users/gcrynen/Documents/R/win-library/3.4/Rcpp/include" -I"C:/Users/gcrynen/Documents/R/win-library/3.4/RcppEigen/include" -I"C:/Users/gcrynen/Documents/R/win-library/3.4/RcppNumerical/include" -O2 -Wall -mtune=generic -c LRT_logl.cpp -o LRT_logl.o
C:/RBuildTools/3.4/mingw_32/bin/g++ -I"C:/PROGRA1/R/R-341.4/include" -DNDEBUG -I"C:/Users/gcrynen/Documents/R/win-library/3.4/Rcpp/include" -I"C:/Users/gcrynen/Documents/R/win-library/3.4/RcppEigen/include" -I"C:/Users/gcrynen/Documents/R/win-library/3.4/RcppNumerical/include" -O2 -Wall -mtune=generic -c RcppExports.cpp -o RcppExports.o
C:/RBuildTools/3.4/mingw_32/bin/g++ -shared -s -static-libgcc -o DECENT.dll tmp.def LRT_logl.o RcppExports.o -LC:/PROGRA1/R/R-341.4/bin/i386 -lR
installing to C:/Users/gcrynen/Documents/R/win-library/3.4/DECENT/libs/i386

*** arch - x64
C:/RBuildTools/3.4/mingw_64/bin/g++ -I"C:/PROGRA1/R/R-341.4/include" -DNDEBUG -I"C:/Users/gcrynen/Documents/R/win-library/3.4/Rcpp/include" -I"C:/Users/gcrynen/Documents/R/win-library/3.4/RcppEigen/include" -I"C:/Users/gcrynen/Documents/R/win-library/3.4/RcppNumerical/include" -O2 -Wall -mtune=generic -c LRT_logl.cpp -o LRT_logl.o
C:/RBuildTools/3.4/mingw_64/bin/g++ -I"C:/PROGRA1/R/R-341.4/include" -DNDEBUG -I"C:/Users/gcrynen/Documents/R/win-library/3.4/Rcpp/include" -I"C:/Users/gcrynen/Documents/R/win-library/3.4/RcppEigen/include" -I"C:/Users/gcrynen/Documents/R/win-library/3.4/RcppNumerical/include" -O2 -Wall -mtune=generic -c RcppExports.cpp -o RcppExports.o
C:/RBuildTools/3.4/mingw_64/bin/g++ -shared -s -static-libgcc -o DECENT.dll tmp.def LRT_logl.o RcppExports.o -LC:/PROGRA1/R/R-341.4/bin/x64 -lR
installing to C:/Users/gcrynen/Documents/R/win-library/3.4/DECENT/libs/x64
** R
** data
*** moving datasets to lazyload DB
** preparing package for lazy loading
** help
*** installing help indices
converting help for package 'DECENT'
finding HTML links ... done
Estep2ByGene html
EstepByGene html
MstepNB html
calc2DOProb html
calc2NBProb html
calc2PoisProb html
calcDOProb html
calcNBProb html
dbetabinom2 html
dbinom2 html
decent html
dnbinom2 html
dpois2 html
fitDE html
fitNoDE html
getImputed html
loglI html
loglI2 html
lrTest html
sim html
zinbGrad html
** building package indices
** testing if installed package can be loaded
*** arch - i386
*** arch - x64

  • DONE (DECENT)
    In R CMD INSTALL
    Downloading GitHub repo mohuangx/SAVER@master
    from URL https://api.github.com/repos/mohuangx/SAVER/zipball/master
    Installing SAVER
    "C:/PROGRA1/R/R-341.4/bin/x64/R" --no-site-file --no-environ --no-save --no-restore
    --quiet CMD INSTALL
    "C:/Users/gcrynen/AppData/Local/Temp/Rtmpg5DfOm/devtools2fe019ed2c37/mohuangx-SAVER-b2e9ff0"
    --library="C:/Users/gcrynen/Documents/R/win-library/3.4" --install-tests

  • installing source package 'SAVER' ...
    ** R
    ** data
    *** moving datasets to lazyload DB
    ** preparing package for lazy loading
    ** help
    *** installing help indices
    converting help for package 'SAVER'
    finding HTML links ... done
    SAVER-package html
    calc.maxcor html
    calc.post html
    calc_estimate html
    calc_loglik html
    combine.saver html
    cor_adjust html
    expr.predict html
    linnarsson html
    optimize_variance html
    sample.saver html
    saver html
    saver_fit html
    ** building package indices
    ** testing if installed package can be loaded
    *** arch - i386
    *** arch - x64

  • DONE (SAVER)
    In R CMD INSTALL
    Downloading GitHub repo statOmics/zingeR@master
    from URL https://api.github.com/repos/statOmics/zingeR/zipball/master
    Installing zingeR
    Installing 1 package: DESeq2
    Installing package into ‘C:/Users/gcrynen/Documents/R/win-library/3.4’
    (as ‘lib’ is unspecified)
    trying URL 'https://bioconductor.org/packages/3.6/bioc/bin/windows/contrib/3.4/DESeq2_1.18.1.zip'
    Content type 'application/zip' length 4542389 bytes (4.3 MB)
    downloaded 4.3 MB

package ‘DESeq2’ successfully unpacked and MD5 sums checked

The downloaded binary packages are in
C:\Users\gcrynen\AppData\Local\Temp\Rtmpg5DfOm\downloaded_packages
"C:/PROGRA1/R/R-341.4/bin/x64/R" --no-site-file --no-environ --no-save --no-restore
--quiet CMD INSTALL
"C:/Users/gcrynen/AppData/Local/Temp/Rtmpg5DfOm/devtools2fe0397630a0/statOmics-zingeR-c789ae5"
--library="C:/Users/gcrynen/Documents/R/win-library/3.4" --install-tests

  • installing source package 'zingeR' ...
    ** R
    ** data
    *** moving datasets to lazyload DB
    ** preparing package for lazy loading
    ** help
    *** installing help indices
    converting help for package 'zingeR'
    finding HTML links ... done
    NBsimSingleCell html
    getDatasetZTNB html
    glmWeightedF html
    Rd warning: C:/Users/gcrynen/AppData/Local/Temp/Rtmpg5DfOm/devtools2fe0397630a0/statOmics-zingeR-c789ae5/man/glmWeightedF.Rd:20: missing file link 'glmLRT'
    Rd warning: C:/Users/gcrynen/AppData/Local/Temp/Rtmpg5DfOm/devtools2fe0397630a0/statOmics-zingeR-c789ae5/man/glmWeightedF.Rd:37: missing file link 'glmLRT'
    independentFiltering html
    Rd warning: C:/Users/gcrynen/AppData/Local/Temp/Rtmpg5DfOm/devtools2fe0397630a0/statOmics-zingeR-c789ae5/man/independentFiltering.Rd:14: missing file link 'glmLRT'
    islamEset html
    zeroWeightsLS html
    Rd warning: C:/Users/gcrynen/AppData/Local/Temp/Rtmpg5DfOm/devtools2fe0397630a0/statOmics-zingeR-c789ae5/man/zeroWeightsLS.Rd:23: missing file link 'DESeqDataSet-class'
    Rd warning: C:/Users/gcrynen/AppData/Local/Temp/Rtmpg5DfOm/devtools2fe0397630a0/statOmics-zingeR-c789ae5/man/zeroWeightsLS.Rd:25: missing file link 'DESeqDataSet-class'
    ** building package indices
    ** installing vignettes
    ** testing if installed package can be loaded
    *** arch - i386
    *** arch - x64
  • DONE (zingeR)
    In R CMD INSTALL

devtools::install_github("bvieth/powsimR", build_vignettes = TRUE, dependencies = FALSE)
Downloading GitHub repo bvieth/powsimR@master
from URL https://api.github.com/repos/bvieth/powsimR/zipball/master
Installing powsimR
Installation failed: SVN does not seem to be installed on your system.

I also used the alternative method but that gives the same results.

thank you very much
gogce

Installation error to do with 'lpsymphony' and 'openmp'

Hi,

I am trying to install this on my MacOS Mojave 10.14.3. However, I get this error - see below.

Do you have any suggestions as to how to fix this?

Thanks!

Sander

r

R version 3.5.2 (2018-12-20) -- "Eggshell Igloo"
Copyright (C) 2018 The R Foundation for Statistical Computing
Platform: x86_64-apple-darwin18.2.0 (64-bit)

R is free software and comes with ABSOLUTELY NO WARRANTY.
You are welcome to redistribute it under certain conditions.
Type 'license()' or 'licence()' for distribution details.

  Natural language support but running in an English locale

R is a collaborative project with many contributors.
Type 'contributors()' for more information and
'citation()' on how to cite R or R packages in publications.

Type 'demo()' for some demos, 'help()' for on-line help, or
'help.start()' for an HTML browser interface to help.
Type 'q()' to quit R.

> ipak <- function(pkg, repository = c("CRAN", "Bioconductor", "github")) {
+     new.pkg <- pkg[!(pkg %in% installed.packages()[, "Package"])]
+     # new.pkg <- pkg
+     if (length(new.pkg)) {
+         if (repository == "CRAN") {
+             install.packages(new.pkg, dependencies = TRUE)
+         }
+         if (repository == "Bioconductor") {
+             source("https://bioconductor.org/biocLite.R")
+             biocLite(new.pkg, dependencies = TRUE, ask = FALSE)
+         }
+         if (repository == "github") {
+             devtools::install_github(new.pkg, build_vignettes = FALSE, dependencies = TRUE)
+         }
+     }
+ }
>
> # CRAN PACKAGES
> cranpackages <- c("bbmle", "broom", "cobs", "cowplot", "data.table", "devtools",
+     "doParallel", "dplyr", "drc", "DrImpute", "fastICA", "fitdistrplus", "foreach",
+     "gamlss.dist", "ggExtra", "ggplot2", "ggthemes", "grDevices", "glmnet",
+     "grid", "gtools", "Hmisc", "kernlab", "MASS", "matrixStats", "mclust", "methods",
+     "minpack.lm", "moments", "msir", "NBPSeq", "nonnest2", "parallel", "penalized",
+     "plyr", "pscl", "reshape2", "ROCR", "Rtsne", "scales", "Seurat", "snow",
+     "stats", "tibble", "tidyr", "VGAM", "ZIM")
> ipak(cranpackages, repository = "CRAN")
>
> # BIOCONDUCTOR
> biocpackages <- c("AnnotationDbi", "baySeq", "Biobase", "BiocGenerics", "BiocParallel",
+     "DEDS", "DESeq2", "EBSeq", "edgeR", "IHW", "iCOBRA", "limma", "Linnorm",
+     "MAST", "monocle", "NOISeq", "qvalue", "ROTS", "RUVSeq", "S4Vectors", "scater",
+     "scDD", "scde", "scone", "scran", "SCnorm", "SingleCellExperiment", "SummarizedExperiment",
+     "zinbwave")
> ipak(biocpackages, repository = "Bioconductor")
>
> # GITHUB
> githubpackages <- c("nghiavtr/BPSC", "cz-ye/DECENT", "mohuangx/SAVER", "statOmics/zingeR")
> ipak(githubpackages, repository = "github")
Skipping install of 'BPSC' from a github remote, the SHA1 (5a512e5f) has not changed since last install.
  Use `force = TRUE` to force installation
Skipping install of 'DECENT' from a github remote, the SHA1 (dd593069) has not changed since last install.
  Use `force = TRUE` to force installation
Skipping install of 'SAVER' from a github remote, the SHA1 (1c124ad8) has not changed since last install.
  Use `force = TRUE` to force installation
Skipping install of 'zingeR' from a github remote, the SHA1 (c789ae53) has not changed since last install.
  Use `force = TRUE` to force installation
> devtools::install_github("bvieth/powsimR", build_vignettes = TRUE, dependencies = FALSE)
Downloading GitHub repo bvieth/powsimR@master
✔  checking for file ‘/private/var/folders/7r/ns6f04xj55j72y97pvwtwxj0000_2q/T/RtmpnNPrJr/remotesfd02396b0a5c/bvieth-powsimR-c70c819/DESCRIPTION’ ...
─  preparing ‘powsimR’:
✔  checking DESCRIPTION meta-information ...
─  checking for LF line-endings in source and make files and shell scripts
─  checking for empty or unneeded directories
─  looking to see if a ‘data/datalist’ file should be added
─  building ‘powsimR_1.1.4.tar.gz’ (5.3s)

Installing package into ‘/usr/local/lib/R/3.5/site-library’
(as ‘lib’ is unspecified)
* installing *source* package ‘powsimR’ ...
** R
** data
*** moving datasets to lazyload DB
** inst
** byte-compile and prepare package for lazy loading
Error in dyn.load(file, DLLpath = DLLpath, ...) :
  unable to load shared object '/usr/local/Cellar/r/3.5.2_2/lib/R/library/lpsymphony/libs/lpsymphony.so':
  dlopen(/usr/local/Cellar/r/3.5.2_2/lib/R/library/lpsymphony/libs/lpsymphony.so, 6): Library not loaded: /Library/Frameworks/R.framework/Versions/3.5/Resources/lib/libRlapack.dylib
  Referenced from: /usr/local/Cellar/r/3.5.2_2/lib/R/library/lpsymphony/libs/lpsymphony.so
  Reason: image not found
ERROR: lazy loading failed for package ‘powsimR’
* removing ‘/usr/local/lib/R/3.5/site-library/powsimR’
Error in i.p(...) :
  (converted from warning) installation of package ‘/var/folders/7r/ns6f04xj55j72y97pvwtwxj0000_2q/T//RtmpnNPrJr/filefd0229d84453/powsimR_1.1.4.tar.gz’ had non-zero exit status

Which distributions are considered nested in `evaluateDist`?

In evaluateDist, you use a likelihood ratio test when models are nested and a Vuong test otherwise. Which models do you consider to be nested, and for nested models, how do you determine the distribution of the likelihood ratio under the null?

From a newcomer's perspective, the statistics seem quite tricky. Reading some work by Paul Wilson (links below), it seems that the Poisson and ZIP are "nested" in the sense that the ZIP family includes the Poisson as a special case, but Wilks' Theorem does not apply because the special case happens when the zero-inflation parameter is at the boundary of the parameter space. Unfortunately, this somewhat technical detail really distorts the upper quantiles in Wilson's brief simulation study. There is a convenient workaround where the ZIP model family is expanded to include zero-deflated models too, but I don't know if this has been implemented here or not.

https://stats.stackexchange.com/questions/182020/zero-inflated-poisson-regression-vuong-test-raw-aic-or-bic-corrected-results
https://wlv.openrepository.com/bitstream/handle/2436/622610/Vuong1.pdf?sequence=2

What distribution do you assume for the mean and dispersion?

Hi powsimR devs -- fantastic work on this tool! I looked for a while through the documentation and the paper for a while, but I am unable to find an answer to two key questions about the simulation.

  • When you write "We first draw the mean expression for each gene", how exactly is this done? Is it drawn literally from the empirical distribution in this sense, i.e. sampled with replacement?
  • You write "to capture the variability of the observed dispersion estimates, a local variability prediction band (σ = 1.96) is applied to the fit". Do you sample the dispersion uniformly within this 95% prediction band?

Thanks!

Error in 'rownames' for estimateParam()

Hello,

I have successfully installed powSimR (v1.1.4) without building the vignettes. I am trying to run the first part of the vignette but I receive an error:

Error in rownames<-(*tmp*, value = c("ENSMUSG00000050671", "ENSMUSG00000097613", : invalid rownames length

This is the part of the vignette that causes the error and will not run:
TwoiLIF.params <- estimateParam(countData=kolodziejczk_cnts, batchData= kolodziejczk_grps, spikeData = NULL, spikeInfo = NULL, Lengths = NULL, MeanFragLengths = NULL, Distribution = 'ZINB', RNAseq = 'singlecell', Normalisation = 'scran', sigma = 1.96, NCores = NULL, verbose=TRUE)

Any ideas as to what would cause this error? I apologize ahead of time if this is something obvious-it is not obvious to me!

Here is my session info, if needed:

R version 3.5.2 (2018-12-20)
Platform: x86_64-apple-darwin15.6.0 (64-bit)
Running under: macOS High Sierra 10.13.3

Matrix products: default
BLAS: /Library/Frameworks/R.framework/Versions/3.5/Resources/lib/libRblas.0.dylib
LAPACK: /Library/Frameworks/R.framework/Versions/3.5/Resources/lib/libRlapack.dylib

locale:
[1] en_US.UTF-8/en_US.UTF-8/en_US.UTF-8/C/en_US.UTF-8/en_US.UTF-8

attached base packages:
[1] stats     graphics  grDevices utils     datasets  methods   base     

other attached packages:
[1] powsimR_1.1.4     gamlss.dist_5.1-1 MASS_7.3-51.1    

loaded via a namespace (and not attached):
  [1] mixtools_1.1.0             softImpute_1.4             
  [3] minpack.lm_1.2-1           pbapply_1.4-0              
  [5] lattice_0.20-38             haven_2.1.0                
  [7] fastICA_1.2-1               mgcv_1.8-26                
  [9] penalized_0.9-51            blob_1.1.1                 
 [11] survival_2.43-3             later_0.8.0                
 [13] nloptr_1.2.1                DBI_1.0.0                  
 [15] R.utils_2.8.0               SingleCellExperiment_1.2.0 
 [17] Linnorm_2.1.5               zlibbioc_1.26.0            
 [19] MatrixModels_0.4-1          pspline_1.0-18             
 [21] pcaMethods_1.72.0           SDMTools_1.1-221           
 [23] htmlwidgets_1.3             mvtnorm_1.0-10             
 [25] hdf5r_1.0.1                 UpSetR_1.3.3               
 [27] parallel_3.5.2              scater_1.5.0               
 [29] irlba_2.3.3                 DEoptimR_1.0-8             
 [31] lars_1.2                    Rcpp_1.0.0                 
 [33] KernSmooth_2.23-15          DT_0.5                     
 [35] promises_1.0.1              gdata_2.18.0               
 [37] DDRTree_0.1.5               DelayedArray_0.6.6         
 [39] limma_3.36.5                vegan_2.5-4                
 [41] Hmisc_4.2-0                 ShortRead_1.38.0           
 [43] apcluster_1.4.7             RSpectra_0.13-1            
 [45] msir_1.3.1                  mnormt_1.5-5               
 [47] digest_0.6.18               png_0.1-7                  
 [49] qlcMatrix_0.9.7             cowplot_0.9.4              
 [51] glmnet_2.0-16               pkgconfig_2.0.2            
 [53] docopt_0.6.1                DelayedMatrixStats_1.2.0   
 [55] ggbeeswarm_0.6.0            iterators_1.0.10           
 [57] minqa_1.2.4                 lavaan_0.6-3               
 [59] reticulate_1.11.1           SummarizedExperiment_1.10.1
 [61] spam_2.2-2                  beeswarm_0.2.3             
 [63] modeltools_0.2-22           xfun_0.5                   
 [65] zoo_1.8-4                   tidyselect_0.2.5           
 [67] ZIM_1.1.0                   reshape2_1.4.3             
 [69] purrr_0.3.1                 kernlab_0.9-27             
 [71] ica_1.0-2                   pcaPP_1.9-73               
 [73] EDASeq_2.14.1               viridisLite_0.3.0          
 [75] snow_0.4-3                  rtracklayer_1.40.6         
 [77] rlang_0.3.1                 hexbin_1.27.2              
 [79] manipulateWidget_0.10.0     glue_1.3.0                 
 [81] metap_1.1                   RColorBrewer_1.1-2         
 [83] registry_0.5-1              fpc_2.1-11.1               
 [85] matrixStats_0.54.0          stringr_1.4.0              
 [87] pkgmaker_0.27               fields_9.6                 
 [89] DESeq2_1.20.0               SparseM_1.77               
 [91] gbRd_0.4-11                 httpuv_1.4.5.1             
 [93] class_7.3-14                BPSC_0.99.2                
 [95] RMTstat_0.3                 annotate_1.58.0            
 [97] webshot_0.5.1               jsonlite_1.6               
 [99] XVector_0.20.0              bit_1.1-14                 
[101] mime_0.6                    gridExtra_2.3              
[103] gplots_3.0.1.1              Rsamtools_1.32.3           
[105] zingeR_0.1.0                stringi_1.3.1              
[107] gmodels_2.18.1              gsl_1.9-10.3               
[109] bitops_1.0-6                Rdpack_0.10-1              
[111] maps_3.3.0                  RSQLite_2.1.1              
[113] tidyr_0.8.3                 pheatmap_1.0.12            
[115] data.table_1.12.0           DEDS_1.51.0                
[117] energy_1.7-5                rstudioapi_0.9.0           
[119] GenomicAlignments_1.16.0    nlme_3.1-137               
[121] qvalue_2.9.0                scran_1.8.4                
[123] fastcluster_1.1.25          scone_1.4.0                
[125] locfit_1.5-9.1              miniUI_0.1.1.1             
[127] cobs_1.3-3                  R.oo_1.22.0                
[129] prabclus_2.2-7              segmented_0.5-3.0          
[131] BiocGenerics_0.26.0         readxl_1.3.0               
[133] ROTS_1.5.1                  cellranger_1.1.0           
[135] munsell_0.5.0               R.methodsS3_1.7.1          
[137] moments_0.14                hwriter_1.3.2              
[139] caTools_1.17.1.2            codetools_0.2-15           
[141] coda_0.19-2                 Biobase_2.40.0             
[143] GenomeInfoDb_1.16.0         vipor_0.4.5                
[145] lmtest_0.9-36               htmlTable_1.13.1           
[147] rARPACK_0.11-0              lsei_1.2-0                 
[149] xtable_1.8-3                SAVER_1.1.1                
[151] ROCR_1.0-7                  diptest_0.75-7             
[153] lpsymphony_1.8.0            abind_1.4-5                
[155] FNN_1.1.3                   RANN_2.6.1                 
[157] sparsesvd_0.1-4             CompQuadForm_1.4.3         
[159] GenomicRanges_1.32.7        bibtex_0.4.2               
[161] rgl_0.99.16                 tibble_2.0.1               
[163] ggdendro_0.1-20             cluster_2.0.7-1            
[165] Seurat_2.3.4                Matrix_1.2-15              
[167] prettyunits_1.0.2           shinyBS_0.61               
[169] ggridges_0.5.1              NOISeq_2.24.0              
[171] shinydashboard_0.7.1        mclust_5.4.2               
[173] igraph_1.2.4                slam_0.1-45                
[175] testthat_2.0.1              doSNOW_1.0.16              
[177] htmltools_0.3.6             GenomicFeatures_1.32.3     
[179] XML_3.98-1.19               DrImpute_1.0               
[181] foreign_0.8-71              withr_2.1.2                
[183] fitdistrplus_1.0-14         BiocParallel_1.14.2        
[185] aroma.light_3.10.0          bit64_0.9-7                
[187] rngtools_1.3.1              doRNG_1.7.1                
[189] foreach_1.4.4               robustbase_0.93-3          
[191] outliers_0.14               scde_2.8.0                 
[193] Biostrings_2.48.0           combinat_0.0-8             
[195] rsvd_1.0.0                  iCOBRA_1.5.0               
[197] memoise_1.1.0               VGAM_1.1-1                 
[199] nonnest2_0.5-2              forcats_0.4.0              
[201] rio_0.5.16                  geneplotter_1.58.0         
[203] permute_0.9-4               curl_3.3                   
[205] fdrtool_1.2.15              trimcluster_0.1-2.1        
[207] acepack_1.4.1               edgeR_3.19.3               
[209] checkmate_1.9.1             npsurv_0.4-0               
[211] tensorA_0.36.1              DECENT_0.99.2              
[213] ellipse_0.4.1               ggplot2_3.1.0              
[215] rjson_0.2.20                openxlsx_4.1.0             
[217] ggrepel_0.8.0               distillery_1.0-4           
[219] dtw_1.20-1                  scDD_1.4.0                 
[221] stabledist_0.7-1            Lmoments_1.2-3             
[223] tools_3.5.2                 sandwich_2.5-0             
[225] magrittr_1.5                RCurl_1.95-4.12            
[227] proxy_0.4-23                car_3.0-2                  
[229] pbivnorm_0.6.0              ape_5.2                    
[231] bayesm_3.1-1                EBSeq_1.17.0               
[233] httr_1.4.0                  assertthat_0.2.0           
[235] boot_1.3-20                 R6_2.4.0                   
[237] Rhdf5lib_1.2.1              nnet_7.3-12                
[239] progress_1.2.0              tximport_1.8.0             
[241] genefilter_1.62.0           gtools_3.8.1               
[243] statmod_1.4.30              Rook_1.1-1                 
[245] rhdf5_2.24.0                splines_3.5.2              
[247] carData_3.0-2               colorspace_1.4-0           
[249] amap_0.8-16                 generics_0.0.2             
[251] stats4_3.5.2                NBPSeq_0.3.0               
[253] compositions_1.40-2         base64enc_0.1-3            
[255] baySeq_2.11.0               pillar_1.3.1               
[257] HSMMSingleCell_0.114.0      GenomeInfoDbData_1.1.0     
[259] plyr_1.8.4                  extRemes_2.0-9             
[261] dotCall64_1.0-0             gtable_0.2.0               
[263] zip_2.0.0                   SCnorm_1.5.7               
[265] monocle_2.8.0               knitr_1.22                 
[267] RcppArmadillo_0.9.200.7.1   latticeExtra_0.6-28        
[269] biomaRt_2.36.1              IRanges_2.14.12            
[271] ADGofTest_0.3               copula_0.999-19            
[273] crosstalk_1.0.0             Cairo_1.5-9                
[275] doParallel_1.0.14           pscl_1.5.2                 
[277] flexmix_2.3-15              quantreg_5.38              
[279] AnnotationDbi_1.39.2        broom_0.5.1                
[281] scales_1.0.0                arm_1.10-1                 
[283] backports_1.1.3             IHW_1.5.0                  
[285] S4Vectors_0.20.1            densityClust_0.3           
[287] lme4_1.1-21                 brew_1.0-6                 
[289] hms_0.4.2                   DESeq_1.32.0               
[291] Rtsne_0.15                  dplyr_0.8.0.1              
[293] shiny_1.2.0                 grid_3.5.2                 
[295] numDeriv_2016.8-1           bbmle_1.0.20               
[297] lazyeval_0.2.1                    dynamicTreeCut_1.63-1      
[299] Formula_1.2-3                    tsne_0.1-3                 
[301] blockmodeling_0.3.4         crayon_1.3.4               
[303] MAST_1.6.1                       RUVSeq_1.14.0              
[305] viridis_0.5.1                      rpart_4.1-13               
[307] zinbwave_1.2.0                compiler_3.5.2            

Error building vignette

Hi Beate,
Installing powsimR using devtools::install_github("bvieth/powsimR", build_vignettes = TRUE) results in an error due to its inability to build the vignette. This is rectified if build_vignettes=FALSE, however I can't seem to find a complete vignette for powsimR (at least not on your github account or through the package). It would be great to have access to this.
Best,
Hania

Recommend Projects

  • React photo React

    A declarative, efficient, and flexible JavaScript library for building user interfaces.

  • Vue.js photo Vue.js

    🖖 Vue.js is a progressive, incrementally-adoptable JavaScript framework for building UI on the web.

  • Typescript photo Typescript

    TypeScript is a superset of JavaScript that compiles to clean JavaScript output.

  • TensorFlow photo TensorFlow

    An Open Source Machine Learning Framework for Everyone

  • Django photo Django

    The Web framework for perfectionists with deadlines.

  • D3 photo D3

    Bring data to life with SVG, Canvas and HTML. 📊📈🎉

Recommend Topics

  • javascript

    JavaScript (JS) is a lightweight interpreted programming language with first-class functions.

  • web

    Some thing interesting about web. New door for the world.

  • server

    A server is a program made to process requests and deliver data to clients.

  • Machine learning

    Machine learning is a way of modeling and interpreting data that allows a piece of software to respond intelligently.

  • Game

    Some thing interesting about game, make everyone happy.

Recommend Org

  • Facebook photo Facebook

    We are working to build community through open source technology. NB: members must have two-factor auth.

  • Microsoft photo Microsoft

    Open source projects and samples from Microsoft.

  • Google photo Google

    Google ❤️ Open Source for everyone.

  • D3 photo D3

    Data-Driven Documents codes.