Learn R Programming

⚠️There's a newer version (1.0.1) of this package.Take me there.

ArchR has new features available for scATAC-seq Analysis

Paired scATAC-seq and scRNA-seq Analysis

ArchR now supports paired scATAC-seq and scRNA-seq Analysis!       See updates with importFeatureMatrix, addGeneExpressionMatrix, addIterativeLSI, addCombinedDims       For a brief tutorial of these features : https://greenleaflab.github.io/ArchR_2020/Ex-Analyze-Multiome.html

Trajectory Analysis

ArchR now directly supports both monocle3 and Slingshot based trajectory analysis!       See updates with getMonocleTrajectories, addMonocleTrajectory, addSlingShotTrajectories       For a brief tutorial of these features : https://greenleaflab.github.io/ArchR_2020/Ex-Analyze-Trajectory.html

Additionally ArchR now enables export of a peak matrix that is compatible with STREAM!       See updates with exportPeakMatrixForSTREAM

ArchR is currently in Beta and will be in active development through the peer review process.

ArchR is a full-featured R package for processing and analyzing single-cell ATAC-seq data. ArchR provides the most extensive suite of scATAC-seq analysis tools of any software available. Additionally, ArchR excels in both speed and resource usage, making it possible to analyze 1 million cells in 8 hours on a MacBook Pro laptop.

For installation instructions and full documentation, visit www.ArchRProject.com.

Quick Installation of ArchR

For a full walk through of installation and frequently related issues please visit www.ArchRProject.com.

First, install devtools (for installing GitHub packages) if it isn't already installed:

if (!requireNamespace("devtools", quietly = TRUE)) install.packages("devtools")

Then, install BiocManager (for installing bioconductor packages) if it isn't already installed:

if (!requireNamespace("BiocManager", quietly = TRUE)) install.packages("BiocManager")

Then, install ArchR:

devtools::install_github("GreenleafLab/ArchR", ref="master", repos = BiocManager::repositories())

Lastly, install all of the ArchR dependencies that aren't installed by default:

library(ArchR)
ArchR::installExtraPackages()

If any of these steps fails, you should identify the offending package and troubleshoot that individual installation before proceeding. Additionally, please see the ArchR website (www.ArchRProject.com) where we have installation troubleshooting tips.

Issues using ArchR?

ArchR is currently in beta. We expect there to be bumps in the road. If you think you have found a bug, please first install the latest version of ArchR via

devtools::install_github("GreenleafLab/ArchR", ref="master", repos = BiocManager::repositories())

If this does not fix your problem, please report an issue on Github with the Bug Report form.

If you have questions about ArchR usage, please refer to the the searchable full user's manual, the FAQ section, and the publication. If you think the documentation on this website or in the function annotations is unclear, please submit an issue on Github with the Documentation Request form. If there is a feature that you think is missing from ArchR and you have already searched the user's manual, submit an issue on Github with the Feature Request form. If none of these options help, send us an email. We will do our best to respond to questions that are not otherwise answered in the documentation.

Copy Link

Version

Version

1.0.0

License

GPL (>= 2)

Maintainer

Jeffrey Granja

Last Published

September 6th, 2021

Functions in ArchR (1.0.0)

addDoubletScores

Add Doublet Scores to a collection of ArrowFiles or an ArchRProject
addArchRChrPrefix

Add a globally-applied requirement for chromosome prefix
addFeatureCounts

This function will add total counts of scATAC cells in provided features into ArchRProject.
addCoAccessibility

Add Peak Co-Accessibility to an ArchRProject
addCombinedDims

Combine two or more modalities dimensionality reductions.
addPeakSet

Add a peak set to an ArchRProject
addArchRGenome

Add a globally defined genome to all ArchR functions.
addArchRLogging

Set ArchR Logging
addIterativeLSI

Add an Iterative LSI-based dimensionality reduction to an ArchRProject
addImputeWeights

Add Imputation Weights to an ArchRProject
addFeatureMatrix

Add a feature matrix to an ArchRProject or a set of ArrowFiles
addGeneIntegrationMatrix

Add a GeneIntegrationMatrix to ArrowFiles or an ArchRProject
addGeneExpressionMatrix

Add Gene Expression Matrix to ArrowFiles or an ArchRProject
addGeneScoreMatrix

Add GeneScoreMatrix to ArrowFiles or an ArchRProject
addProjectSummary

Add projectSummary to an ArchRProject
addUMAP

Add a UMAP embedding of a reduced dimensions object to an ArchRProject
getArchRLogging

Get ArchR Logging
addSampleColData

Add information to sampleColData in an ArchRProject
addBgdPeaks

Add Background Peaks to an ArchRProject
addArchRThreads

Add a globally-applied number of threads to use for parallel computing.
addPeak2GeneLinks

Add Peak2GeneLinks to an ArchRProject
getCellNames

Get cellNames from an ArchRProject
createArrowFiles

Create Arrow Files
getChromLengths

Get chromLengths from ArchRProject
correlateMatrices

Correlate Matrices within an ArchRProject
$<-.ArchRProject

Add directly to cellColData directly from dollar.sign accessor
getSampleNames

Get the sample names from an ArchRProject
getMatches

Get peak annotation matches from an ArchRProject
getVarDeviations

Get Variable Deviations across cells in ArchRProject.
getValidBarcodes

Get Valid Barcodes from 10x Cell Ranger output to pre-filter barcodes
getFragmentsFromArrow

Get the fragments from an ArrowFile
getMarkers

Get Marker Features from a marker summarized experiment
confusionMatrix

Create a Confusion Matrix based on two value vectors
getGenomeAnnotation

Get the genomeAnnotation from an ArchRProject
getGroupSummary

Get summary for Groups in ArchRProject
getGenome

Get the genome used by an ArchRProject
exportPeakMatrixForSTREAM

Get a PeakMatrix stored in an ArchRProject and write out for STREAM
createGeneAnnotation

Create a gene annotation object for ArchR
getMonocleTrajectories

Get a Monocle CDS of Trajectories that can be added to an ArchRProject #NEW
getOutputDirectory

Get outputDirectory from an ArchRProject
ggPoint

A ggplot-based dot plot wrapper function
getTutorialData

Get Relevant Data For ArchR Tutorials
getTrajectory

Get Supervised Trajectory from an ArchR Project
installExtraPackages

Install extra packages used in ArchR that are not installed by default
loadArchRProject

Load Previous ArchRProject into R
plotEnrichHeatmap

Plot a Heatmap of Peak Annotation Hypergeometric Enrichment in Marker Peaks.
addTSNE

Add a TSNE embedding of a reduced dimensions object to an ArchRProject
plotEmbedding

Visualize an Embedding from ArchR Project
plotFootprints

Plot Footprints
subsetArchRProject

Subset an ArchRProject for downstream analysis
getAvailableMatrices

Get a list available matrices in the ArrowFiles storted in an ArchRProject
subsetCells

Subset cells in an ArchRProject.
ArchRProject

Create ArchRProject from ArrowFiles
addArchRAnnotations

Add ArchR annotations to an ArchRProject
correlateTrajectories

Correlate Trajectories
getFeatures

Get the features that could be selected from a given data matrix within an ArchRProject
getChromSizes

Get chromSizes from ArchRProject
findMacs2

Find the installed location of the MACS2 executable
getCoAccessibility

Get the peak co-accessibility from an ArchRProject
getPeakSet

Get the peak set from an ArchRProject
getFootprints

Calculate footprints from an ArchRProject
getMatrixFromProject

Get a data matrix stored in an ArchRProject
addDeviationsMatrix

Add a matrix of deviations for a given peakAnnotation to Arrow Files in ArchRProject
addPeakMatrix

Add a Peak Matrix to the ArrowFiles of an ArchRProject
addPeakAnnotations

Add peak annotations to an ArchRProject
projectBulkATAC

Project Bulk ATAC-seq data into single cell subspace
getInputFiles

Get Input Files from paths to create arrows
getMarkerFeatures

Identify Marker Features for each cell grouping
getTSS

Get the transcription start sites of all genes in an ArchRProject
ggHex

A ggplot-based Hexplot wrapper function summary of points in a standardized manner
ggOneToOne

A ggplot-based one-to-one dot plot wrapper function
nCells

Get the number of cells from an ArchRProject/ArrowFile
plotTrajectory

Visualize a Trajectory from ArchR Project
plotTSSEnrichment

Plot a TSS Enrichment Plot for Each Sample
mapLabels

Re-map a character vector of labels from an old set of labels to a new set of labels
createGenomeAnnotation

Create a genome annotation object for ArchR
filterChrGR

Filters unwanted seqlevels from a Genomic Ranges object or similar object
getCellColData

Get cellColData from an ArchRProject
getBlacklist

Get the blacklist from an ArchRProject
getGroupBW

Export Group BigWigs
getProjectSummary

Get projectSummary from an ArchRProject
getTestFragments

Get PBMC Small Test Fragments
getReducedDims

Get dimensionality reduction information stored in an ArchRProject
getTestProject

Get PBMC Small Test Project
validBSgenome

Get/Validate BSgenome
ggAlignPlots

Align ggplot plots vertically or horizontally
%bcni%

Negated matching function for S4Vector objects
ggGroup

A ggplot-based ridge/violin plot wrapper function
paletteDiscrete

Optimized discrete color palette generation
peakAnnoEnrichment

Peak Annotation Hypergeometric Enrichment in Marker Peaks.
plotMarkers

Plot Differential Markers
getPeakAnnotation

Get peakAnnotation from an ArchRProject
reformatFragmentFiles

Reformat Fragment Files to be Tabix and Chr Sorted
paletteContinuous

Continuous Color Palette
plotPDF

Plot PDF in outputDirectory of an ArchRProject
nonOverlappingGR

Retreive a non-overlapping set of regions from a Genomic Ranges object
saveArchRProject

Save ArchRProject for Later Usage
[.ArchRProject

Subset cells directly from ArchRProject
ArchRBrowser

Launch ArchR Genome Browser
ArchRPalettes

List of color palettes that can be used in plots
addArchRDebugging

Set ArchR Debugging
addModuleScore

Add Module Scores to an ArchRProject
addMonocleTrajectory

Add a Monocle Trajectory to an ArchR Project #NEW
addTrajectory

Add a Supervised Trajectory to an ArchR Project
addTileMatrix

Add TileMatrix to ArrowFiles or an ArchRProject
addReproduciblePeakSet

Add a Reproducible Peak Set to an ArchRProject
getArchRGenome

Get the globally defined genome, the geneAnnotation, or genomeAnnotation objects associated with the globally defined genome.
$.ArchRProject

Accessing cellColData directly from dollar.sign accessor
addMotifAnnotations

Add motif annotations to an ArchRProject
addCellColData

Add information to cellColData in an ArchRProject
addClusters

Add cluster information to an ArchRProject
addHarmony

Add Harmony Batch Corrected Reduced Dims to an ArchRProject
addGroupCoverages

Add Group Coverages to an ArchRProject object
getFragmentsFromProject

Get the fragments from an ArchRProject
getSampleColData

Get sampleColData from an ArchRProject
getImputeWeights

Get Imputation Weights from ArchRProject
.DollarNames.ArchRProject

Accessing cellColData directly from dollar.sign accessor
getArchRChrPrefix

Get a globally-applied requirement for chromosome prefix
getArchRDebugging

Get ArchR Debugging
%bcin%

Generic matching function for S4Vector objects
plotBrowserTrack

Plot an ArchR Region Track
addSlingShotTrajectories

Add a Slingshot Trajectories to an ArchR Project #NEW
filterDoublets

Filter Doublets From an ArchRProject
plotGroups

Visualize Groups from ArchR Project
plotFragmentSizes

Plot the fragment size distribution for each sample
getBgdPeaks

Get Background Peaks from an ArchRProject
getArrowFiles

Get ArrowFiles from an ArchRProject
getArchRThreads

Get globally-applied number of threads to use for parallel computing.
addDemuxletResults

Add Demuxlet Results to ArchR Project
getPositions

Get peak annotation positions from an ArchRProject
getMatrixFromArrow

Get a data matrix stored in an ArrowFile
plotTrajectoryHeatmap

Plot a Heatmap of Features across a Trajectory
getEmbedding

Get embedding information stored in an ArchRProject
theme_ArchR

ggplot2 default theme for ArchR
getSeqnames

Get the seqnames that could be selected from a given data matrix within an ArchRProject
getExons

Get the exons from an ArchRProject
extendGR

Extend regions from a Genomic Ranges object
createLogFile

Create a Log File for ArchR
getGeneAnnotation

Get geneAnnotation from an ArchRProject
getGenes

Get the genes from an ArchRProject
getGroupSE

Export Group Summarized Experiment
import10xFeatureMatrix

Import Feature Matrix from 10x Feature HDF5 file.
%ni%

Negated Value Matching
plotMarkerHeatmap

Plot a Heatmap of Identified Marker Features
getPeak2GeneLinks

Get the peak-to-gene links from an ArchRProject
imputeMatrix

Impute a matrix with impute weights
recoverArchRProject

Recover ArchRProject if broken sampleColData/cellColData
plotPeak2GeneHeatmap

Plot Peak2Gene Heatmap from an ArchRProject