Skip to content

Commit

Permalink
bring develop-private up to date with develop
Browse files Browse the repository at this point in the history
  • Loading branch information
andrewwbutler committed Aug 28, 2017
2 parents f269d97 + cec7cb9 commit 5a671d7
Show file tree
Hide file tree
Showing 224 changed files with 12,013 additions and 3,309 deletions.
2 changes: 2 additions & 0 deletions .Rbuildignore
Original file line number Diff line number Diff line change
@@ -1,3 +1,5 @@
^.*\.Rproj$
^\.Rproj\.user$
.git
.travis.yml
appveyor.yml
1 change: 1 addition & 0 deletions .gitignore
Original file line number Diff line number Diff line change
Expand Up @@ -5,3 +5,4 @@
src/*.o
src/*.so
.DS_Store
*.pdf
22 changes: 20 additions & 2 deletions .travis.yml
Original file line number Diff line number Diff line change
@@ -1,7 +1,25 @@
# R for travis: see documentation at https://docs.travis-ci.com/user/languages/r

language: R
sudo: false
cache: packages
sudo: required
r_binary_packages:
- lars
- mixtools
- caret
- e1071
- ica
- fpc
- ape
- igraph
- dplyr
- irlba
- reshape2
- gdata
- compositions
- dtw
- plotly
- httr
- tidyr
- ranger
warnings_are_errors: false
dist: trusty
38 changes: 23 additions & 15 deletions DESCRIPTION
Original file line number Diff line number Diff line change
@@ -1,15 +1,24 @@
Package: Seurat
Version: 2.0.0.900
Date: 07/17/17
Title: Seurat : R toolkit for single cell genomics
Description: Seurat : R toolkit for single cell genomics.
Author: Rahul Satija
Maintainer: Satija Lab <[email protected]>
URL: http://www.satijalab.org/seurat
Version: 2.0.1
Date: 2017-08-18
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(
person(given = 'Rahul', family = 'Satija', email = '[email protected]', role = 'aut'),
person(given = 'Andrew', family = 'Butler', email = '[email protected]', role = 'aut'),
person(given = 'Paul', family = 'Hoffman', email = '[email protected]', role = c('aut', 'cre')),
person(given = 'Jeff', family = 'Farrell', email = '[email protected]', role = 'ctb'),
person(given = 'Shiwei', family = 'Zheng', email = '[email protected]', role = 'ctb'),
person(given = 'Christoph', family = 'Hafemeister', email = '[email protected]', role = 'ctb'),
person(given = 'Patrick', family = 'Roelli', email = '[email protected]', role = 'ctb')
)
URL: http://www.satijalab.org/seurat, https://github.com/satijalab/seurat
BugReports: https://github.com/satijalab/seurat/issues
Depends:
R (>= 3.2.0),
ggplot2,
cowplot,
Matrix,
SystemRequirements: Java (>= 1.6)
Imports:
methods,
Expand All @@ -31,35 +40,35 @@ Imports:
dplyr,
RColorBrewer,
MASS,
Matrix,
irlba,
reshape2,
gridExtra,
gplots,
gdata,
Rcpp,
RcppEigen,
RcppProgress,
tclust,
ranger,
compositions,
NMF,
NMOF,
dtw,
SDMTools,
plotly,
enrichR,
diffusionMap,
Hmisc,
httr,
tidyr
tidyr,
ggjoy
LinkingTo: Rcpp, RcppEigen, RcppProgress
License: GPL-3
Collate:
License: GPL-3 | file LICENSE
LazyData: true
Collate:
'RcppExports.R'
'seurat.R'
'cluster_determination.R'
'cluster_determination_internal.R'
'cluster_validation.R'
'data.R'
'deprecated_functions.R'
'differential_expression.R'
'differential_expression_internal.R'
Expand All @@ -79,7 +88,6 @@ Collate:
'preprocessing_internal.R'
'printing_utilities.R'
'scoring.R'
'seuratFxns.R'
'snn.R'
'spatial.R'
'spatial_internal.R'
Expand Down
File renamed without changes.
99 changes: 77 additions & 22 deletions NAMESPACE
Original file line number Diff line number Diff line change
Expand Up @@ -11,11 +11,12 @@ export(AssessSplit)
export(AverageDetectionRate)
export(AverageExpression)
export(AveragePCA)
export(BlackAndWhite)
export(BuildClusterTree)
export(BuildRFClassifier)
export(BuildSNN)
export(CalcVarExpRatio)
export(CellCentroid)
export(CaseMatch)
export(CellCycleScoring)
export(CellPlot)
export(ClassifyCells)
Expand All @@ -26,7 +27,6 @@ export(CustomPalette)
export(DBClustDimension)
export(DBclust_dimension)
export(DMEmbed)
export(DMLoad)
export(DMPlot)
export(DarkTheme)
export(DiffExpTest)
Expand All @@ -39,8 +39,7 @@ export(DimTopGenes)
export(DoHeatmap)
export(DoKMeans)
export(DotPlot)
export(DotPlotGG)
export(ExactCellCentroid)
export(DotPlotOld)
export(ExpMean)
export(ExpSD)
export(ExpVar)
Expand All @@ -59,7 +58,6 @@ export(FindMarkers)
export(FindMarkersNode)
export(FindVariableGenes)
export(FitGeneK)
export(FitGeneMix)
export(GenePlot)
export(GenesInCluster)
export(GetAssayData)
Expand All @@ -78,7 +76,6 @@ export(ICHeatmap)
export(ICTopCells)
export(ICTopGenes)
export(InitialMapping)
export(JackRandom)
export(JackStraw)
export(JackStrawPlot)
export(JoyPlot)
Expand All @@ -88,7 +85,6 @@ export(Kclust_dimension)
export(LogNormalize)
export(LogVMR)
export(MakeSparse)
export(MapCell)
export(MarkerTest)
export(MatrixRowShuffle)
export(MeanVarPlot)
Expand All @@ -97,7 +93,6 @@ export(MergeSeurat)
export(MinMax)
export(NegBinomDETest)
export(NegBinomRegDETest)
export(NodeHeatmap)
export(NormalizeData)
export(NumberClusters)
export(OldDoHeatmap)
Expand All @@ -112,7 +107,6 @@ export(PCTopCells)
export(PCTopGenes)
export(PlotClusterTree)
export(PoissonDETest)
export(PosteriorPlot)
export(PrintAlignSubspaceParams)
export(PrintCCAParams)
export(PrintCalcParams)
Expand All @@ -128,8 +122,10 @@ export(PrintSNNParams)
export(PrintTSNEParams)
export(ProjectDim)
export(ProjectPCA)
export(PurpleAndYellow)
export(Read10X)
export(RefinedMapping)
export(RegressOut)
export(RemoveFromTable)
export(RenameIdent)
export(ReorderIdent)
Expand Down Expand Up @@ -166,8 +162,6 @@ export(VizICA)
export(VizPCA)
export(VlnPlot)
export(WhichCells)
export(XCellCentroid)
export(YCellCentroid)
export(addImputedScore)
export(addMetaData)
export(addSmoothedScore)
Expand All @@ -176,16 +170,13 @@ export(average.expression)
export(average.pca)
export(batch.gene)
export(buildClusterTree)
export(bwCols)
export(calc.insitu)
export(calcNoiseModels)
export(calinskiPlot)
export(cell.cor.matrix)
export(cellPlot)
export(cluster.alpha)
export(diff.t.test)
export(diffExp.test)
export(dim.plot)
export(doHeatMap)
export(doKMeans)
export(dot.plot)
Expand Down Expand Up @@ -218,7 +209,6 @@ export(jackStrawPlot)
export(kMeansHeatmap)
export(map.cell)
export(marker.test)
export(mean.var.plot)
export(minusc)
export(minusr)
export(pcHeatmap)
Expand All @@ -230,20 +220,16 @@ export(pca.sig.genes)
export(plotClusterTree)
export(plotNoiseModel)
export(posterior.plot)
export(print.pca)
export(project.pca)
export(project.samples)
export(pyCols)
export(refined.mapping)
export(regulatorScore)
export(removePC)
export(rename.ident)
export(reorder.ident)
export(run_diffusion)
export(run_tsne)
export(set.all.ident)
export(set.ident)
export(situ3d)
export(spatial.de)
export(subsetCells)
export(subsetData)
Expand All @@ -262,18 +248,17 @@ export(zf.insitu.side)
export(zf.insitu.vec.lateral)
export(zf.insitu.ventral)
exportClasses(seurat)
exportMethods(show)
import(Matrix)
import(ROCR)
import(RColorBrewer)
import(SDMTools)
import(VGAM)
import(diffusionMap)
import(enrichR)
import(fpc)
import(ggplot2)
import(gridExtra)
import(httr)
import(lars)
import(methods)
import(parallel)
import(pbapply)
import(stringr)
Expand All @@ -287,15 +272,21 @@ importFrom(Matrix,colSums)
importFrom(Matrix,readMM)
importFrom(Matrix,rowSums)
importFrom(Matrix,sparseMatrix)
importFrom(NMF,aheatmap)
importFrom(RColorBrewer,brewer.pal.info)
importFrom(ROCR,performance)
importFrom(ROCR,prediction)
importFrom(Rcpp,evalCpp)
importFrom(Rtsne,Rtsne)
importFrom(VGAM,tobit)
importFrom(VGAM,vgam)
importFrom(ape,as.phylo)
importFrom(ape,drop.tip)
importFrom(ape,nodelabels)
importFrom(ape,plot.phylo)
importFrom(caret,train)
importFrom(caret,trainControl)
importFrom(cowplot,get_legend)
importFrom(cowplot,plot_grid)
importFrom(dplyr,"%>%")
importFrom(dplyr,filter)
Expand All @@ -310,7 +301,27 @@ importFrom(dplyr,top_n)
importFrom(dplyr,ungroup)
importFrom(dtw,dtw)
importFrom(gdata,drop.levels)
importFrom(ggjoy,geom_joy)
importFrom(ggjoy,theme_joy)
importFrom(gplots,heatmap.2)
importFrom(grDevices,col2rgb)
importFrom(grDevices,colorRampPalette)
importFrom(grDevices,colors)
importFrom(grDevices,rgb)
importFrom(graphics,abline)
importFrom(graphics,axis)
importFrom(graphics,contour)
importFrom(graphics,hist)
importFrom(graphics,lines)
importFrom(graphics,locator)
importFrom(graphics,mtext)
importFrom(graphics,par)
importFrom(graphics,plot)
importFrom(graphics,points)
importFrom(graphics,rect)
importFrom(graphics,smoothScatter)
importFrom(graphics,text)
importFrom(graphics,title)
importFrom(ica,icafast)
importFrom(ica,icaimax)
importFrom(ica,icajade)
Expand All @@ -320,12 +331,56 @@ importFrom(igraph,graph.adjlist)
importFrom(igraph,plot.igraph)
importFrom(irlba,irlba)
importFrom(mixtools,normalmixEM)
importFrom(mixtools,plot.mixEM)
importFrom(pbapply,pbapply)
importFrom(pbapply,pblapply)
importFrom(pbapply,pbsapply)
importFrom(ranger,ranger)
importFrom(reshape2,melt)
importFrom(stats,anova)
importFrom(stats,as.dendrogram)
importFrom(stats,as.dist)
importFrom(stats,as.formula)
importFrom(stats,coef)
importFrom(stats,complete.cases)
importFrom(stats,cor)
importFrom(stats,cov)
importFrom(stats,density)
importFrom(stats,dist)
importFrom(stats,dnorm)
importFrom(stats,glm)
importFrom(stats,hclust)
importFrom(stats,kmeans)
importFrom(stats,lm)
importFrom(stats,loess)
importFrom(stats,logLik)
importFrom(stats,median)
importFrom(stats,na.omit)
importFrom(stats,optim)
importFrom(stats,order.dendrogram)
importFrom(stats,p.adjust)
importFrom(stats,pchisq)
importFrom(stats,poisson)
importFrom(stats,predict)
importFrom(stats,prop.test)
importFrom(stats,qqplot)
importFrom(stats,quantile)
importFrom(stats,qunif)
importFrom(stats,reorder)
importFrom(stats,residuals)
importFrom(stats,rnorm)
importFrom(stats,runif)
importFrom(stats,sd)
importFrom(stats,smooth.spline)
importFrom(stats,t.test)
importFrom(stats,var)
importFrom(tclust,tkmeans)
importFrom(tidyr,gather)
importFrom(tsne,tsne)
importFrom(utils,globalVariables)
importFrom(utils,packageVersion)
importFrom(utils,read.table)
importFrom(utils,setTxtProgressBar)
importFrom(utils,txtProgressBar)
importFrom(utils,write.table)
useDynLib(Seurat)
Loading

0 comments on commit 5a671d7

Please sign in to comment.