Skip to content

Commit

Permalink
remove non-ASCI characters for check
Browse files Browse the repository at this point in the history
  • Loading branch information
hpliner committed Sep 18, 2019
1 parent 5873239 commit 8bb2eeb
Show file tree
Hide file tree
Showing 5 changed files with 14 additions and 11 deletions.
4 changes: 2 additions & 2 deletions R/alignment.R
Original file line number Diff line number Diff line change
Expand Up @@ -14,7 +14,7 @@
#'
#' Haghverdi L, Lun ATL, Morgan MD, Marioni JC (2018). "Batch effects in
#' single-cell RNA-sequencing data are corrected by matching mutual nearest
#' neighbors." Nat. Biotechnol., 36(5), 421427. doi: 10.1038/nbt.4091
#' neighbors." Nat. Biotechnol., 36(5), 421-427. doi: 10.1038/nbt.4091
#'
#' @param cds the cell_data_set upon which to perform this operation
#' @param preprocess_method a string specifying the low-dimensional space
Expand Down Expand Up @@ -71,7 +71,7 @@ align_cds <- function(cds,
"Morgan MD, Marioni JC (2018). 'Batch effects in",
"single-cell RNA-sequencing data are corrected by matching",
"mutual nearest neighbors.' Nat. Biotechnol., 36(5),",
"421427. doi: 10.1038/nbt.4091"))
"421-427. doi: 10.1038/nbt.4091"))
corrected_PCA = batchelor::fastMNN(as.matrix(preproc_res),
batch=colData(cds)[,alignment_group],
k=alignment_k,
Expand Down
2 changes: 1 addition & 1 deletion R/cell_data_set.R
Original file line number Diff line number Diff line change
Expand Up @@ -104,7 +104,7 @@ new_cell_data_set <- function(expression_data,
"named 'gene_short_name' for certain functions."))
}

sce <- SingleCellExperiment(list(counts=as(expression_data, "dgCMatrix")),
sce <- SingleCellExperiment(list(counts=methods::as(expression_data, "dgCMatrix")),
rowData = gene_metadata,
colData = cell_metadata)

Expand Down
12 changes: 6 additions & 6 deletions R/utils.R
Original file line number Diff line number Diff line change
Expand Up @@ -730,17 +730,17 @@ clear_cds_slots <- function(cds) {
add_citation <- function(cds, citation_key) {
citation_map <- list(
UMAP = c("UMAP", "McInnes, L., Healy, J. & Melville, J. UMAP: Uniform Manifold Approximation and Projection for dimension reduction. Preprint at https://arxiv.org/abs/1802.03426 (2018)."),
MNN_correct = c("MNN Correct", "Haghverdi, L. et. al. Batch effects in single-cell RNA-sequencing data are corrected by matching mutual nearest neighbors. Nat. Biotechnol. 36, 421427 (2018). https://doi.org/10.1038/nbt.4091"),
partitions = c("paritioning", c("Levine, J. H., et. al. Data-driven phenotypic dissection of AML reveals progenitor-like cells that correlate with prognosis. Cell 162, 184197 (2015). https://doi.org/10.1016/j.cell.2015.05.047",
MNN_correct = c("MNN Correct", "Haghverdi, L. et. al. Batch effects in single-cell RNA-sequencing data are corrected by matching mutual nearest neighbors. Nat. Biotechnol. 36, 421-427 (2018). https://doi.org/10.1038/nbt.4091"),
partitions = c("paritioning", c("Levine, J. H., et. al. Data-driven phenotypic dissection of AML reveals progenitor-like cells that correlate with prognosis. Cell 162, 184-197 (2015). https://doi.org/10.1016/j.cell.2015.05.047",
"Wolf, F. A. et. al. PAGA: graph abstraction reconciles clustering with trajectory inference through a topology preserving map of single cells. Genome Biol. 20, 59 (2019). https://doi.org/10.1186/s13059-019-1663-x")),
clusters = c("clustering", "Levine, J. H. et. al. Data-driven phenotypic dissection of AML reveals progenitor-like cells that correlate with prognosis. Cell 162, 184197 (2015). https://doi.org/10.1016/j.cell.2015.05.047"),
clusters = c("clustering", "Levine, J. H. et. al. Data-driven phenotypic dissection of AML reveals progenitor-like cells that correlate with prognosis. Cell 162, 184-197 (2015). https://doi.org/10.1016/j.cell.2015.05.047"),
leiden = c("leiden", "Traag, V.A., Waltman, L. & van Eck, N.J. From Louvain to Leiden: guaranteeing well-connected communities. Scientific Reportsvolume 9, Article number: 5233 (2019). https://doi.org/10.1038/s41598-019-41695-z" )
)
if (is.null(metadata(cds)$citations) | citation_key == "Monocle") {
metadata(cds)$citations <- data.frame(method = c("Monocle", "Monocle", "Monocle"),
citations = c("Trapnell C. et. al. The dynamics and regulators of cell fate decisions are revealed by pseudotemporal ordering of single cells. Nat. Biotechnol. 32, 381386 (2014). https://doi.org/10.1038/nbt.2859",
"Qiu, X. et. al. Reversed graph embedding resolves complex single-cell trajectories. Nat. Methods 14, 979982 (2017). https://doi.org/10.1038/nmeth.4402",
"Cao, J. et. al. The single-cell transcriptional landscape of mammalian organogenesis. Nature 566, 496502 (2019). https://doi.org/10.1038/s41586-019-0969-x"))
citations = c("Trapnell C. et. al. The dynamics and regulators of cell fate decisions are revealed by pseudotemporal ordering of single cells. Nat. Biotechnol. 32, 381-386 (2014). https://doi.org/10.1038/nbt.2859",
"Qiu, X. et. al. Reversed graph embedding resolves complex single-cell trajectories. Nat. Methods 14, 979-982 (2017). https://doi.org/10.1038/nmeth.4402",
"Cao, J. et. al. The single-cell transcriptional landscape of mammalian organogenesis. Nature 566, 496-502 (2019). https://doi.org/10.1038/s41586-019-0969-x"))
}
metadata(cds)$citations <- rbind(metadata(cds)$citations,
data.frame(method = citation_map[[citation_key]][1],
Expand Down
5 changes: 4 additions & 1 deletion inst/WORDLIST
Original file line number Diff line number Diff line change
Expand Up @@ -118,7 +118,7 @@ Batchelor
Biotechnol
CDSs
Eck
Hadhverdi
Haghverdi
JC
Lun
Marioni
Expand All @@ -132,3 +132,6 @@ nbt
ncenter
str
residual_model_formula_str
MNNCorrect
pre
reticulate
2 changes: 1 addition & 1 deletion man/align_cds.Rd

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

0 comments on commit 8bb2eeb

Please sign in to comment.