Skip to content

rr1859/R.4Cker

Repository files navigation

R.4Cker

4C-ker is a method developed to analyze 4C-Seq (circularized chromosome conformation capture) data. The manuscript can be found here (4C-ker: A method to reproducibly identify genome-wide interactions captured by 4C-Seq experiments).

For reviews on 4C-seq refer to the following articles:

  • van de Werken HJ, Methods in Enzymology, 2012
  • Splinter E, Methods, 2012
  • Raviram R, Epigenomics, 2014
4Cker is designed to identify domains of interaction
  1. near the bait (1MB on either side for 4bp enzymes and 5Mb on either side for 6bp enzymes)
  2. cis chromosome
  3. trans chromosomes

The required R packages to run R.4Cker are: MASS, DESeq2, psych, depmixS4, miscTools, devtools, RColorBrewer, ggplot2. To install R.4Cker:

library(devtools)
install_github("rr1859/R.4Cker")
library(R.4Cker)

The input to 4C-ker are 4 column tab-delimited count files with chr start end and counts per observed fragment. The extension to files can be named ‘.bedGraph’ to visualize the interaction profile on IGV genome browser. If you already have the count files skip to step 3, if not 4C-Seq FASTQ files can be mapped to a reduced genome (refer to steps 1-2).

1. Creating a reduced genome and mapping 4C-Seq reads

4C-Seq reads are usually mapped to a reduced genome consisting of unique sequence fragments adjacent to the primary restriction enzyme sites in the genome. A script (reduced_genome.sh) has been provided to create a custom reduced genome (this requires oligoMatch (ucsc command line tools - kent) and fastaFromBed (bedtools)). The fragment length should be length of the read minus the size of barcode and primer (including the RE sequence). In addition a FASTA(.fa) file for the primary enzyme and genome are required (files should be named according to what is provided in the .sh script - example: mm10.fa and hindiii.fa). The reduced genome can be used to map 4C-Seq single-end reads with bowtie2. First a bowtie2 index is created using bowtie2-build. With bowtie2, the -5 option can be used to trim the first ‘x’ bps that contain the barcode (if present) and the bait sequence including the RE. Below is an example to map 51bp long reads where the first 26 bps of the read contain a 6bp barcode + 20 bp of the sequence containing the bait sequence:

bash reduced_genome.sh -frag_len 30 -p_enzyme hindiii -genome mm10
bowtie2-build mm10_hindiii_flanking_sequences_25_unique.fa mm10_hindiii_flanking_sequences_25_unique
bowtie2 -p 12 -N 0 -5 26 \
	--un sample_unaligned.sam \
	-x mm10_hindiii_flanking_sequences_25_unique \
	-U sample.fastq \
	-S sample_aligned.sam

2. Creating a counts file from mapped data (SAM file output from bowtie2)

The SAM output from bowtie2 reads can be used to create a counts file(.bedGraph) with number of reads per RE fragment using the sam_bedGraph.sh file with the argument for the directory where .SAM files can be found. This will make a .bedGraph file for ALL *aligned.sam files in the folder. Once files are generated, remove the self-ligated and undigested fragments before analyzing 4C interactions.

bash sam_bedGraph.sh input_dir_forSAMfiles/

3. Removing the self-ligated and undigested fragments

To remove the self-ligated and undigested fragments, first find the coordinates based on the primer sequence (Watson strand regardless of primer strand and not including the RE sequence)

grep -i -B 1 "CTTCTATCTGCAGAGA" mm10_hindiii_flanking_sequences_25_unique_2.fa

>chr1:100025183-100025208
CTTCTATCTGCAGAGAAATATAGCC

Then find the sequence before and after the bait fragment

grep -E -A 1 -B 1 'chr1.100025183.100025208' mm10_hindiii_flanking_sites_25_unique_2.bed

chr1	100025152	100025177
chr1	100025183	100025208
chr1	100038369	100038394

Remove the fragments matching the coordinates from line 1 and 3 printed above from all .bedGraph file and generate new files with suffix '_rm_self_und.bedGraph'. Remember to do this for each bait.

for file in bait*bedGraph; do grep -v -E 'chr1.100025152.100025177|chr1.100038369.100038394' $file > $(echo $file | sed 's/.bedGraph/_rm_self_und.bedGraph/g'); done

4. Analyzing 4C interactions

As an example, datasets with baits on CD83 (HindIII) and the Tcrb Eb enhancer(NlaIII) will be used to demonstrate the use of 4C-ker. Count files for these datasets can be found in the data folder.

Creating a 4C-ker object: A 4C-ker object can be created using exiting data frames loaded in R (create4CkerObjectFromDFs) or by specifying the path to the .bedGraph files (createR4CkerObjectFromFiles). It will also check if the samples pass QC criteria and generate a stats file. To pass QC samples must have > than 1 million reads, > than 40% of reads on the cis chromosome and > 40% coverage in the 200kb region around the bait for 4bp cutter and 2MB for 6bp cutters. The function create4CkerObjectFromDFs can be used with the example datasets provided. The arguments for the function are as follows:

files/dfs: path to files or character string of the names of the data.frame variables
bait_chr: chromosome name of bait location
bait_coord: chromosomal coordinate of bait primer
primary_enz: sequence of primary restriction enzyme
samples: names of samples for all files
conditions: names of conditions being analyzed (min of 1)
replicates: number of replicates for each condition
species: code for species (Mouse=mm, Human=hs)
output_dir: path to directory where all output files will be saved
enz_file: data.frame containing RE fragments

For the RE fragments you can use the file generated from the reduced_genome script


enz_file=read.table("mm10_hindiii_flanking_sites_25_unique_2.bed", stringsAsFactors = FALSE)

For example to analyze interactions for 1 condition with 2 replicates using the example data (CD83_HindIII):


data(CD83_HindIII)
my_obj = createR4CkerObjectFromDFs(dfs = c("CD83_HindIII_1", "CD83_HindIII_2"),
                       bait_chr="chr13",
                       bait_coord= 43773612,
                       bait_name = "CD83",
                       primary_enz = "AAGCTT",
                       samples = c("CD83_H_1", "CD83_H_2"),
                       conditions = "CD83",
                       replicates = 2,
                       species = "mm",
                       output_dir = "~/Documents/CD83_results_R4Cker/",
		       enz_file=enz_file)

To analyze multiple conditions with the same bait:

enz_file=read.table("mm10_nlaiii_flanking_sites_25_unique_2.bed", stringsAsFactors = FALSE)
data(Tcrb_Eb_DN_ImmB_WT)
my_obj = createR4CkerObjectFromDFs(dfs = c("Tcrb_Eb_DN_WT_1","Tcrb_Eb_DN_WT_2","Tcrb_Eb_ImmB_WT_1","Tcrb_Eb_ImmB_WT_2"),
                       bait_chr="chr6",
                       bait_coord= 41553025,
                       bait_name = "Eb",
                       primary_enz = "CATG",
                       samples = c("DN_Eb_1", "DN_Eb_2", "ImmB_Eb_1", "ImmB_Eb_2"),
                       conditions = c("DN", "ImmB"),
                       replicates = c(2,2),
                       species = "mm",
                       output_dir = "~/Documents/Eb_DN_ImmB_results_R4Cker/",
		       enz_file=enz_file)

To use other datasets from the paper you can download the ZIP of R.4Cker from github and use the .bedGraph files in the data folder.

enz_file=read.table("mm10_hindiii_flanking_sites_25_unique_2.bed", stringsAsFactors = FALSE)
my_obj = createR4CkerObjectFromFiles(files = c("~/Downloads/R.4Cker-master/data/IghCg1_HindIII_1.bedGraph", 
					"~/Downloads/R.4Cker-master/data/IghCg1_HindIII_2.bedGraph"),
                       bait_chr="chr12",
                       bait_coord= 113321402,
                       bait_name = "Igh",
                       primary_enz = "AAGCTT",
                       samples = c("Igh_H_1", "Igh_H_2"),
                       conditions = "Igh",
                       replicates = 2,
                       species = "mm",
                       output_dir = "~/Documents/Igh_results_R4Cker/",
		       enz_file=enz_file)

Once my_obj has been created, the following functions can be called to define domains of interaction with the bait: nearBaitAnalysis, cisAnalysis, transAnalysis. Each of these functions takes as arguments, my_obj and the value of 'k' to determine the size of the adaptive windows. The BED files with the resulting domains of interaction files (*_highinter.bed) will be saved in the output directory. There will be one file for each replicate and one that contains domains called by all replicates. In addition, a normalized counts file will be created for the adaptive windows and can be viewed on IGV genome browser.

Near the bait analysis: For 4bp cutter experiments we recommend a k=3-5 and for 6bp cutter experiments a k=10. The function returns a data frame of windows used for the analysis and the mean window counts for each conditions.

nb_results=nearBaitAnalysis(my_obj,k=5)

To plot the 4C profile for all conditions near the bait:

library(ggplot2)
ggplot(nb_results$norm_counts_avg, aes(x=Coord, y=Count, colour=Condition))+
	theme_bw()+
	geom_line()+xlab(paste("Chromosome coordinates (", my_obj@bait_chr, ")", sep =""))+
	ylab("Normalized counts")+
	ggtitle(paste("Near bait analysis (", my_obj@bait_name, " bait)", sep = ""))

The X and Y axis limits can be changed to zoom into a particular region. Add to the end of ggplot function: +ylim(c(start,end))+xlim(c(start,end))

Cis analysis: We recommend a k=10 for all experiments.

cis_results=cisAnalysis(my_obj,k=10)

Trans analysis. We recommend a k=20 for 6bp experiments and a k=50+ for 4bp cutter experiments.

transAnalysis(my_obj,k=20)

4. Differential interactions using DESeq2

Differential analysis is done between two conditions on the windows that are interacting with the bait in at least 2 condition. We recommend this analysis only for nearbait and cis interactions. A plot of significant interactions will be generated and a BED file of significantly different domains will be saved in the output directory. The arguments for the function are as follows:
obj: 4CkerObject created for analysis
norm_counts_avg: Average counts of replicates for each condition per window
windows: Raw counts per window for each sample
conditions: Conditions to compare - only two conditions for each comparison
region: Region for analysis.options are: "nearbait" or "cis"
coordinates: Coordinates for a more focused analysis. example: coordinates=c(41e6,42e6)
pval: p-value cut off for DESeq2 analysis. Recommended values are 0.01,0.05 or 0.1. If given p-value fails, the function will try higher values upto 0.1

Example for nearbait analysis with Tcrb dataset:

res_df = differentialAnalysis(obj=my_obj,
			norm_counts_avg=nb_results$norm_counts_avg,
			windows=nb_results$window_counts,
			conditions=c("DN", "ImmB"),
			region="nearbait",
			coordinates=NULL,
			pval=0.05)

About

No description, website, or topics provided.

Resources

License

Stars

Watchers

Forks

Packages

No packages published