diff --git a/DESCRIPTION b/DESCRIPTION index 3713e3af4..6562d2fa8 100644 --- a/DESCRIPTION +++ b/DESCRIPTION @@ -1,8 +1,8 @@ Package: bcbioSingleCell Title: bcbio Single-Cell RNA-Seq Description: R package for bcbio single-cell RNA-seq analysis. -Version: 0.4.3 -Date: 2018-08-27 +Version: 0.4.4 +Date: 2018-09-09 Authors@R: c( person( given = "Michael", @@ -54,12 +54,12 @@ LazyData: false Depends: R (>= 3.6), SingleCellExperiment (>= 1.6), - basejump (>= 0.11.11) + basejump (>= 0.11.14) Imports: acidplots (>= 0.2.14), bcbioBase (>= 0.6.10), - bioverbs (>= 0.2.7), - goalie (>= 0.3.6), + bioverbs (>= 0.2.9), + goalie (>= 0.3.7), BiocGenerics (>= 0.30), BiocParallel (>= 1.18), IRanges (>= 2.18.2), @@ -73,7 +73,7 @@ Imports: methods, utils Suggests: - acidroxygen (>= 0.1), + acidroxygen (>= 0.1.2), BiocStyle (>= 2.12), R.utils (>= 2.9), knitr (>= 1.24), diff --git a/NEWS.md b/NEWS.md index 00293254d..a438776a6 100644 --- a/NEWS.md +++ b/NEWS.md @@ -1,3 +1,12 @@ +## bcbioSingleCell 0.4.4 (2019-09-09) + +### Minor changes + +- `bcbioSingleCell`: Internal generator now calls `importSampleData` using + `pipeline = "bcbio"` argument, so we don't run into breaking changes when + handling user metadata in a future basejump update. +- Updated basejump dependency versions. + ## bcbioSingleCell 0.4.3 (2019-08-27) ### Minor changes diff --git a/R/AllGenerators.R b/R/AllGenerators.R index bd8e4fe1b..56fd31cc9 100644 --- a/R/AllGenerators.R +++ b/R/AllGenerators.R @@ -137,7 +137,11 @@ bcbioSingleCell <- function( allSamples <- TRUE sampleData <- NULL if (isString(sampleMetadataFile)) { - sampleData <- importSampleData(sampleMetadataFile, lanes = lanes) + sampleData <- importSampleData( + file = sampleMetadataFile, + lanes = lanes, + pipeline = "bcbio" + ) ## Error on incorrect reverse complement input. if ("sequence" %in% colnames(sampleData)) { sampleDirSequence <- str_extract(names(sampleDirs), "[ACGT]+$") diff --git a/docs/404.html b/docs/404.html index d50c9f10a..ffb45c593 100644 --- a/docs/404.html +++ b/docs/404.html @@ -8,11 +8,13 @@ Page not found (404) • bcbioSingleCell + + @@ -34,10 +36,12 @@ + + @@ -65,7 +69,7 @@ bcbioSingleCell - 0.4.3 + 0.4.4 @@ -84,7 +88,6 @@ Changelog - - - - - - -
+

-Minor changes

+Minor changes
-
+

-Minor changes

+Minor changes
  • Using BiocParallel::SerialParam internally for zinbwave in diffExp.
  • Simplified cell2sample internal code to always use mapCellsToSamples instead of attempting to use a stashed vector inside metadata for SingleCellExperiment method.
  • @@ -186,9 +189,9 @@

    bcbioSingleCell 0.1.10 (2018-05-19)

    -
    +

    -Minor changes

    +Minor changes

    • plotCellTypesPerCluster is using dark = TRUE by default again.
    • @@ -221,9 +224,9 @@

      aggregateReplicates function has been reworked to return a SingleCellExperiment object instead of bcbioSingleCell. The v0.2.4 update of bcbioRNASeq behaves similarly with this generic.

-
+

-Minor changes

+Minor changes
  • Reworked the internal handling of some seurat SingleCellExperiment method support, using as(x, "SingleCellExperiment") internally, which uses the new Seurat::Convert function.
  • Made some previously deprecated functions now defunct: plotClusters, plotTSNEExpressionData, loadSingleCellRun, darkTheme, pcCutoff, quantileHeatmap, plotKnownMarkers, readMarkers, readMarkersFile.
  • @@ -246,9 +249,9 @@

  • Improved R Markdown clustering and marker templates to optionally support UMAP and dark mode in the YAML parameters.
-
+

-Minor changes

+Minor changes
  • Using original Seurat mapping names for data: tSNE_1, tSNE_2, PC1, PC2, UMAP1, UMAP2.
  • Ensure transcript-level counts always have stripTranscriptVersions command applied, to remove the Ensembl transcript versions if present.
  • @@ -260,9 +263,9 @@

    bcbioSingleCell 0.1.13 (2018-05-29)

    -
    +

    -Minor changes

    +Minor changes

    • t-SNE and UMAP plot improvements.
    @@ -280,9 +283,9 @@

    readCellRanger no longer requires reference data defined by refdataDir, although this is still recommended.

-
+

-Minor changes

+Minor changes
  • Resaved example datasets.
  • Switched the example cellranger_small and seurat_small datasets to the publicly available pbmc4k dataset from 10X Genomics. Here we’ve subset the top 500 cells and genes by abundance. We’ll use either the pbmc4k or pbmc8k dataset for the vignette in a future update.
  • @@ -304,9 +307,9 @@

    bcbioSingleCell 0.1.15 (2018-06-13)

    -
    +

    -Minor changes

    +Minor changes

    • Updated internal code to use text as primary argument in markdownHeader calls.
    • Updated example datasets and unit tests to match.
    • @@ -334,9 +337,9 @@

      Seurat clustering now calculates multiple resolutions, suggesting 0.4, 0.8, and 1.2 by default. Dimensional reduction plots have been updated to support looping of these multiple resolutions.

-
+

-Minor changes

+Minor changes
  • as(object, "SingleCellExperiment") coercion now slots stashed metadata into SingleCellExperiment, if defined.
  • @@ -365,9 +368,9 @@

  • Internal data has been renamed to snake_case format, for improved consistency. Note that cell_cycle_markers is used in place of cellCycleMarkers, and cell_type_markers in place of cellTypeMarkers. There’s no easy way to link these files as aliases, so this is a necessary breaking change.
-
+

-Minor changes

+Minor changes
  • Improved R Markdown template defaults for quality control and clustering.
  • Now importing functions related to differential expression into the package NAMESPACE, including DESeq2, edgeR, and zinbwave.
  • @@ -442,7 +445,7 @@

    Contents

-

Site built with pkgdown 1.3.0.9100.

+

Site built with pkgdown 1.4.0.

diff --git a/docs/news/news-0.2.html b/docs/news/news-0.2.html index 4b990d94c..9b18e822d 100644 --- a/docs/news/news-0.2.html +++ b/docs/news/news-0.2.html @@ -8,11 +8,13 @@ Version 0.2 • bcbioSingleCell + + @@ -34,10 +36,12 @@ + + @@ -65,7 +69,7 @@ bcbioSingleCell - 0.4.3 + 0.4.4
@@ -84,7 +88,6 @@ Changelog -
-
+

-Minor changes

+Minor changes
  • No longer exporting mapCellsToSamples. This is now only called internally.
  • Updated documentation to use roxygen2 v6.1.
  • @@ -147,9 +150,9 @@

  • Moved clustering and marker templates to pointillism package, since all clustering code has been moved there. The quality control template using the filterCells function is still provided here.
-
+

-Minor changes

+Minor changes
  • prepareSingleCellTemplate: Improved internal code to use updated prepareTemplate, which has been migrated to basejump package.
  • @@ -178,7 +181,7 @@

    Contents

-

Site built with pkgdown 1.3.0.9100.

+

Site built with pkgdown 1.4.0.

diff --git a/docs/news/news-0.3.html b/docs/news/news-0.3.html index c586d8b4a..c48cacf2a 100644 --- a/docs/news/news-0.3.html +++ b/docs/news/news-0.3.html @@ -8,11 +8,13 @@ Version 0.3 • bcbioSingleCell + + @@ -34,10 +36,12 @@ + + @@ -65,7 +69,7 @@ bcbioSingleCell - 0.4.3 + 0.4.4
@@ -84,7 +88,6 @@ Changelog -
-
+

-Minor changes

+Minor changes
  • Consolidated S4 validity check code into AllClasses.R file.
  • Updated Travis and AppVeyor CI configuration.
  • @@ -155,9 +158,9 @@

  • Renamed example data from cellranger_small to cellranger, and indrops_small to simply indrops.
-
+

-Minor changes

+Minor changes
  • Transitioning to goalie for assert checks in place of assertive package.
  • Miscellaneous documentation improvements.
  • @@ -182,9 +185,9 @@

  • Improved plotting functions to inherit params from basejump.
-
+

-Minor changes

+Minor changes
  • Removed barcodePattern global variable.
@@ -193,9 +196,9 @@

bcbioSingleCell 0.3.3 (2018-11-25)

-
+

-Minor changes

+Minor changes

  • Updated basejump and bcbioBase dependencies, to tighten up build checks.
  • Documentation and CI configuration fixes.
  • @@ -213,9 +216,9 @@

    metrics: Removed code and consolidated SingleCellExperiment method support in basejump package.

-
+

-Minor changes

+Minor changes
  • Documentation improvements.
  • @@ -237,9 +240,9 @@

  • Migrated to inheriting S4 generics from bioverbs, where applicable.
-
+

-Minor changes

+Minor changes
  • Reworked documentation to use sentence case instead of title case.
@@ -248,9 +251,9 @@

bcbioSingleCell 0.3.6 (2019-01-13)

-
+

-Minor changes

+Minor changes

  • Updated basejump and bcbioBase dependencies, to pass build checks.
  • Split out imports into a separate R file.
  • @@ -260,9 +263,9 @@

    bcbioSingleCell 0.3.7 (2019-02-12)

    -
    +

    -Minor changes

    +Minor changes

    • bcbioSingleCell generator: improved internal handling of mapCellsToSamples call. This reworked join step checks the sampleID mapping more carefully.
    • @@ -273,9 +276,9 @@

      bcbioSingleCell 0.3.8 (2019-03-18)

      -
      +

      -Minor changes

      +Minor changes

      • Updated basejump and bcbioBase dependencies.
      • Updated documentation.
      • @@ -286,9 +289,9 @@

        bcbioSingleCell 0.3.9 (2019-04-01)

        -
        +

        -Minor changes

        +Minor changes

        • Migrated development code to Acid Genomics.
        • Updated basejump dependency to v0.10 release series.
        • @@ -308,9 +311,9 @@

        • Extract method [ on bcbioSingleCell class objects no longer alters the version of the object. It only sets subset = TRUE, similar to bcbioRNASeq.
-
+

-Minor changes

+Minor changes
  • Bug fix release for formal rename in emptyRanges from mcolsNames to mcolnames. This has been changed in basejump 0.10.3.
@@ -326,9 +329,9 @@

  • Restricted S4 methods back to bcbioSingleCell from SingleCellExperiment where applicable. Generally, this applies to the supported QC plotting functions. Previously, the methods were defined against SingleCellExperiment to also support CellRanger S4 class, which has since been moved to the Chromium package.
  • -
    +

    -Minor changes

    +Minor changes
    • Improved code coverage by adding additional unit tests.
    • Updated internal reexport method for S4 generics, making reexports.Rd file no longer necessary.
    • @@ -339,9 +342,9 @@

      bcbioSingleCell 0.3.12 (2019-04-18)

      -
      +

      -Minor changes

      +Minor changes

      • Deprecated prepareSingleCellTemplate, in favor of prepareTemplate.
      • Switched Travis CI configuration to use singlecell Docker image.
      • @@ -351,9 +354,9 @@

        bcbioSingleCell 0.3.13 (2019-04-23)

        -
        +

        -Minor changes

        +Minor changes

        • Now importing ggplot2 code from acidplots package.
        • @@ -372,9 +375,9 @@

          bcbioSingleCell 0.3.15 (2019-05-29)

          -
          +

          -Minor changes

          +Minor changes

          • Updated barcodeRanksPerSample and plotBarcodeRanks to support DropletUtils update in Bioconductor 3.9.
          • Improved Travis and AppVeyor CI configuration.
          • @@ -384,9 +387,9 @@

            bcbioSingleCell 0.3.16 (2019-07-17)

            -
            +

            -Minor changes

            +Minor changes

            • Updated basejump dependencies.
            • Improved Travis CI docker configuration.
            • @@ -396,9 +399,9 @@

              bcbioSingleCell 0.3.17 (2019-07-24)

              -
              +

              -Minor changes

              +Minor changes

              • Improved internal S4 function naming consistency.
              • Updated basejump dependencies.
              • @@ -417,9 +420,9 @@

                updateObject: Simplified method support, dropping rowRanges argument. No longer attempting to coerce assays back to a simple list, which doesn’t work well on Bioconductor 3.10 Devel currently.

    -
    +

    -Minor changes

    +Minor changes
    • Updated basejump dependencies.
    • Improved code coverage over 90%.
    • @@ -464,7 +467,7 @@

      Contents

    -

    Site built with pkgdown 1.3.0.9100.

    +

    Site built with pkgdown 1.4.0.

    diff --git a/docs/news/news-0.4.html b/docs/news/news-0.4.html index 1211ec1e0..c1e2bd459 100644 --- a/docs/news/news-0.4.html +++ b/docs/news/news-0.4.html @@ -8,11 +8,13 @@ Version 0.4 • bcbioSingleCell + + @@ -34,10 +36,12 @@ + + @@ -65,7 +69,7 @@ bcbioSingleCell - 0.4.3 + 0.4.4
    @@ -84,7 +88,6 @@ Changelog -
    -
    +

    -Minor changes

    +Minor changes
    • Improved documentation consistency by using shared roxygen from acidroxygen package.
    • Updated basejump and bcbio R package dependencies.
    • @@ -132,9 +135,9 @@

      bcbioSingleCell 0.4.1 (2019-08-20)

      -
      +

      -Minor changes

      +Minor changes

      • plotReadsPerCell: Reworked internal code to use DataFrame primarily instead of tbl_df, so we can remove dplyr dependency.
      • @@ -154,9 +157,9 @@

        bcbioSingleCell: Simplifed internal colData handling, calling calculateMetrics after creating SingleCellExperiment with makeSingleCellExperiment. This improves consistency with Chromium package and enables better preparation of rowRanges containing spike-ins and transgenes.

    -
    +

    -Minor changes

    +Minor changes
    • Moved metricsCols global to basejump, so we can share with Chromium.
    • Improved generator consistency with other basejump and bcbio R packages.
    • @@ -166,11 +169,24 @@

      bcbioSingleCell 0.4.3 (2019-08-27)

      +
      +

      +Minor changes

      +
        +
      • NAMESPACE and basejump dependency updates.
      • +
      +
      +
      +
      +

      +bcbioSingleCell 0.4.4 (2019-09-09)

      Minor changes

        -
      • NAMESPACE and basejump dependency updates.
      • +
      • +bcbioSingleCell: Internal generator now calls importSampleData using pipeline = "bcbio" argument, so we don’t run into breaking changes when handling user metadata in a future basejump update.
      • +
      • Updated basejump dependency versions.
      @@ -184,6 +200,7 @@

      Contents

    • 0.4.1
    • 0.4.2
    • 0.4.3
    • +
    • 0.4.4
    @@ -197,7 +214,7 @@

    Contents

    -

    Site built with pkgdown 1.3.0.9100.

    +

    Site built with pkgdown 1.4.0.

    diff --git a/docs/pkgdown.css b/docs/pkgdown.css index 912cb8234..914595810 100644 --- a/docs/pkgdown.css +++ b/docs/pkgdown.css @@ -246,3 +246,11 @@ mark { .fab { font-family: "Font Awesome 5 Brands" !important; } + +/* don't display links in code chunks when printing */ +/* source: https://stackoverflow.com/a/10781533 */ +@media print { + code a:link:after, code a:visited:after { + content: ""; + } +} diff --git a/docs/pkgdown.yml b/docs/pkgdown.yml index 9b00f0464..889d8136d 100644 --- a/docs/pkgdown.yml +++ b/docs/pkgdown.yml @@ -1,5 +1,5 @@ -pandoc: 2.3.1 -pkgdown: 1.3.0.9100 -pkgdown_sha: 1829398a4e97056fe7fb332d0e8b952784b49321 +pandoc: 1.12.3.1 +pkgdown: 1.4.0 +pkgdown_sha: ~ articles: [] diff --git a/docs/reference/bcb.html b/docs/reference/bcb.html index 28038690f..b27c6b36b 100644 --- a/docs/reference/bcb.html +++ b/docs/reference/bcb.html @@ -8,11 +8,13 @@ bcbio single-cell RNA-seq example data set — bcb • bcbioSingleCell + + @@ -34,13 +36,14 @@ - + + @@ -68,7 +71,7 @@ bcbioSingleCell - 0.4.3 + 0.4.4
    @@ -87,7 +90,6 @@ Changelog -
    -

    Harvard inDrops v3 example data

    -
    bcb
    - + +

    Format

    An object of class bcbioSingleCell with 50 rows and 100 columns.

    -

    Note

    Updated 2019-08-12.

    -

    Examples

    data(bcb) @@ -156,11 +155,8 @@

    Examp
    -

    Site built with pkgdown 1.3.0.9100.

    +

    Site built with pkgdown 1.4.0.

    diff --git a/docs/reference/bcbioSingleCell-class.html b/docs/reference/bcbioSingleCell-class.html index f7af03227..8eaa5861d 100644 --- a/docs/reference/bcbioSingleCell-class.html +++ b/docs/reference/bcbioSingleCell-class.html @@ -8,11 +8,13 @@ bcbio single-cell RNA-seq data set — bcbioSingleCell-class • bcbioSingleCell + + @@ -34,8 +36,8 @@ - + @@ -71,7 +74,7 @@ bcbioSingleCell - 0.4.3 + 0.4.4

    @@ -90,7 +93,6 @@ Changelog -
    -

    bcbioSingleCell is an S4 class that extends SingleCellExperiment, and is designed to store a bcbio single-cell RNA-seq analysis. This class contains read counts saved as a sparse matrix (sparseMatrix), sample metadata, and cell quality control metrics.

    -
    - + +

    Note

    Updated 2019-08-21.

    -
    -

    Site built with pkgdown 1.3.0.9100.

    +

    Site built with pkgdown 1.4.0.

    diff --git a/docs/reference/bcbioSingleCell-package.html b/docs/reference/bcbioSingleCell-package.html index c4d907b66..9c0a76230 100644 --- a/docs/reference/bcbioSingleCell-package.html +++ b/docs/reference/bcbioSingleCell-package.html @@ -8,11 +8,13 @@ bcbioSingleCell — bcbioSingleCell-package • bcbioSingleCell + + @@ -34,14 +36,15 @@ - + + @@ -69,7 +72,7 @@ bcbioSingleCell - 0.4.3 + 0.4.4
    @@ -88,7 +91,6 @@ Changelog -
    -

    Import and analyze bcbio single-cell RNA-seq data.

    -
    - + +

    See also

    Useful links:

      @@ -131,15 +132,13 @@

      See a

    -
    -

    Site built with pkgdown 1.3.0.9100.

    +

    Site built with pkgdown 1.4.0.

    diff --git a/docs/reference/bcbioSingleCell.html b/docs/reference/bcbioSingleCell.html index 0a0257de4..9306bd651 100644 --- a/docs/reference/bcbioSingleCell.html +++ b/docs/reference/bcbioSingleCell.html @@ -8,11 +8,13 @@ bcbio single-cell RNA-seq data set — bcbioSingleCell • bcbioSingleCell + + @@ -34,8 +36,8 @@ - + @@ -71,7 +74,7 @@ bcbioSingleCell - 0.4.3 + 0.4.4
    @@ -90,7 +93,6 @@ Changelog -
    -

    bcbioSingleCell is an S4 class that extends SingleCellExperiment, and is designed to store a bcbio single-cell RNA-seq analysis. This class contains read counts saved as a sparse matrix (sparseMatrix), sample metadata, and cell quality control metrics.

    -
    bcbioSingleCell(uploadDir, sampleMetadataFile = NULL, organism = NULL,
    @@ -130,7 +130,7 @@ 

    bcbio single-cell RNA-seq data set

    transgeneNames = NULL, spikeNames = NULL, interestingGroups = "sampleName", BPPARAM = BiocParallel::
    SerialParam(), ...)
    - +

    Arguments

    @@ -201,15 +201,13 @@

    Arg

    Additional arguments.

    - +

    Value

    bcbioSingleCell.

    -

    Note

    Updated 2019-08-27.

    -

    Remote data

    @@ -218,7 +216,6 @@

    When working in RStudio, we recommend connecting to the bcbio-nextgen run directory as a remote connection over sshfs.

    -

    See also

    @@ -227,16 +224,15 @@

    See a
  • .S4methods(class = "bcbioSingleCell").

  • -

    Examples

    uploadDir <- system.file("extdata/indrops", package = "bcbioSingleCell") x <- bcbioSingleCell(uploadDir)
    #> Dated project directory: 2018-01-01_bcbio.
    #> 1 sample detected: #> [1] "multiplexed_AAAAAAAA"
    #> Importing 'project-summary.yaml' using 'yaml::yaml.load_file()'.
    #> Data versions are missing.
    #> Importing 'programs.txt' using 'data.table::fread()'.
    #> Importing 'bcbio-nextgen.log' using 'base::readLines()'.
    #> 'bcbio-nextgen.log' file is empty.
    #> Importing 'bcbio-nextgen-commands.log' using 'base::readLines()'.
    #> 1000 reads per cellular barcode cutoff detected.
    #> Counts will imported as genes.
    #> UMI type: harvard-indrop-v3.
    #> Importing unfiltered cellular barcode distributions...
    #> Importing 'multiplexed-AAAAAAAA-barcodes.tsv' using 'data.table::fread()'.
    #> Importing counts...
    #> Importing 'multiplexed-AAAAAAAA.mtx.rownames' using 'base::readLines()'.
    #> Importing 'multiplexed-AAAAAAAA.mtx.colnames' using 'base::readLines()'.
    #> Importing 'multiplexed-AAAAAAAA.mtx' using 'Matrix::readMM()'.
    #> Importing sidecar 'multiplexed-AAAAAAAA.mtx.rownames'.
    #> Importing 'multiplexed-AAAAAAAA.mtx.rownames' using 'base::readLines()'.
    #> Importing sidecar 'multiplexed-AAAAAAAA.mtx.colnames'.
    #> Importing 'multiplexed-AAAAAAAA.mtx.colnames' using 'base::readLines()'.
    #> 'multiplexed-AAAAAAAA.mtx' does not contain syntactically valid names.
    #> Imported 'multiplexed-AAAAAAAA'.
    #> bcbio GTF file: /n/app/bcbio/dev/genomes/Hsapiens/hg38/rnaseq/ref-transcripts.gtf.
    #> bcbio GTF file is not accessible.
    #> Slotting empty ranges into 'rowRanges()'.
    #> 'sampleMetadataFile' is recommended for multiplexed samples (e.g. harvard-indrop-v3).
    #> Calculating 100 sample metrics.
    #> Calculating metrics without biotype information. -#> 'rowRanges' required to calculate: nCoding, nMito, mitoRatio.
    #> bcbioSingleCell 0.4.3 -#> uploadDir: /Users/mike/R/x86_64-apple-darwin15.6.0-library/3.6/bcbioSingleCell/extdata/indrops -#> dates(2): [bcbio] 2018-01-01; [R] 2019-08-27 +#> 'rowRanges' required to calculate: nCoding, nMito, mitoRatio.
    #> bcbioSingleCell 0.4.4 +#> uploadDir: /tmp/RtmpzwtPV8/temp_libpath9c5a3896d068/bcbioSingleCell/extdata/indrops +#> dates(2): [bcbio] 2018-01-01; [R] 2019-09-09 #> level: genes #> interestingGroups: sampleName #> filtered: FALSE @@ -258,11 +254,11 @@

    Examp sampleMetadataFile = file.path(uploadDir, "metadata.csv") )

    #> Dated project directory: 2018-01-01_bcbio.
    #> 1 sample detected: #> [1] "multiplexed_AAAAAAAA"
    #> Importing 'project-summary.yaml' using 'yaml::yaml.load_file()'.
    #> Data versions are missing.
    #> Importing 'programs.txt' using 'data.table::fread()'.
    #> Importing 'bcbio-nextgen.log' using 'base::readLines()'.
    #> 'bcbio-nextgen.log' file is empty.
    #> Importing 'bcbio-nextgen-commands.log' using 'base::readLines()'.
    #> 1000 reads per cellular barcode cutoff detected.
    #> Counts will imported as genes.
    #> UMI type: harvard-indrop-v3.
    #> Importing 'metadata.csv' using 'data.table::fread()'.
    #> Multiplexed samples detected.
    #> Importing unfiltered cellular barcode distributions...
    #> Importing 'multiplexed-AAAAAAAA-barcodes.tsv' using 'data.table::fread()'.
    #> Importing counts...
    #> Importing 'multiplexed-AAAAAAAA.mtx.rownames' using 'base::readLines()'.
    #> Importing 'multiplexed-AAAAAAAA.mtx.colnames' using 'base::readLines()'.
    #> Importing 'multiplexed-AAAAAAAA.mtx' using 'Matrix::readMM()'.
    #> Importing sidecar 'multiplexed-AAAAAAAA.mtx.rownames'.
    #> Importing 'multiplexed-AAAAAAAA.mtx.rownames' using 'base::readLines()'.
    #> Importing sidecar 'multiplexed-AAAAAAAA.mtx.colnames'.
    #> Importing 'multiplexed-AAAAAAAA.mtx.colnames' using 'base::readLines()'.
    #> 'multiplexed-AAAAAAAA.mtx' does not contain syntactically valid names.
    #> Imported 'multiplexed-AAAAAAAA'.
    #> bcbio GTF file: /n/app/bcbio/dev/genomes/Hsapiens/hg38/rnaseq/ref-transcripts.gtf.
    #> bcbio GTF file is not accessible.
    #> Slotting empty ranges into 'rowRanges()'.
    #> Calculating 100 sample metrics.
    #> Calculating metrics without biotype information. -#> 'rowRanges' required to calculate: nCoding, nMito, mitoRatio.
    #> bcbioSingleCell 0.4.3 -#> uploadDir: /Users/mike/R/x86_64-apple-darwin15.6.0-library/3.6/bcbioSingleCell/extdata/indrops -#> dates(2): [bcbio] 2018-01-01; [R] 2019-08-27 +#> 'rowRanges' required to calculate: nCoding, nMito, mitoRatio.
    #> bcbioSingleCell 0.4.4 +#> uploadDir: /tmp/RtmpzwtPV8/temp_libpath9c5a3896d068/bcbioSingleCell/extdata/indrops +#> dates(2): [bcbio] 2018-01-01; [R] 2019-09-09 #> level: genes -#> sampleMetadataFile: /Users/mike/R/x86_64-apple-darwin15.6.0-library/3.6/bcbioSingleCell/extdata/indrops/metadata.csv +#> sampleMetadataFile: /tmp/RtmpzwtPV8/temp_libpath9c5a3896d068/bcbioSingleCell/extdata/indrops/metadata.csv #> interestingGroups: sampleName #> filtered: FALSE #> class: SingleCellExperiment @@ -282,15 +278,10 @@

    Examp

    Contents

    @@ -306,7 +297,7 @@

    Author

    -

    Site built with pkgdown 1.3.0.9100.

    +

    Site built with pkgdown 1.4.0.

    diff --git a/docs/reference/bcbioSingleCellTestsURL.html b/docs/reference/bcbioSingleCellTestsURL.html index 47e66e18f..472af7735 100644 --- a/docs/reference/bcbioSingleCellTestsURL.html +++ b/docs/reference/bcbioSingleCellTestsURL.html @@ -8,11 +8,13 @@ Cache URL — bcbioSingleCellTestsURL • bcbioSingleCell + + @@ -34,13 +36,14 @@ - + + @@ -68,7 +71,7 @@ bcbioSingleCell - 0.4.3 + 0.4.4
    @@ -87,7 +90,6 @@ Changelog -
    -

    Cache URL

    -
    bcbioSingleCellTestsURL
    - + +

    Format

    An object of class character of length 1.

    -

    Examples

    bcbioSingleCellTestsURL
    #> [1] "http://tests.acidgenomics.com/bcbioSingleCell/v0.4"
    @@ -132,9 +132,7 @@

    Examp
    -

    Site built with pkgdown 1.3.0.9100.

    +

    Site built with pkgdown 1.4.0.

    diff --git a/docs/reference/defunct.html b/docs/reference/defunct.html index bdda40f5d..dda921c64 100644 --- a/docs/reference/defunct.html +++ b/docs/reference/defunct.html @@ -8,11 +8,13 @@ Defunct functions — defunct • bcbioSingleCell + + @@ -34,13 +36,14 @@ - + + @@ -68,7 +71,7 @@ bcbioSingleCell - 0.4.3 + 0.4.4 @@ -87,7 +90,6 @@ Changelog - - - - - - @@ -149,7 +152,7 @@

    Contents

    -

    Site built with pkgdown 1.3.0.9100.

    +

    Site built with pkgdown 1.4.0.

    diff --git a/docs/reference/show.html b/docs/reference/show.html index 4b68bd58b..9f4b17865 100644 --- a/docs/reference/show.html +++ b/docs/reference/show.html @@ -8,11 +8,13 @@ Show an object — show • bcbioSingleCell + + @@ -34,8 +36,8 @@ - + @@ -72,7 +75,7 @@ bcbioSingleCell - 0.4.3 + 0.4.4 @@ -91,7 +94,6 @@ Changelog - - -

    Examples

    data(bcb) -updateObject(bcb)
    #> Upgrading bcbioSingleCell from version 0.3.19 to 0.4.3.
    #> bcbioSingleCell 0.4.3 +updateObject(bcb)
    #> Upgrading bcbioSingleCell from version 0.3.19 to 0.4.4.
    #> bcbioSingleCell 0.4.4 #> uploadDir: /data00/draco/acidbase/packages/bcbioSingleCell/inst/extdata/indrops #> dates(2): [bcbio] 2018-01-01; [R] 2019-08-12 #> level: genes @@ -248,15 +245,10 @@

    Examp

    Contents

    @@ -272,7 +264,7 @@

    Author

    -

    Site built with pkgdown 1.3.0.9100.

    +

    Site built with pkgdown 1.4.0.