Skip to main content

Single Nucleus Methyl-Seq and Chromatin Capture (snm3C) Overview

Pipeline VersionDate UpdatedDocumentation AuthorsQuestions or Feedback
snm3C_v4.0.0March, 2024Kaylee MathewsPlease file GitHub issues in the WARP repository

Introduction to snm3C

The Single Nucleus Methly-Seq and Chromatin Capture (snm3C) workflow is an open-source, cloud-optimized computational workflow for processing single-nucleus methylome and chromatin contact (snm3C) sequencing data. The workflow is designed to demultiplex and align raw sequencing reads, call chromatin contacts, and generate summary metrics.

The workflow is developed in collaboration with Hanqing Liu, Wei Tian, Wubin Ding, Huaming Chen, Chongyuan Luo, Jingtian Zhou, and the entire laboratory of Joseph Ecker.

For more information about the snm3C tools and analysis, please see the YAP documentation or the cemba_data GitHub repository created by Hanqing Liu.

Quickstart table

The following table provides a quick glance at the Multiome pipeline features:

Pipeline featuresDescriptionSource
Assay typesingle-nucleus methylome and chromatin contact (snm3C) sequencing dataLee et al. 2019
Overall workflowRead alignment and chromatin contact calling
Workflow languageWDL 1.0openWDL
Genomic Reference SequenceGRCh38 human genome primary sequenceGENCODE human reference files
AlignerHISAT-3NZhang at al. 2021
Data input file formatFile format in which sequencing data is providedFASTQ
Data output file formatFile formats in which snm3C output is providedCSV, FASTQ, BAM, and ALLC

Set-up

snm3C installation

To download the latest snm3C release, see the release tags prefixed with "snm3C" on the WARP releases page. All snm3C pipeline releases are documented in the snm3C changelog.

To discover and search releases, use the WARP command-line tool Wreleaser.

If you’re running a version of the snm3C workflow prior to the latest release, the accompanying documentation for that release may be downloaded with the source code on the WARP releases page (see the source code folder website/docs/Pipelines/snm3C).

The snm3C workflow can be deployed using Cromwell, a GA4GH-compliant, flexible workflow management system that supports multiple computing platforms. The workflow can also be run in Terra, a cloud-based analysis platform.

Inputs

The snm3C workflow requires a JSON configuration file specifying the input files and parameters for the analysis. Example configuration files can be found in the snm3C test_inputs directory in the WARP repository.

Input descriptions

ParameterDescription
fastq_input_read1Array of multiplexed FASTQ files for read 1.
fastq_input_read2Array of multiplexed FASTQ files for read 2.
random_primer_indexesFile containing random primer indexes.
plate_idString specifying the plate ID.
tarred_index_filesFile containing tarred index files for hisat-3 mapping.
genome_faFile containing the reference genome in FASTA format.
chromosome_sizesFile containing the genome chromosome sizes.
r1_adapterOptional string describing the adapter sequence for read 1 paired-end reads to be used during adapter trimming with Cutadapt; default is "AGATCGGAAGAGCACACGTCTGAAC".
r2_adapterOptional string describing the adapter sequence for read 2 paired-end reads to be used during adapter trimming with Cutadapt; default is "AGATCGGAAGAGCGTCGTGTAGGGA".
r1_left_cutOptional integer describing the number of bases to be trimmed from the beginning of read 1 with Cutadapt; default is 10.
r1_right_cutOptional integer describing the number of bases to be trimmed from the end of read 1 with Cutadapt; default is 10.
r2_left_cutOptional integer describing the number of bases to be trimmed from the beginning of read 2 with Cutadapt; default is 10.
r2_right_cutOptional integer describing the number of bases to be trimmed from the end of read 2 with Cutadapt; default is 10.
min_read_lengthOptional integer; if a read length is smaller than min_read_length, both paired-end reads will be discarded; default is 30.
num_upstr_basesOptional integer describing the number of bases upstream of the C base to include in ALLC file context column created using ALLCools; default is 0.
num_downstr_basesOptional integer describing the number of bases downstream of the C base to include in ALLC file context column created using ALLCools; default is 2.
compress_levelOptional integer describing the compression level for the output ALLC file; default is 5.

snm3C tasks and tools

The workflow contains several tasks described below.

Overall, the snm3C workflow:

  1. Demultiplexes reads.
  2. Sorts, filters, trims, and aligns paired-end reads, and separates unmapped, uniquely aligned, and multi-aligned reads.
  3. Aligns unmapped, single-end reads and removes overlapping reads.
  4. Merges mapped reads, calls chromatin contacts, and creates ALLC files.
  5. Creates summary output file.

The tools each snm3C task employs are detailed in the table below.

To see specific tool parameters, select the workflow WDL link; then find the task and view the command {} section of the task in the WDL script. To view or use the exact tool software, see the task's Docker image which is specified in the task WDL # runtime values section as docker: . More details about these tools and parameters can be found in the YAP documentation.

Task nameToolSoftwareDescription
DemultiplexingCutadaptCutadaptPerforms demultiplexing to cell-level FASTQ files based on random primer indices.
Hisat-paired-endCutadapt, HISAT-3N, hisat3n_general.py, hisat3n_m3c.pyCutadapt, HISAT-3N, python3Sorts, filters, and trims reads using the r1_adapter, r2_adapter, r1_left_cut, r1_right_cut, r2_left_cut, and r2_right_cut input parameters; performs paired-end read alignment; imports 2 custom python3 scripts developed by Hanqing Liu and calls the separate_unique_and_multi_align_reads() and split_hisat3n_unmapped_reads() functions to separate unmapped, uniquely aligned, multi-aligned reads from HISAT-3N BAM file, then splits the unmapped reads FASTQ file by all possible enzyme cut sites and output new R1 and R2 FASTQ files; unmapped reads are stored in unmapped FASTQ files and uniquely and multi-aligned reads are stored in separate BAM files.
Hisat_single_endHISAT-3N, hisat3n_m3c.pyHISAT-3N, python3Performs single-end alignment of unmapped reads to maximize read mapping, imports a custom python3 script developed by Hanqing Liu, and calls the remove_overlap_read_parts() function to remove overlapping reads from the split alignment BAM file produced during single-end alignment.
Merge_sort_analyzemerge, sort, MarkDuplicates, hisat3n_m3c.py, bam-to-allc, extract-allcsamtools, Picard, python3, ALLCoolsMerges and sorts all mapped reads from the paired-end and single-end alignments; creates a position-sorted BAM file and a name-sorted BAM file; removes duplicate reads from the position-sorted, merged BAM file; imports a custom python3 script developed by Hanqing Liu and calls the call_chromatin_contacts() function to call chromatin contacts from the name-sorted, merged BAM file; reads are considered chromatin contacts if they are greater than 2,500 base pairs apart; creates a first ALLC file with a list of methylation points and a second ALLC file containing methylation contexts.
Summarysummary.pypython3Imports a custom python3 script developed by Hanqing Liu and calls the snm3c_summary() function to generate a single, summary file for the pipeline in CSV format; contains trimming, mapping, deduplication, chromatin contact, and AllC site statistics.

1. Demultiplexes reads

In the first step of the pipeline (Demultiplexing), raw sequencing reads are demultiplexed by random primer index into cell-level FASTQ files using Cutadapt. For more information on barcoding, see the YAP documentation.

2. Sorts, filters, trims, and aligns paired-end reads, and separates unmapped, uniquely aligned, and multi-aligned reads

Sorts, filters, and trims reads After demultiplexing, the pipeline uses Cutadapt to sort, filter, and trim reads in the hisat-paired-end task. The R1 and R2 adapter sequences are removed, along with the number of bases specified by the r1_left_cut, r1_right_cut, r2_left_cut, and r2_right_cut input parameters. Any reads shorter than the specified min_read_length are filtered out in this step.

Aligns paired-end reads Next, the task uses HISAT-3N to perform paired-end read alignment to a reference genome FASTA file (genome_fa) and outputs an aligned BAM file. Additionally, the task outputs a stats file and a text file containing the genomic reference version used.

Separates unmapped, uniquely aligned, and multi-aligned reads After paired-end alignment, the task imports a custom python3 script (hisat3n_general.py) developed by Hanqing Liu. The task calls the script's separate_unique_and_multi_align_reads() function to separate unmapped, uniquely aligned, and multi-aligned reads from the HISAT-3N BAM file. Three new files are output from this step of the pipeline:

  1. A FASTQ file that contains the unmapped reads (unmapped_fastq_tar)
  2. A BAM file that contains the uniquely aligned reads (unique_bam_tar)
  3. A BAM file that contains the multi-aligned reads (multi_bam_tar)

After separating reads, the task imports a custom python3 script (hisat3n_m3c.py) developed by Hanqing Liu and calls the script's split_hisat3n_unmapped_reads() function. This splits the FASTQ file containing the unmapped reads by all possible enzyme cut sites and outputs new R1 and R2 files.

3. Aligns unmapped, single-end reads and removes overlapping reads

In the next step of the pipeline, the Hisat_single_end task uses HISAT-3N to perform single-end read alignment of the previously unmapped reads to maximize read mapping and outputs a single, aligned BAM file.

After the second alignment step, the task imports a custom python3 script (hisat3n_m3c.py) developed by Hanqing Liu. The task calls the script's remove_overlap_read_parts() function to remove overlapping reads from the BAM file produced during single-end alignment and output another BAM file.

4. Merges mapped reads, calls chromatin contacts, and creates ALLC files

Merged mapped reads The Merge_sort_analyze task uses samtools to merge and sort all of the mapped reads from the paired-end and single-end alignments into a single BAM file. The BAM file is output as both a position-sorted and a name-sorted BAM file.

After merging, the task uses Picard's MarkDuplicates tool to remove duplicate reads from the position-sorted, merged BAM file and output a deduplicated BAM file.

Calls chromatin contacts Next, the pipeline imports a custom python3 script (hisat3n_m3c.py) developed by Hanqing Liu. The task calls the script's call_chromatin_contacts() function to call chromatin contacts from the name-sorted, merged BAM file. If reads are greater than 2,500 base pairs apart, they are considered chromatin contacts. If reads are less than 2,500 base pairs apart, they are considered the same fragment.

Creates ALLC files After calling chromatin contacts, the task uses the ALLCools bam-to-allc function to create an ALLC file from the deduplicated BAM file that contains a list of methylation points. The num_upstr_bases and num_downstr_bases input parameters are used to define the number of bases upstream and downstream of the C base to include in the ALLC context column.

Next, the task uses the ALLCools extract-allc function to extract methylation contexts from the input ALLC file and output a second ALLC file that can be used to generate an MCDS file.

6. Creates summary output file

In the last step of the pipeline, the summary task imports a custom python3 script (summary.py) developed by Hanqing Liu. The task calls the script's snm3c_summary() function to generate a single, summary file for the pipeline in CSV format; contains trimming, mapping, deduplication, chromatin contact, and AllC site statistics. This is the main output of the pipeline.

Outputs

The following table lists the output variables and files produced by the pipeline.

Output nameFilename, if applicableOutput format and description
MappingSummary<plate_id>_MappingSummary.csv.gzMapping summary file in CSV format.
name_sorted_bams<plate_id>.hisat3n_dna.all_reads.name_sort.tar.gzArray of tarred files containing name-sorted, merged BAM files.
unique_reads_cgn_extraction_allc<plate_id>.allc.tsv.tar.gzArray of tarred files containing list of methylation points.
unique_reads_cgn_extraction_tbi<plate_id>.allc.tbi.tar.gzArray of tarred files containing ALLC index files.
reference_version<plate_id>.reference_version.txtArray of tarred files containing the genomic reference version used.
all_reads_dedup_contacts<plate_id>.hisat3n_dna.all_reads.dedup_contacts.tar.gzArray of tarred TSV files containing deduplicated chromatin contacts.
all_reads_3C_contacts<plate_id>.hisat3n_dna.all_reads.3C.contact.tar.gzArray of tarred TSV files containing chromatin contacts in Hi-C format.
chromatin_contact_stats<plate_id>.chromatin_contact_stats.tar.gzArray of tarred files containing chromatin contact statistics.
unique_reads_cgn_extraction_allc_extract<plate_id>.extract-allc.tar.gzArray of tarred files containing CGN context-specific ALLC files that can be used to generate an MCDS file.
unique_reads_cgn_extraction_tbi_extract<plate_id>.extract-allc_tbi.tar.gzArray of tarred files containing ALLC index files.

Versioning

All snm3C pipeline releases are documented in the pipeline changelog.

Citing the snm3C Pipeline

If you use the snm3C Pipeline in your research, please identify the pipeline in your methods section using the snm3C SciCrunch resource identifier.

  • Ex: snm3C Pipeline (RRID:SCR_025041)

Please cite the following publications for the snm3C pipeline:

Lee, DS., Luo, C., Zhou, J. et al. Simultaneous profiling of 3D genome structure and DNA methylation in single human cells. Nat Methods 16, 999–1006 (2019). https://doi.org/10.1038/s41592-019-0547-z

Liu, H., Zhou, J., Tian, W. et al. DNA methylation atlas of the mouse brain at single-cell resolution. Nature 598, 120–128 (2021). https://doi.org/10.1038/s41586-020-03182-8

Please cite the following preprint for the WARP repository and website:

Degatano, K.; Awdeh, A.; Dingman, W.; Grant, G.; Khajouei, F.; Kiernan, E.; Konwar, K.; Mathews, K.; Palis, K.; Petrillo, N.; Van der Auwera, G.; Wang, C.; Way, J.; Pipelines, W. WDL Analysis Research Pipelines: Cloud-Optimized Workflows for Biological Data Processing and Reproducible Analysis. Preprints 2024, 2024012131. https://doi.org/10.20944/preprints202401.2131.v1

Consortia support

This pipeline is supported by the BRAIN Initiative (BICCN and BICAN).

If your organization also uses this pipeline, we would like to list you! Please reach out to us by contacting the WARP Pipeline Development team.

Acknowledgements

We are immensely grateful to the members of the BRAIN Initiative (BICAN Sequencing Working Group) and SCORCH for their invaluable and exceptional contributions to this pipeline. Our heartfelt appreciation goes to our collaborators and the developers of these tools, Hanqing Liu, Wei Tian, Wubin Ding, Huaming Chen, Chongyuan Luo, Jingtian Zhou, and the entire laboratory of Joseph Ecker.

Feedback

For questions, suggestions, or feedback related to the snm3C pipeline, please contact the WARP team. Your feedback is valuable for improving the pipeline and addressing any issues that may arise during its usage.