Man pages for bioinfocz/scdrake
A pipeline for droplet-based single-cell RNA-seq data secondary analysis implemented in the drake Make-like toolkit for R language

add_item_to_listAdd named item (including 'NULL') to a list.
additional_cell_data_fnLoad additional cell data from a CSV or Rds (dataframe) file.
add_marker_table_linksConvert specified columns of a marker table to HTML links.
assert_that_A wrapper around 'assertthat::assert_that()'.
as_seuratConvert a 'SingleCellExperiment' to 'Seurat' object.
calc_sc3Run SC3 clustering for a specific 'k'.
cc_genes_fnGet dataframe of cell cycle genes.
cell_annotation_diagnostic_plots_files_fnSave cell annotation diagnostic plots to PDF files.
cell_annotation_diagnostic_plots_fnGenerate diagnostic plots for cell annotation.
cell_annotation_fnPerform cell annotation via 'SingleR::SingleR()'.
cell_annotation_labels_fnCreate a named list of cell labels returned from...
cell_annotation_params_fnLoad a list of cell annotation references into a 'tibble'.
cell_dataCreate new cell groups based on existing ones.
cell_data_fnMerge all cell-related data to a single DataFrame.
cells_per_cluster_tableGet a frequency table of cell-cluster assignments.
cells_per_cluster_table_collapsed_htmlPrint a HTML of table collapsible by button.
check_pandocCheck for 'pandoc"s binary.
check_pkg_installedCheck if a package is installed and display an informative...
check_scdrakeCheck for selected 'scdrake' dependencies.
check_yqCheck the availability and version of the 'yq' tool.
cliInstall or check the command line interface scripts.
cluster_markers_fnAdd LFC summaries for Wilcox tests, obtained from t-test...
cluster_markers_heatmaps_df_fnCreate a final 'tibble' holding parameters for cluster...
cluster_markers_out_fnCreate a final 'dataframe' of cluster markers.
cluster_markers_paramsExtract columns with certain parameters from cluster markers...
cluster_markers_params_fnLoad a list of cluster markers sources into a 'tibble'.
cluster_markers_processed_fnAdd additional summary columns of cluster markers for...
cluster_sc3_cluster_stability_plots_file_fnSave SC3 cluster stability plots to a single PDF.
cluster_sc3_df_fnCreate a dataframe of SC3 clusters for a selected number of...
collapse_ensembl_multivalsCollapse a character vector by '","'.
contrasts_fnExtract contrast statistics from cluster markers tests.
contrasts_heatmaps_df_fnCreate a 'tibble' holding contrast results and heatmap...
contrasts_out_fnFormat a 'tibble' with contrast results.
contrasts_paramsPrepare a 'tibble' with parameters for contrasts tests.
create_dirsCreate a basic directory structure based on paths in config.
create_dummy_plotCreate a blank 'ggplot' with label.
create_seu_for_heatmapsCreate a 'Seurat' object used for heatmap generation.
dimred_plots_cell_annotation_params_df_fnMake a tibble with parameters for dimred plots of cell...
dimred_plots_clustering_fnMake a dimred plot for each clustering and dimred method.
dimred_plots_clustering_united_files_fnPut clustering dimred plots for different parameters...
dimred_plots_from_params_dfMake dimred plots of selected variables.
dimred_plots_other_vars_params_df_fnMake a tibble with parameters for dimred plots of selected...
dot-apply_config_patchesApply YAML config patches to package-bundled configs.
dot-check_integration_methodsCheck for valid 'INTEGRATION_SOURCES' parameter.
dot-check_marker_sourcesCheck for correct structure of 'CLUSTER_MARKERS_SOURCES' or...
dot-get_dict_paramUnlist a list of length one containing a named list.
dot-hereize_pathsUsing the 'here' package, contruct paths relative to...
dot-load_config_groupLoad a group of YAML config files.
dot-load_configsLoad a list of YAML config files.
dot-paths_to_base_dirConstruct paths relative to base directory.
dot-update_configs_recursiveRecursively update local configs using a file glob...
download_example_dataDownload PBMC example data from 10x Genomics.
download_yqDownload the binary of the 'yq' tool (version 3.4.1).
empty_droplets_fnCalculate empty droplet statistics for each cell.
filter_markersFilter a dataframe with cluster markers.
filter_nullsReturn list with removed 'NULL' elements.
format_shell_commandFormat a shell command as a Markdown codeblock.
format_used_functionsUse the '{downlit}' package to generate a Markdown list of...
generate_cell_annotation_plots_sectionGenerate a section with dimred plots used in some RMarkdown...
generate_dimred_plots_clustering_sectionGenerate a section of clustering dimensionality reduction...
generate_dimred_plots_sectionGenerate a section with dimred plots used in some RMarkdown...
generate_markers_results_sectionGenerate a table with links to marker results.
generate_stage_reportRender RMarkdown document for a stage of the pipeline.
get_cell_annotation_subplanGet a subplan for cell annotation via 'SingleR'
get_clustering_graph_subplanGet a subplan for graph-based clustering.
get_clustering_kmeans_subplanGet a subplan for k-means clustering.
get_clustering_sc3_subplanGet a subplan for SC3 clustering.
get_clustering_subplanGet subplan for clustering.
get_dimred_plots_other_vars_subplanGet a subplan for dimensionality reduction plots of selected...
get_gene_filterGet a logical filter for genes not passing a ratio of cells...
get_int_method_descriptionReturn description for an integration method.
get_pca_gene_var_pcsGet a number of PCs corresponding to biological variation.
get_pca_selected_pcsGet a final selection of number of PCs.
get_planGet a 'drake' plan for a specific analysis type.
get_random_stringsGenerate random strings compounded from alphabetical...
get_subplan_commonGet a 'drake' subplan common to all pipelines.
get_subplan_integrationGet a 'drake' plan for a stage of integration pipeline.
get_subplan_single_sampleGet a 'drake' plan for a stage of single-sample pipeline.
get_sys_envRead an environment variable and if needed, assign a default...
get_tmp_dirGet a path to the temporary directory according to the OS.
get_top_hvgsGet top N highly variable genes (HVGs) by a specified metric.
get_used_qc_filters_operator_descReturn an informative message about the used operator to join...
get_yq_default_pathReturn a default download path for the 'yq' tool's binary.
grapes-and-and-grapesA short-circuit evaluation-like function similar to 'bash"s...
graph_snn_fnCompute shared nearest neighbors (SNN) graph.
highlight_pointsHighlight points belonging to certain levels.
html_linksGenerate a HTML link as <a></a> or in the form of image as...
hvg_int_list_fnGet a named list of HVG data (gene IDs, fit, metadata).
hvg_plot_int_fnMake a HVG plot for uncorrected 'SingleCellExperiment' object...
init_projectInitialize a new 'scdrake' project.
int_diagnostics_df_fnCompute and make integration diagnostics and plots for each...
integration_methods_df_fnMake a tibble with integration methods and their parameters.
lapply_rowsApply a function over rows of a 'data.frame'-like object and...
list_names_to_valuesAppend names of a list of lists as values in each sublist.
lists_to_tibbleConvert list of lists to tibble.
load_configLoad a YAML config file as 'scdrake_list'.
load_custom_planSource a file returning a custom drake plan.
make_gene_annotationCreate a 'dataframe' with annotation of SCE object's genes...
make_kmeans_gaps_plotMake a plot of k-means gaps.
make_pca_selected_pcs_plotMake a plot showing numbers of selected PCs from all...
marker_heatmapMake a heatmap of cell clusters.
marker_heatmaps_wrapperMake a heatmap of global or contrast markers.
marker_plotMake a marker plot.
markers_dimred_plotsMake dimred plots for each marker source defined in...
markers_dimred_plots_filesSave dimred plots.
markers_for_tablesMake a table used in HTML report of marker results.
markers_plots_filesMake plots of top markers.
markers_plots_topGet a tibble of top markers extracted from each test result.
markers_table_filesPrepare a table with markers and render a HTML report from...
md_headerGenerate a Markdown header.
merge_sce_metadataMerge 'metadata()' of multiple 'SingleCellExperiment' object.
na_emptyReturn 'NA' if an object is empty.
pca_phase_plots_fnMake dimred plots of PCA colored by cell cycle phase.
plot_clustreePlot clustering tree.
plot_colDataA wrapper for 'scater::plotColData()'.
plot_hvgPlot average expression vs. HVG metrics (total, bio, and...
plot_hvg_fitPlot fit of a HVG metric and highlight HVGs.
plotReducedDim_modA wrapper around 'scater::plotReducedDim()'.
plot_vlnMake a combined violin-boxplot plot.
prepare_marker_source_paramsPrepare a 'tibble' with parameters for cluster marker tests.
process_configConfig processing.
reexportsObjects exported from other packages
render_bootstrap_tableRender a dataframe-like object using 'knitr::kable()' and...
replace_list_nas_with_nullsReplace 'NA's in a list by 'NULL's.
replace_list_nullsReplace 'NULL' items in a defined depth of a list.
run_graph_based_clusteringFind clusters in SNN graph using a community detection...
run_kmeans_clusteringRun k-means clustering for a specific 'k'.
run_pipelineRun the 'scdrake' pipeline.
save_clustreeSave a clustree plot into PDF.
save_pdfSave a list of plots to multipage PDF.
save_printCapture output from 'print()' of an object.
save_selected_markers_plots_filesSave plots of selected markers.
SCDRAKE_CLI_VERSIONMatching CLI version for this package version.
scdrake_listA 'scdrake"s list with overloaded, strict access operators.
scdrake_makeExecute a 'scdrake"s pipeline plan.
scdrake_optionsOptions used by 'scdrake'.
scdrake-packagescdrake: A pipeline for droplet-based single-cell RNA-seq...
sce_add_cell_dataAdd columns to 'colData()' of a 'SingleCellExperiment'...
sce_add_colDataAppend new columns to 'colData' of a 'SingleCellExperiment'...
sce_add_metadataAppend data to 'metadata()' list of a 'SingleCellExperiment'...
sce_calc_pcaCalculate PCA of a 'SingleCellExperiment' object.
sce_cc_fnAssign cell cycle phase to cells.
sce_compute_dimredsCompute t-SNE and UMAP dimreds on a 'SingleCellExperiment'...
sce_final_input_qc_fnFinalize a 'SingleCellExperiment' object which will proceed...
sce_get_cc_genesIdentify cell cycle-related genes by using variance explained...
sce_history_fnCreate a tibble with history of cell and gene filtering.
sce_history_plot_fnPlot history of cell and gene filtering.
sce_int_clustering_df_fnCompute a quick graph-based clustering for each integration...
sce_int_combine_hvgsCombine HVG data from a list of 'SingleCellExperiment'...
sce_int_df_fnPerform integration of single-samples.
sce_int_dimred_df_fnCalculate t-SNE and UMAP for each integration method result...
sce_int_dimred_plots_df_fnMake dimred plot for each combination of integration method,...
sce_int_import_fnImport 'sce_final_norm_clustering' targets from 'drake'...
sce_int_pca_df_fnCompute PCA for each integration method result...
sce_int_processed_fnSubset each object in a list of 'SingleCellExperiment'...
sce_int_raw_snn_clustering_fnPerform a fast shared nearest neighbor clustering of each...
sce_normNormalize counts either by 'scran' or 'sctransform'.
sce_norm_hvg_fnFind highly variable genes (HVGs).
sce_raw_fnImport scRNA-seq data.
sce_remove_cc_genesRemove cell cycle-related genes from HVGs.
sce_rm_doublets_fnRemove cell doublets from a 'SingleCellExperiment' object.
sce_selected_fnSelect a 'SingleCellExperiment' object which will proceed to...
sce_valid_cells_fnSubset cells in a 'SingleCellExperiment' object to non-empty...
scran_markersCompute cell cluster markers.
selected_markers_dimplotMake a grid of feature plots for selected markers.
selected_markers_int_df_fnPrepare parameters for expression plots of selected markers.
selected_markers_int_plots_df_fnMake expression plots of selected markers.
selected_markers_plots_fnMake a grid of feature plots for selected genes.
set_rstudio_drake_cacheSet 'rstudio_drake_cache' option.
seu_add_metadataAppend data to metadata o a 'Seurat' object's assay.
text_utils_glueVarious wrappers around 'glue::glue()' and 'cat()'.
text_utils_joiningVarious utils for joining of text.
update_configUpdate a local YAML config file using a default one.
update_config_groupUpdate a group of configs, i.e. pipeline, single-sample, or...
update_projectUpdate 'scdrake' project files.
which_genes_regexGet indices of genes whose annotation matches a regex.
with_dbiLoad a SQL database file and run a function from the...
with_planLocally change a 'future' plan.
yq_merge_cmdMerge two YAML files using the 'yq' tool.
bioinfocz/scdrake documentation built on Jan. 29, 2024, 10:24 a.m.