Learn R Programming

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.1

License

GPL (>= 2)

Maintainer

Jeffrey Granja

Last Published

September 6th, 2021

Functions in ArchR (1.0.1)

addArchRLogging

Set ArchR Logging
addArchRChrPrefix

Add a globally-applied requirement for chromosome prefix
addArchRDebugging

Set ArchR Debugging
addFeatureCounts

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

Add information to cellColData in an ArchRProject
addBgdPeaks

Add Background Peaks to an ArchRProject
addGeneExpressionMatrix

Add Gene Expression Matrix to ArrowFiles or an ArchRProject
addFeatureMatrix

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

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

Set ArchR Verbosity for Log Messaging
addGeneIntegrationMatrix

Add a GeneIntegrationMatrix to ArrowFiles or an ArchRProject
addTileMatrix

Add TileMatrix to ArrowFiles or an ArchRProject
addTSNE

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

Combine two or more modalities dimensionality reductions.
ArchRBrowser

Launch ArchR Genome Browser
addDemuxletResults

Add Demuxlet Results to ArchR Project
ArchRPalettes

List of color palettes that can be used in plots
addGeneScoreMatrix

Add GeneScoreMatrix to ArrowFiles or an ArchRProject
addDeviationsMatrix

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

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

Create ArchRProject from ArrowFiles
addArchRAnnotations

Add ArchR annotations to an ArchRProject
addProjectSummary

Add projectSummary to an ArchRProject
addGroupCoverages

Add Group Coverages to an ArchRProject object
addReproduciblePeakSet

Add a Reproducible Peak Set to an ArchRProject
confusionMatrix

Create a Confusion Matrix based on two value vectors
addMonocleTrajectory

Add a Monocle Trajectory to an ArchR Project #NEW
getArchRChrPrefix

Get a globally-applied requirement for chromosome prefix
findMacs2

Find the installed location of the MACS2 executable
correlateMatrices

Correlate Matrices within an ArchRProject
getArchRVerbose

Set ArchR Verbosity for Log Messaging
getArrowFiles

Get ArrowFiles from an ArchRProject
addSampleColData

Add information to sampleColData in an ArchRProject
addModuleScore

Add Module Scores to an ArchRProject
addIterativeLSI

Add an Iterative LSI-based dimensionality reduction to an ArchRProject
$.ArchRProject

Accessing cellColData directly from dollar.sign accessor
addSlingShotTrajectories

Add a Slingshot Trajectories to an ArchR Project #NEW
addClusters

Add cluster information to an ArchRProject
createGenomeAnnotation

Create a genome annotation object for ArchR
createGeneAnnotation

Create a gene annotation object for ArchR
$<-.ArchRProject

Add directly to cellColData directly from dollar.sign accessor
exportPeakMatrixForSTREAM

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

Extend regions from a Genomic Ranges object
getGenes

Get the genes from an ArchRProject
getGeneAnnotation

Get geneAnnotation from an ArchRProject
getGenome

Get the genome used by an ArchRProject
getGenomeAnnotation

Get the genomeAnnotation from an ArchRProject
getFragmentsFromArrow

Get the fragments from an ArrowFile
addCoAccessibility

Add Peak Co-Accessibility to an ArchRProject
getChromLengths

Get chromLengths from ArchRProject
getCellNames

Get cellNames from an ArchRProject
addMotifAnnotations

Add motif annotations to an ArchRProject
getFootprints

Calculate footprints from an ArchRProject
getFeatures

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

Get a data matrix stored in an ArrowFile
getMatrixFromProject

Get a data matrix stored in an ArchRProject
getFragmentsFromProject

Get the fragments from an ArchRProject
getSeqnames

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

Correlate Trajectories
paletteDiscrete

Optimized discrete color palette generation
getGroupBW

Export Group BigWigs
peakAnnoEnrichment

Peak Annotation Hypergeometric Enrichment in Marker Peaks.
getTSS

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

Export Group Summarized Experiment
plotTrajectoryHeatmap

Plot a Heatmap of Features across a Trajectory
getGroupSummary

Get summary for Groups in ArchRProject
getImputeWeights

Get Imputation Weights from ArchRProject
getOutputDirectory

Get outputDirectory from an ArchRProject
getMonocleTrajectories

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

Get Variable Deviations across cells in ArchRProject.
getValidBarcodes

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

Align ggplot plots vertically or horizontally
createArrowFiles

Create Arrow Files
getProjectSummary

Get projectSummary from an ArchRProject
getReducedDims

Get dimensionality reduction information stored in an ArchRProject
loadArchRProject

Load Previous ArchRProject into R
ggGroup

A ggplot-based ridge/violin plot wrapper function
plotEnrichHeatmap

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

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

Plot Footprints
addPeakMatrix

Add a Peak Matrix to the ArrowFiles of an ArchRProject
addPeakSet

Add a peak set to an ArchRProject
addHarmony

Add Harmony Batch Corrected Reduced Dims to an ArchRProject
projectBulkATAC

Project Bulk ATAC-seq data into single cell subspace
theme_ArchR

ggplot2 default theme for ArchR
validBSgenome

Get/Validate BSgenome
%bcin%

Generic matching function for S4Vector objects
getTutorialData

Get Relevant Data For ArchR Tutorials
plotBrowserTrack

Plot an ArchR Region Track
ggPoint

A ggplot-based dot plot wrapper function
getTrajectory

Get Supervised Trajectory from an ArchR Project
getArchRDebugging

Get ArchR Debugging
getArchRGenome

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

Visualize an Embedding from ArchR Project
addPeak2GeneLinks

Add Peak2GeneLinks to an ArchRProject
addImputeWeights

Add Imputation Weights to an ArchRProject
addPeakAnnotations

Add peak annotations to an ArchRProject
plotTSSEnrichment

Plot a TSS Enrichment Plot for Each Sample
plotTrajectory

Visualize a Trajectory from ArchR Project
subsetCells

Subset cells in an ArchRProject.
subsetArchRProject

Subset an ArchRProject for downstream analysis
filterChrGR

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

Add a Supervised Trajectory to an ArchR Project
getAvailableMatrices

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

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

Get Background Peaks from an ArchRProject
getPeakAnnotation

Get peakAnnotation from an ArchRProject
ggOneToOne

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

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

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

Filter Doublets From an ArchRProject
plotFragmentSizes

Plot the fragment size distribution for each sample
nCells

Get the number of cells from an ArchRProject/ArrowFile
getArchRLogging

Get ArchR Logging
getArchRThreads

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

Visualize Groups from ArchR Project
getExons

Get the exons from an ArchRProject
getEmbedding

Get embedding information stored in an ArchRProject
recoverArchRProject

Recover ArchRProject if broken sampleColData/cellColData
addUMAP

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

Create a Log File for ArchR
.DollarNames.ArchRProject

Accessing cellColData directly from dollar.sign accessor
getBlacklist

Get the blacklist from an ArchRProject
getCellColData

Get cellColData from an ArchRProject
getMatches

Get peak annotation matches from an ArchRProject
getMarkers

Get Marker Features from a marker summarized experiment
reformatFragmentFiles

Reformat Fragment Files to be Tabix and Chr Sorted
getPositions

Get peak annotation positions from an ArchRProject
getSampleNames

Get the sample names from an ArchRProject
getPeakSet

Get the peak set from an ArchRProject
getSampleColData

Get sampleColData from an ArchRProject
%bcni%

Negated matching function for S4Vector objects
%ni%

Negated Value Matching
getChromSizes

Get chromSizes from ArchRProject
getCoAccessibility

Get the peak co-accessibility from an ArchRProject
plotMarkerHeatmap

Plot a Heatmap of Identified Marker Features
getMarkerFeatures

Identify Marker Features for each cell grouping
getInputFiles

Get Input Files from paths to create arrows
getTestFragments

Get PBMC Small Test Fragments
import10xFeatureMatrix

Import Feature Matrix from 10x Feature HDF5 file.
getTestProject

Get PBMC Small Test Project
plotMarkers

Plot Differential Markers
imputeMatrix

Impute a matrix with impute weights
paletteContinuous

Continuous Color Palette
saveArchRProject

Save ArchRProject for Later Usage
plotPDF

Plot PDF in outputDirectory of an ArchRProject
nonOverlappingGR

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

Plot Peak2Gene Heatmap from an ArchRProject
[.ArchRProject

Subset cells directly from ArchRProject
addArchRGenome

Add a globally defined genome to all ArchR functions.