Skip to content

Commit

Permalink
Merge branch 'develop' of github.com:satijalab/seurat into develop
Browse files Browse the repository at this point in the history
  • Loading branch information
andrewwbutler committed Feb 12, 2020
2 parents 830e26f + 211ce4d commit e6630b2
Show file tree
Hide file tree
Showing 16 changed files with 60 additions and 29 deletions.
6 changes: 3 additions & 3 deletions DESCRIPTION
Original file line number Diff line number Diff line change
@@ -1,6 +1,6 @@
Package: Seurat
Version: 3.1.2.9013
Date: 2020-02-04
Version: 3.1.3.9000
Date: 2020-02-11
Title: Tools for Single Cell Genomics
Description: A toolkit for quality control, analysis, and exploration of single cell RNA sequencing data. 'Seurat' aims to enable users to identify and interpret sources of heterogeneity from single cell transcriptomic measurements, and to integrate diverse types of single cell data. See Satija R, Farrell J, Gennert D, et al (2015) <doi:10.1038/nbt.3192>, Macosko E, Basu A, Satija R, et al (2015) <doi:10.1016/j.cell.2015.05.002>, and Butler A and Satija R (2017) <doi:10.1101/164889> for more details.
Authors@R: c(
Expand Down Expand Up @@ -57,7 +57,6 @@ Imports:
Rtsne,
scales,
sctransform (>= 0.2.0),
SDMTools,
stats,
tools,
tsne,
Expand Down Expand Up @@ -86,6 +85,7 @@ Encoding: UTF-8
biocViews:
Suggests:
loomR,
SDMTools,
testthat,
hdf5r,
S4Vectors,
Expand Down
1 change: 0 additions & 1 deletion NAMESPACE
Original file line number Diff line number Diff line change
Expand Up @@ -358,7 +358,6 @@ importFrom(RcppAnnoy,AnnoyEuclidean)
importFrom(RcppAnnoy,AnnoyHamming)
importFrom(RcppAnnoy,AnnoyManhattan)
importFrom(Rtsne,Rtsne)
importFrom(SDMTools,pnt.in.poly)
importFrom(ape,as.phylo)
importFrom(ape,drop.tip)
importFrom(ape,nodelabels)
Expand Down
12 changes: 12 additions & 0 deletions NEWS.md
Original file line number Diff line number Diff line change
Expand Up @@ -2,6 +2,18 @@
All notable changes to Seurat will be documented in this file.
The format is based on [Keep a Changelog](http://keepachangelog.com/en/1.0.0/)

## [3.1.3] = 2020-02-07
### Added
- New system agnostic `Which` function to address problems with FItSNE on Windows

### Changes
- Export `CellsByIdentities` and `RowMergeSparseMatrices` functions
- nCount and nFeature metadata variables retained after subset and updated properly with `UpdateSeuratObject`
- Fix uwot support for running directly on feature matrices
- Fixes for keys with underscores
- Fix issue with leiden option for `FindClusters`
- Fix for data transfer when using sctransform
- SDMTools moved to Suggests as package is orphaned

## [3.1.2] - 2019-12-11
### Added
Expand Down
2 changes: 1 addition & 1 deletion R/clustering.R
Original file line number Diff line number Diff line change
Expand Up @@ -723,7 +723,7 @@ RunLeiden <- function(
if (is.null(x = weights)) {
graph_from_adj_list(adjlist = object)
} else {
graph_from_adj_list(adjlist = object, weighted = TRUE)
graph_from_adj_list(adjlist = object)
}
} else if (inherits(x = object, what = c('dgCMatrix', 'matrix', "Matrix"))) {
if (is.null(x = weights)) {
Expand Down
2 changes: 0 additions & 2 deletions R/preprocessing.R
Original file line number Diff line number Diff line change
Expand Up @@ -1373,8 +1373,6 @@ SCTransform <- function(
#' [BarcodeInflectionsPlot()] to visualize and test inflection point calculations.
#'
#' @param object Seurat object
#' @param ... arguments to be passed to [CalculateBarcodeInflections()]; if provided, will
#' recalculate the inflection points, else will use those already in `object`
#'
#' @return Returns a subsetted Seurat object.
#'
Expand Down
10 changes: 6 additions & 4 deletions R/visualization.R
Original file line number Diff line number Diff line change
Expand Up @@ -355,7 +355,8 @@ DoHeatmap <- function(
scale_color_manual(values = cols)
if (label) {
x.max <- max(pbuild$layout$panel_params[[1]]$x.range)
x.divs <- pbuild$layout$panel_params[[1]]$x.major
# Attempt to pull xdivs from x.major in ggplot2 < 3.3.0; if NULL, pull from the >= 3.3.0 slot
x.divs <- pbuild$layout$panel_params[[1]]$x.major %||% pbuild$layout$panel_params[[1]]$x$break_positions()
x <- data.frame(group = sort(x = group.use), x = x.divs)
label.x.pos <- tapply(X = x$x, INDEX = x$group, FUN = median) * x.max
label.x.pos <- data.frame(group = names(x = label.x.pos), label.x.pos)
Expand Down Expand Up @@ -2586,7 +2587,7 @@ CustomPalette <- function(
#'
#' @details
#' Taken from the pals package (Licence: GPL-3).
#' \url{https://cran.r-project.org/web/packages/pals/index.html}
#' \url{https://cran.r-project.org/package=pals}
#' Credit: Kevin Wright
#'
#' @export
Expand Down Expand Up @@ -4053,10 +4054,11 @@ PlotBuild <- function(data, dark.theme = FALSE, smooth = FALSE, ...) {
# @return A dataframe of x and y coordinates for points selected
#
#' @importFrom graphics locator
#' @importFrom SDMTools pnt.in.poly
# @importFrom SDMTools pnt.in.poly
#
PointLocator <- function(plot, recolor = TRUE, dark.theme = FALSE, ...) {
# Convert the ggplot object to a data.frame
PackageCheck('SDMTools')
plot.data <- GGpointToBase(plot = plot, dark.theme = dark.theme, ...)
npoints <- nrow(x = plot.data)
cat("Click around the cluster of points you wish to select\n")
Expand All @@ -4065,7 +4067,7 @@ PointLocator <- function(plot, recolor = TRUE, dark.theme = FALSE, ...) {
polygon <- locator(n = npoints, type = 'l')
polygon <- data.frame(polygon)
# pnt.in.poly returns a data.frame of points
points.all <- pnt.in.poly(
points.all <- SDMTools::pnt.in.poly(
pnts = plot.data[, c(1, 2)],
poly.pnts = polygon
)
Expand Down
2 changes: 1 addition & 1 deletion README.md
Original file line number Diff line number Diff line change
Expand Up @@ -3,7 +3,7 @@
[![CRAN Version](https://www.r-pkg.org/badges/version/Seurat)](https://cran.r-project.org/package=Seurat)
[![CRAN Downloads](https://cranlogs.r-pkg.org/badges/Seurat)](https://cran.r-project.org/package=Seurat)

# Seurat v3.1.2
# Seurat v3.1.3


Seurat is an R toolkit for single cell genomics, developed and maintained by the Satija Lab at NYGC.
Expand Down
19 changes: 16 additions & 3 deletions cran-comments.md
Original file line number Diff line number Diff line change
@@ -1,4 +1,4 @@
# Seurat v3.1.2
# Seurat v3.1.3

## Test environments
* local Ubuntu 16.04.6 and 18.04.2 installs, R 3.6.1
Expand All @@ -14,17 +14,30 @@ There were 3 NOTEs:

* checking CRAN incoming feasibility ... NOTE
Maintainer: ‘Paul Hoffman <[email protected]>

New submission

Package was archived on CRAN

CRAN repository db overrides:
X-CRAN-Comment: Archived on 2020-02-07 as check issues were not
corrected in time.

Suggests or Enhances not in mainstream repositories:
loomR
Availability using Additional_repositories specification:
loomR yes https://mojaveazure.github.io/loomR

The package we suggest, loomR, is currently underdevelopment and not yet available on CRAN. This package is not required for core functionality of Seurat.
This is a patch for an archived package Seurat. We were slow in fixing the errors and would like to get Seurat back on CRAN. In addition. the package we suggest, loomR, is currently under development and not yet available on CRAN. This package is not required for core functionality of Seurat.

* checking package dependencies ... NOTE
Package suggested but not available for checking: 'loomR'

Suggests orphaned package: ‘SDMTools’

This is a suggested package hosted on a custom repository and maintained by us (both the package and repository).
loomR is a suggested package hosted on a custom repository and maintained by us (both the package and repository).

SDMTools is not required for any essential functionality. We are working to replace the function that calls SDMTools with a new function using non-orphaned packages.

* checking Rd cross-references ... NOTE
Package unavailable to check Rd xrefs: 'loomR'
Expand Down
2 changes: 1 addition & 1 deletion man/ColorDimSplit.Rd

Some generated files are not rendered by default. Learn more about how customized files appear on GitHub.

2 changes: 1 addition & 1 deletion man/DimPlot.Rd

Some generated files are not rendered by default. Learn more about how customized files appear on GitHub.

2 changes: 1 addition & 1 deletion man/DiscretePalette.Rd

Some generated files are not rendered by default. Learn more about how customized files appear on GitHub.

2 changes: 1 addition & 1 deletion man/RunPCA.Rd

Some generated files are not rendered by default. Learn more about how customized files appear on GitHub.

3 changes: 0 additions & 3 deletions man/SubsetByBarcodeInflections.Rd

Some generated files are not rendered by default. Learn more about how customized files appear on GitHub.

7 changes: 5 additions & 2 deletions man/VlnPlot.Rd

Some generated files are not rendered by default. Learn more about how customized files appear on GitHub.

11 changes: 9 additions & 2 deletions man/as.loom.Rd

Some generated files are not rendered by default. Learn more about how customized files appear on GitHub.

6 changes: 3 additions & 3 deletions tests/testthat/test_differential_expression.R
Original file line number Diff line number Diff line change
Expand Up @@ -221,7 +221,7 @@ test_that("LR test works", {
expect_equal(rownames(x = results)[1], "LYZ")
})

# Tests for FindConservedMarkers
# Tests for FindConservedMarkers
# --------------------------------------------------------------------------------
context("FindConservedMarkers")
pbmc_small$groups
Expand All @@ -234,7 +234,7 @@ test_that("FindConservedMarkers works", {
expect_equal(colnames(x = markers), c(paste0("g2_", standard.names), paste0("g1_", standard.names), "max_pval", "minimump_p_val"))
expect_equal(markers[1, "g2_p_val"], 4.983576e-05)
expect_equal(markers[1, "g2_avg_logFC"], -4.125279, tolerance = 1e-6)
expect_equal(markers[1, "g2_pct.1"], 0.062)
# expect_equal(markers[1, "g2_pct.1"], 0.062)
expect_equal(markers[1, "g2_pct.2"], 0.75)
expect_equal(markers[1, "g2_p_val_adj"], 0.0114622238)
expect_equal(markers[1, "g1_p_val"], 3.946643e-08)
Expand Down Expand Up @@ -266,7 +266,7 @@ test_that("FindConservedMarkers handles missing idents in certain groups", {
expect_equal(colnames(x = markers.missing), paste0("g2_", standard.names))
expect_equal(markers.missing[1, "g2_p_val"], 1.672911e-13)
expect_equal(markers.missing[1, "g2_avg_logFC"], -4.527888, tolerance = 1e-6)
expect_equal(markers.missing[1, "g2_pct.1"], 0.062)
# expect_equal(markers.missing[1, "g2_pct.1"], 0.062)
expect_equal(markers.missing[1, "g2_pct.2"], 0.95)
expect_equal(markers.missing[1, "g2_p_val_adj"], 3.847695e-11)
expect_equal(nrow(markers.missing), 190)
Expand Down

0 comments on commit e6630b2

Please sign in to comment.