Package: celda 1.21.0

Joshua Campbell

celda: CEllular Latent Dirichlet Allocation

Celda is a suite of Bayesian hierarchical models for clustering single-cell RNA-sequencing (scRNA-seq) data. It is able to perform "bi-clustering" and simultaneously cluster genes into gene modules and cells into cell subpopulations. It also contains DecontX, a novel Bayesian method to computationally estimate and remove RNA contamination in individual cells without empty droplet information. A variety of scRNA-seq data visualization functions is also included.

Authors:Joshua Campbell [aut, cre], Shiyi Yang [aut], Zhe Wang [aut], Sean Corbett [aut], Yusuke Koga [aut]

celda_1.21.0.tar.gz
celda_1.21.0.zip(r-4.5)celda_1.21.0.zip(r-4.4)celda_1.21.0.zip(r-4.3)
celda_1.21.0.tgz(r-4.4-arm64)celda_1.21.0.tgz(r-4.4-x86_64)celda_1.21.0.tgz(r-4.3-arm64)celda_1.21.0.tgz(r-4.3-x86_64)
celda_1.21.0.tar.gz(r-4.5-noble)celda_1.21.0.tar.gz(r-4.4-noble)
celda_1.21.0.tgz(r-4.4-emscripten)celda_1.21.0.tgz(r-4.3-emscripten)
celda.pdf |celda.html
celda/json (API)
NEWS

# Install 'celda' in R:
install.packages('celda', repos = c('https://bioc.r-universe.dev', 'https://cloud.r-project.org'))

Peer review:

Bug tracker:https://github.com/campbio/celda/issues

Uses libs:
  • c++– GNU Standard C++ Library v3
  • openmp– GCC OpenMP (GOMP) support library
Datasets:

On BioConductor:celda-1.21.0(bioc 3.20)celda-1.20.0(bioc 3.19)

bioconductor-package

68 exports 2.18 score 130 dependencies 2 dependents 1 mentions

Last updated 2 months agofrom:705c668d9d

Exports:appendCeldaListavailableModelsbestLogLikelihoodceldacelda_Ccelda_CGcelda_GceldaClustersceldaClusters<-celdaGridSearchceldaHeatmapceldaModelceldaModulesceldaModules<-celdaPerplexityceldaProbabilityMapceldatosceceldaTsneceldaUmapclusterProbabilitycompareCountMatrixcountChecksumdecontXdecontXcountsdecontXcounts<-distinctColorsfactorizeMatrixfeatureModuleLookupfeatureModuleTablegeneSetEnrichlogLikelihoodlogLikelihoodHistorymatrixNamesmoduleHeatmapnormalizeCountsparamsperplexityplotCeldaViolinplotDecontXContaminationplotDecontXMarkerExpressionplotDecontXMarkerPercentageplotDimReduceClusterplotDimReduceFeatureplotDimReduceGridplotDimReduceModuleplotGridSearchPerplexityplotHeatmapplotRPCrecodeClusterYrecodeClusterZrecursiveSplitCellrecursiveSplitModulereorderCeldareportCeldaCGPlotResultsreportCeldaCGRunresamplePerplexityresListretrieveFeatureIndexrunParamssampleLabelsampleLabel<-selectBestModelselectFeaturessimulateCellssimulateContaminationsplitModulesubsetCeldaListtopRank

Dependencies:abindaskpassbeachmatbeeswarmBHBiobaseBiocGenericsBiocNeighborsBiocParallelBiocSingularblusterCairocirclizecliclueclustercodetoolscolorspacecombinatComplexHeatmapcpp11crayoncurldata.tabledbscanDelayedArrayDelayedMatrixStatsdigestdoParalleldqrngedgeRenrichRfansifarverFNNforeachformatRfutile.loggerfutile.optionsgenericsGenomeInfoDbGenomeInfoDbDataGenomicRangesGetoptLongggbeeswarmggplot2ggrastrggrepelGlobalOptionsgluegridExtragtablehttrigraphIRangesirlbaisobanditeratorsjsonlitelabelinglambda.rlatticelifecyclelimmalocfitmagrittrMASSMatrixMatrixGenericsmatrixStatsMCMCprecisionmetapodmgcvmimemunsellnlmeopensslpheatmappillarpkgconfigplyrpngR6raggRColorBrewerRcppRcppAnnoyRcppArmadilloRcppEigenRcppHNSWRcppMLRcppProgressreshape2rjsonrlangRSpectrarsvdRtsneS4ArraysS4VectorsScaledMatrixscalesscaterscranscuttleshapeSingleCellExperimentsitmosnowSparseArraysparseMatrixStatsstatmodstringistringrSummarizedExperimentsyssystemfontstextshapingtibbleUCSC.utilsutf8uwotvctrsviporviridisviridisLitewithrWriteXLSXVectorzlibbioc

Readme and manuals

Help Manual

Help pageTopics
Append two celdaList objectsappendCeldaList
available modelsavailableModels
Get the log-likelihoodbestLogLikelihood bestLogLikelihood,celdaModel-method bestLogLikelihood,SingleCellExperiment-method
Celda modelscelda
Cell clustering with Celdacelda_C celda_C,ANY-method celda_C,SingleCellExperiment-method
Cell and feature clustering with Celdacelda_CG celda_CG,ANY-method celda_CG,SingleCellExperiment-method
Feature clustering with Celdacelda_G celda_G,ANY-method celda_G,SingleCellExperiment-method
celdaCGGridSearchResceldaCGGridSearchRes
celdaCGmodceldaCGMod
celdaCGSimceldaCGSim
Get or set the cell cluster labels from a celda SingleCellExperiment object or celda model object.celdaClusters celdaClusters,celdaModel-method celdaClusters,SingleCellExperiment-method celdaClusters<- celdaClusters<-,SingleCellExperiment-method
celdaCModceldaCMod
celdaCSimceldaCSim
celdaGModceldaGMod
Run Celda in parallel with multiple parametersceldaGridSearch celdaGridSearch,matrix-method celdaGridSearch,SingleCellExperiment-method
celdaGSimceldaGSim
Plot celda HeatmapceldaHeatmap celdaHeatmap,SingleCellExperiment-method
Get celda model from a celda SingleCellExperiment objectceldaModel celdaModel,SingleCellExperiment-method
Get or set the feature module labels from a celda SingleCellExperiment object.celdaModules celdaModules,SingleCellExperiment-method celdaModules<- celdaModules<-,SingleCellExperiment-method
Get perplexity for every model in a celdaListceldaPerplexity
Get perplexity for every model in a celdaListceldaPerplexity,celdaList-method
Probability map for a celda modelceldaProbabilityMap celdaProbabilityMap,SingleCellExperiment-method
Convert old celda model object to 'SCE' objectceldatosce celdatosce,celdaList-method celdatosce,celda_C-method celdatosce,celda_CG-method celdatosce,celda_G-method
t-Distributed Stochastic Neighbor Embedding (t-SNE) dimension reduction for celda 'sce' objectceldaTsne celdaTsne,SingleCellExperiment-method
Uniform Manifold Approximation and Projection (UMAP) dimension reduction for celda 'sce' objectceldaUmap celdaUmap,SingleCellExperiment-method
Get the conditional probabilities of cell in subpopulations from celda modelclusterProbability clusterProbability,SingleCellExperiment-method
Check count matrix consistencycompareCountMatrix compareCountMatrix,ANY,celdaList-method compareCountMatrix,ANY,celdaModel-method
contaminationSimcontaminationSim
Get the MD5 hash of the count matrix from the celdaListcountChecksum
Get the MD5 hash of the count matrix from the celdaListcountChecksum,celdaList-method
Contamination estimation with decontXdecontX decontX,ANY-method decontX,SingleCellExperiment-method
Get or set decontaminated counts matrixdecontXcounts decontXcounts,SingleCellExperiment-method decontXcounts<- decontXcounts<-,SingleCellExperiment-method
Create a color palettedistinctColors
Fast matrix multiplication for double x inteigenMatMultInt
Fast matrix multiplication for double x doubleeigenMatMultNumeric
Generate factorized matrices showing each feature's influence on cell / gene clusteringfactorizeMatrix factorizeMatrix,ANY,celda_C-method factorizeMatrix,ANY,celda_CG-method factorizeMatrix,ANY,celda_G-method factorizeMatrix,SingleCellExperiment,ANY-method
Fast normalization for numeric matrixfastNormProp
Fast normalization for numeric matrixfastNormPropLog
Fast normalization for numeric matrixfastNormPropSqrt
Obtain the gene module of a gene of interestfeatureModuleLookup featureModuleLookup,SingleCellExperiment-method
Output a feature module tablefeatureModuleTable
Gene set enrichmentgeneSetEnrich geneSetEnrich,matrix-method geneSetEnrich,SingleCellExperiment-method
Calculate the Log-likelihood of a celda modellogLikelihood logLikelihood,matrix,celda_C-method logLikelihood,matrix,celda_CG-method logLikelihood,matrix,celda_G-method logLikelihood,SingleCellExperiment,ANY-method
Get log-likelihood historylogLikelihoodHistory logLikelihoodHistory,celdaModel-method logLikelihoodHistory,SingleCellExperiment-method
Get feature, cell and sample names from a celdaModelmatrixNames matrixNames,celdaModel-method
Heatmap for featureModulesmoduleHeatmap moduleHeatmap,SingleCellExperiment-method
get row and column indices of none zero elements in the matrixnonzero
Normalization of count datanormalizeCounts
Get parameter values provided for celdaModel creationparams params,celdaModel-method
Calculate the perplexity of a celda modelperplexity perplexity,ANY,celda_C-method perplexity,ANY,celda_CG-method perplexity,ANY,celda_G-method perplexity,SingleCellExperiment,ANY-method
Feature Expression Violin PlotplotCeldaViolin plotCeldaViolin,ANY-method plotCeldaViolin,SingleCellExperiment-method
Plots contamination on UMAP coordinatesplotDecontXContamination
Plots expression of marker genes before and after decontaminationplotDecontXMarkerExpression
Plots percentage of cells cell types expressing markersplotDecontXMarkerPercentage
Plotting the cell labels on a dimension reduction plotplotDimReduceCluster plotDimReduceCluster,SingleCellExperiment-method plotDimReduceCluster,vector-method
Plotting feature expression on a dimension reduction plotplotDimReduceFeature plotDimReduceFeature,ANY-method plotDimReduceFeature,SingleCellExperiment-method
Mapping the dimension reduction plotplotDimReduceGrid plotDimReduceGrid,ANY-method plotDimReduceGrid,SingleCellExperiment-method
Plotting Celda module probability on a dimension reduction plotplotDimReduceModule plotDimReduceModule,ANY-method plotDimReduceModule,SingleCellExperiment-method
Visualize perplexity of a list of celda modelsplotGridSearchPerplexity plotGridSearchPerplexity,celdaList-method plotGridSearchPerplexity,SingleCellExperiment-method
Plots heatmap based on Celda modelplotHeatmap
Visualize perplexity differences of a list of celda modelsplotRPC plotRPC,celdaList-method plotRPC,SingleCellExperiment-method
Recode feature module labelsrecodeClusterY
Recode cell cluster labelsrecodeClusterZ
Recursive cell splittingrecursiveSplitCell recursiveSplitCell,matrix-method recursiveSplitCell,SingleCellExperiment-method
Recursive module splittingrecursiveSplitModule recursiveSplitModule,matrix-method recursiveSplitModule,SingleCellExperiment-method
Reorder cells populations and/or features modules using hierarchical clusteringreorderCelda reorderCelda,matrix,celda_C-method reorderCelda,matrix,celda_CG-method reorderCelda,matrix,celda_G-method reorderCelda,SingleCellExperiment,ANY-method
Generate an HTML report for celda_CGreportceldaCG reportCeldaCGPlotResults reportCeldaCGRun
Calculate and visualize perplexity of all models in a celdaListresamplePerplexity resamplePerplexity,ANY-method resamplePerplexity,SingleCellExperiment-method
Get final celdaModels from a celda model 'SCE' or celdaList objectresList resList,celdaList-method resList,SingleCellExperiment-method
Retrieve row index for a set of featuresretrieveFeatureIndex
Get run parameters from a celda model 'SingleCellExperiment' or 'celdaList' objectrunParams runParams,celdaList-method runParams,SingleCellExperiment-method
sampleCellssampleCells
Get or set sample labels from a celda SingleCellExperiment objectsampleLabel sampleLabel,celdaModel-method sampleLabel,SingleCellExperiment-method sampleLabel<- sampleLabel<-,SingleCellExperiment-method
sceCeldaCsceCeldaC
sceCeldaCGsceCeldaCG
sceCeldaCGGridSearchsceCeldaCGGridSearch
sceCeldaGsceCeldaG
Select best chain within each combination of parametersselectBestModel selectBestModel,celdaList-method selectBestModel,SingleCellExperiment-method
Simple feature selection by feature countsselectFeatures selectFeatures,matrix-method selectFeatures,SingleCellExperiment-method
A function to draw clustered heatmaps.semiPheatmap
Simulate count data from the celda generative models.simulateCells
Simulate contaminated count matrixsimulateContamination
Split celda feature modulesplitModule splitModule,SingleCellExperiment-method
Subset celda model from SCE object returned from 'celdaGridSearch'subsetCeldaList subsetCeldaList,celdaList-method subsetCeldaList,SingleCellExperiment-method
Identify features with the highest influence on clustering.topRank