ChIP- seq Analysis. BaRC Hot Topics - Feb 24 th 2015 BioinformaBcs and Research CompuBng Whitehead InsBtute. hgp://barc.wi.mit.

Size: px
Start display at page:

Download "ChIP- seq Analysis. BaRC Hot Topics - Feb 24 th 2015 BioinformaBcs and Research CompuBng Whitehead InsBtute. hgp://barc.wi.mit."

Transcription

1 ChIP- seq Analysis BaRC Hot Topics - Feb 24 th 2015 BioinformaBcs and Research CompuBng Whitehead InsBtute hgp://barc.wi.mit.edu/hot_topics/

2 Before we start: 1. Log into tak (step 0 on the exercises) 2. Go to your lab space and create a folder for the class (see separate hand out) 3. Connect to your lab space through the wi- htdata network and open the folder you created 2

3 Outline ChIP- seq overview Quality control Experimental design Mapping Map reads Remove unmapped reads and convert to bam files Check the profile of the mapped reads Peak calling More detail about MACS opbons Linking peaks to genes Visualizing ChIP- seq data with ngsplot 3

4 ChIP-Seq overview Park, P. J., ChIP- seq: advantages and challenges of a maturing technology, Nat Rev Genet. Oct;10(10): (2009) 4

5 Steps in data analysis 1. Quality control 2. EffecBve mapping Treat IP and control the same way (preprocessing and mapping) 3. Peak calling i) Read extension and signal profile generabon ii) Peak assignment Pepke, S. et al. ComputaBon for ChIP- seq and RNA- seq studies, Nat Methods. Nov (2009) 5

6 Experimental design Include a control sample. If the protein of interest binds repebbve regions, using paired end sequencing may reduce the mapping ambiguity. Otherwise single reads should be fine. Include at least two biological replicates. If you have replicates you may want to use the parameter IDR irreproducible discovery rate. See us for details. If only a small percentage of the reads maps to the genome, you may have to troubleshoot your ChIP protocol. 6

7 Data that we will use on the hands on the exercises ENCODE human ChIP- seq experiment EncodeBroadHistoneHepg2H3k4me3 EncodeBroadHistoneHepg2Control For quality control and mapping we will use a subset of the data (10%) For running MACS we will use the full set but only chr1 reads 7

8 Quality control (before read mapping) See Hot Topics: Quality Control and Mapping Reads Run fastqc Look at output and determine 1. What type of quality encoding (Illumina versions) your reads have Input qualibes - - solexa- quals <= phred64 Illumina versions phred33 >= If you need to remove adapter, trim reads, filter reads based on quality etc. 8

9 Hands- on Step 1: Quality control Run step 1 commands (fastqc) bsub fastqc Hepg2Control_subset.fastq bsub fastqc Hepg2H3k4me3_subset.fastq 9

10 Fastqc Output 10

11 Mapping We have to map reads to the genome. The mapping solware doesn t have to know about splicing. BowBe, bowbe2 (allows gaps) are good choices Bwa (allows gaps) is fine too Treat IP and control samples the same way during preprocessing and mapping. 11

12 Hands- on Step 2: Mapping bsub bowbe2 - - phred33- quals - N 1 - x /nfs/genomes/ human_gp_feb_09_no_random/bowbe/hg19 - U Hepg2Control_subset.fastq - S Hepg2Control_subset_hg19.N1.sam bsub bowbe2 - - phred33- quals - N 1 - x /nfs/genomes/ human_gp_feb_09_no_random/bowbe/hg19 - U Hepg2H3k4me3_subset.fastq - S Hepg2H3k4me3_subset_hg19.N1.sam - - phred33- quals Because we have Illumina N <int> max # mismatches in seed alignment; can be 0 or 1 (default=0) - x path to the bowbe2 index - U input sequence - S output.sam 12

13 Hands- on Steps 3: Remove unmapped reads and convert to BAM. Sort and index the bam file. Remove unmapped reads bsub "samtools view - hs - F 4 Hepg2Control_subset_hg19.N1.sam samtools view - b - S - > Hepg2Control_subset_hg19.N1.mapped_only.bam" bsub "samtools view - hs - F 4 Hepg2H3k4me3_subset_hg19.N1.sam samtools view - b - S - > Hepg2H3k4me3_subset_hg19.N1.mapped_only.bam" Sort reads bsub samtools sort - T Control_subset - o Control_subset_hg19.N1.mapped_only.sorted.bam Hepg2Control_subset_hg19.N1.mapped_only.bam bsub samtools sort - T H3k4me3_subset - o H3k4me3_subset_hg19.N1.mapped_only.sorted.bam Hepg2H3k4me3_subset_hg19.N1.mapped_only.bam - T PREFIX Write temporary files to PREFIX.nnnn.bam - o FILE Write final output to FILE rather than standard output Index reads bsub samtools index Control_subset_hg19.N1.mapped_only.sorted.bam bsub samtools index H3k4me3_subset_hg19.N1.mapped_only.sorted.bam 13

14 Strand cross- correlabon analysis Bailey, et al. PracBcal Guidelines for the Comprehensive Analysis of ChIP- seq Data, PLOS ComputaPonal Biology Nov 2013 Strand cross- correlabon is computed as the Pearson correlabon between the posibve and the negabve strand profiles at different strand shil distances, k 14

15 Strand cross- correlabon analysis outputs 15

16 Hands- on Steps 4: Quality control aler read mapping Check the strand cross- correlabon peak and predominant fragment length. bsub /nfs/barc_public/phantompeakqualtools/run_spp.r - c=control_chr1.bam - savp - out=control_chr1.run_spp.out bsub /nfs/barc_public/phantompeakqualtools/run_spp.r - c=h3k4me3_chr1.bam - savp - out=h3k4me3_chr1.run_spp.out - savp, save cross- correlabon plot 16

17 Peak calling i) Read extension and signal profile generabon strand cross- correlabon can be used to calculate fragment length ii) Peak evaluabon Look for fold enrichment of the sample over input or expected background EsBmate the significance of the fold enrichment using: Poisson distribubon negabve binomial distribubon background distribubon from input DNA model background data to adjust for local variabon (MACS) Pepke, S. et al. ComputaBon for ChIP- seq and RNA- seq studies, Nat Methods. Nov

18 Peak calling: MACS MACS uses a two- step strategy: 1. Builds a model using high quality peaks and infers shil size from it. 2. Shils the reads and does a second round to call the final peaks. It uses a Poisson distribubon to assign p- values to peaks. But the distribubon has a dynamic parameter, local lambda, to capture the influence of local biases. MACS default is to filter out redundant tags at the same locabon and with the same strand by allowing at most 1 tag. This works well. - g: You need to set up this parameter accordingly: EffecBve genome size. It can be 1.0e+9 or , or shortcuts: 'hs' for human (2.7e9), 'mm' for mouse (1.87e9), 'ce' for C. elegans (9e7) and 'dm' for fruit fly (1.2e8), Default:hs For broad peaks like some histone modificabons it is recommended to use --nomodel and if there is not input sample to use --nolambda. 18

19 Hands- on Steps 5: MACS Input files: Hepg2H3k4me3_chr1.bam Control_chr1.bam MACS command bsub macs2 callpeak - t H3k4me3_chr1.bam - c Control_chr1.bam - - name H3k4me3_chr1 - - format BAM PARAMETERS - t TFILE Treatment file - c CFILE Control file - - name NAME Experiment name, which will be used to generate output file names. DEFAULT: NA - - format FORMAT Format of tag file, BED or SAM or BAM or BOWTIE. DEFAULT: BED - - extsize EXTSIZE The arbitrary extension size in bp. When nomodel is true, MACS will use this value as fragment size to extend each read towards 3' end, then, pile them up. You can use the value from the strand cross- correla3on analysis. 19

20 MACS output Output files: 1. Excel peaks file contains the following columns Chr, start, end, length, abs_summit, pileup, -LOG10(pvalue), -LOG10(qvalue), name 2. Bed peaks file chr, start, end, -LOG10(qvalue) 3. Summits.bed: contains the peak summits locabons for every peaks. The 5th column in this file is - log10qvalue the same as NAME_peaks.bed 4. Peaks.narrowPeak is BED6+4 format file. Contains the peak locabons together with peak summit, fold- change, pvalue and qvalue. 5. Model.r is an R script which you can use to produce a PDF image about the model based on your data. (Rscript NAME_model.r) To look at the peaks on a genome browser you can upload one of the output bed files or you can also make a bedgraph file with columns (step 6 of hands on): chr, start, end, fold_enrichment 20

21 Visualize peaks in IGV Hepg2H3k4me3_chr1.b edgraph Control_chr1.sorted.bam Cov Control_chr1.sorted.bam Hepg2H3k4me3_chr1.sort ed.bam Coverage Hepg2H3k4me3_chr1.sort ed.bam 21

22 Other recommendabons Look at your mapped reads and peaks in a genome browser to verify peak calling thresholds OpBonal: remove reads mapping to the ENCODE and 1000 Genomes blacklisted regions hgps://sites.google.com/site/anshulkundaje/projects/blacklists 22

23 Linking peaks to genes: intersectbed Bed tools slopbed closestbed coveragebed groupby It groups rows based on the value of a given column/s and it summarizes the other columns 23

24 Hands- on 8: Link peaks to nearby genes Take all genes and add 3Kb up and down with slopbed slopbed - b i GRCh37.p13.HumanENSEMBLgenes.bed - g /nfs/ genomes/human_gp_feb_09_no_random/anno/chrominfo.txt > HumanGenesPlusMinus3kb.bed Intersect the slopped genes with peaks and get the list of unique genes overlapping intersectbed - wa - a HumanGenesPlusMinus3kb.bed - b peaks.bed awk '{print $4}' sort - u > Genesat3KborlessfromPeaks.txt intersectbed - wa - a HumanGenesPlusMinus3kb.bed - b peaks.bed head - 3 chr ENSG _CCDC163P chr ENSG _CCDC163P chr ENSG _MIR

25 Hands- on 9: Link peaks to closest genes For each region find the closest gene and filter based on the distance to the gene closestbed - d - a peaks.bed - b GRCh37.p13.HumanENSEMBLgenes.bed head chr H3k4me3_chr1_peak_ chr ENSG _WASH7P 0 chr H3k4me3_chr1_peak_ chr ENSG _MIR chr H3k4me3_chr1_peak_ chr ENSG _WASH7P 0 #the next two steps can also be done on excel closestbed - d - a peaks.bed - b GRCh37.p13.HumanENSEMBLgenes.bed groupby - g 9,10 - c 6,7,8, - o disbnct,disbnct,disbnct head - 3 ENSG _WASH7P 0 chr ENSG _MIR chr ENSG _WASH7P 0 chr closestbed - d - a peaks.bed - b GRCh37.p13.HumanENSEMBLgenes.bed groupby - g 9,10 - c 6,7,8, - o disbnct,disbnct,disbnct awk 'BEGIN {OFS="\t"}{ if ($2<3000) {print $3,$4,$5,$1,$2} } ' head - 5 chr ENSG _WASH7P 0 chr ENSG _MIR chr ENSG _WASH7P 0 chr ENSG _AL chr ENSG _RP11-34P

26 Hands- on 9: Link peaks to closest genes (1 command) For each region find the closest gene and filter based on the distance to the gene closestbed - d - a peaks.bed - b GRCh37.p13.HumanENSEMBLgenes.bed groupby - g 9,10 - c 6,7,8, - o disbnct,disbnct,disbnct awk 'BEGIN {OFS="\t"}{ if ($2<3000) {print $3,$4,$5,$1,$2} }' > closestgeneat3kborless.bed closestbed - d print the distance to the feature in - b groupby - g columns to group on - c columns to summarize - o operabon to use to summarize 26

27 Visualizing ChIP- seq reads with ngsplot See Hot Topics: ngsplot Hands- on 10: bsub ngs.plot.r - G hg19 - R tss - C H3k4me3_chr1.bam - O H3k4me3_chr1.tss - T H3K4me3 - L FL

28 References Previous Hot Topics Quality Control and Mapping Reads hgp://jura.wi.mit.edu/bio/educabon/hot_topics/ngs_qc_mapping_feb2015/ngs_qc_mapping2015_1perpage.pdf SOPs hgp://barcwiki.wi.mit.edu/wiki/sops/chip_seq_peaks Reviews and benchmark papers: ChIP- seq: advantages and challenges of a maturing technology (Oct 09) (hgp:// nrg2641.html) ComputaBon for ChIP- seq and RNA- seq studies (Nov 09) (hgp:// html) PracBcal Guidelines for the Comprehensive Analysis of ChIP- seq Data. PLoS Comput. Biol A computabonal pipeline for comparabve ChIP- seq analyses. Nat. Protoc ChIP- seq guidelines and pracbces of the ENCODE and modencode consorba. Genome Res Quality control and strand cross- correlabon hgp://code.google.com/p/phantompeakqualtools/ MACS: Model- based Analysis of ChIP- Seq (MACS). Genome Biol 2008 hgp://liulab.dfci.harvard.edu/macs/index.html Using MACS to idenbfy peaks from ChIP- Seq data. Curr Protoc BioinformaPcs hgp://onlinelibrary.wiley.com/doi/ / bi0214s34/pdf Bedtools: hgps://code.google.com/p/bedtools/ hgp://bioinformabcs.oxfordjournals.org/content/26/6/841.abstract ngsplot hgps://code.google.com/p/ngsplot/ Shen, L.*, Shao, N., Liu, X. and Nestler, E. (2014) ngs.plot: Quick mining and visualizabon of next- generabon sequencing data by integrabng genomic databases, BMC Genomics, 15,

Analysis of ChIP-seq data

Analysis of ChIP-seq data Before we start: 1. Log into tak (step 0 on the exercises) 2. Go to your lab space and create a folder for the class (see separate hand out) 3. Connect to your lab space through the wihtdata network and

More information

ChIP-seq Analysis. BaRC Hot Topics - March 21 st 2017 Bioinformatics and Research Computing Whitehead Institute.

ChIP-seq Analysis. BaRC Hot Topics - March 21 st 2017 Bioinformatics and Research Computing Whitehead Institute. ChIP-seq Analysis BaRC Hot Topics - March 21 st 2017 Bioinformatics and Research Computing Whitehead Institute http://barc.wi.mit.edu/hot_topics/ Outline ChIP-seq overview Experimental design Quality control/preprocessing

More information

ChIP-seq Analysis. BaRC Hot Topics - Feb 23 th 2016 Bioinformatics and Research Computing Whitehead Institute.

ChIP-seq Analysis. BaRC Hot Topics - Feb 23 th 2016 Bioinformatics and Research Computing Whitehead Institute. ChIP-seq Analysis BaRC Hot Topics - Feb 23 th 2016 Bioinformatics and Research Computing Whitehead Institute http://barc.wi.mit.edu/hot_topics/ Outline ChIP-seq overview Experimental design Quality control/preprocessing

More information

From genomic regions to biology

From genomic regions to biology Before we start: 1. Log into tak (step 0 on the exercises) 2. Go to your lab space and create a folder for the class (see separate hand out) 3. Connect to your lab space through the wihtdata network and

More information

Protocol: peak-calling for ChIP-seq data / segmentation analysis for histone modification data

Protocol: peak-calling for ChIP-seq data / segmentation analysis for histone modification data Protocol: peak-calling for ChIP-seq data / segmentation analysis for histone modification data Table of Contents Protocol: peak-calling for ChIP-seq data / segmentation analysis for histone modification

More information

ChIP-seq hands-on practical using Galaxy

ChIP-seq hands-on practical using Galaxy ChIP-seq hands-on practical using Galaxy In this exercise we will cover some of the basic NGS analysis steps for ChIP-seq using the Galaxy framework: Quality control Mapping of reads using Bowtie2 Peak-calling

More information

ChIP-seq hands-on practical using Galaxy

ChIP-seq hands-on practical using Galaxy ChIP-seq hands-on practical using Galaxy In this exercise we will cover some of the basic NGS analysis steps for ChIP-seq using the Galaxy framework: Quality control Mapping of reads using Bowtie2 Peak-calling

More information

Practical 4: ChIP-seq Peak calling

Practical 4: ChIP-seq Peak calling Practical 4: ChIP-seq Peak calling Shamith Samarajiiwa, Dora Bihary September 2017 Contents 1 Calling ChIP-seq peaks using MACS2 1 1.1 Assess the quality of the aligned datasets..................................

More information

Analyzing ChIP- Seq Data in Galaxy

Analyzing ChIP- Seq Data in Galaxy Analyzing ChIP- Seq Data in Galaxy Lauren Mills RISS ABSTRACT Step- by- step guide to basic ChIP- Seq analysis using the Galaxy platform. Table of Contents Introduction... 3 Links to helpful information...

More information

NGS Data Visualization and Exploration Using IGV

NGS Data Visualization and Exploration Using IGV 1 What is Galaxy Galaxy for Bioinformaticians Galaxy for Experimental Biologists Using Galaxy for NGS Analysis NGS Data Visualization and Exploration Using IGV 2 What is Galaxy Galaxy for Bioinformaticians

More information

ITMO Ecole de Bioinformatique Hands-on session: smallrna-seq N. Servant 21 rd November 2013

ITMO Ecole de Bioinformatique Hands-on session: smallrna-seq N. Servant 21 rd November 2013 ITMO Ecole de Bioinformatique Hands-on session: smallrna-seq N. Servant 21 rd November 2013 1. Data and objectives We will use the data from GEO (GSE35368, Toedling, Servant et al. 2011). Two samples were

More information

ChIP-seq practical: peak detection and peak annotation. Mali Salmon-Divon Remco Loos Myrto Kostadima

ChIP-seq practical: peak detection and peak annotation. Mali Salmon-Divon Remco Loos Myrto Kostadima ChIP-seq practical: peak detection and peak annotation Mali Salmon-Divon Remco Loos Myrto Kostadima March 2012 Introduction The goal of this hands-on session is to perform some basic tasks in the analysis

More information

High-throughput sequencing: Alignment and related topic. Simon Anders EMBL Heidelberg

High-throughput sequencing: Alignment and related topic. Simon Anders EMBL Heidelberg High-throughput sequencing: Alignment and related topic Simon Anders EMBL Heidelberg Established platforms HTS Platforms Illumina HiSeq, ABI SOLiD, Roche 454 Newcomers: Benchtop machines: Illumina MiSeq,

More information

High-throughput sequencing: Alignment and related topic. Simon Anders EMBL Heidelberg

High-throughput sequencing: Alignment and related topic. Simon Anders EMBL Heidelberg High-throughput sequencing: Alignment and related topic Simon Anders EMBL Heidelberg Established platforms HTS Platforms Illumina HiSeq, ABI SOLiD, Roche 454 Newcomers: Benchtop machines 454 GS Junior,

More information

DNase I Seq data Analysis Strategy. Dragon Star 2013 QianQin 同济大学

DNase I Seq data Analysis Strategy. Dragon Star 2013 QianQin 同济大学 DNase I Seq data Analysis Strategy Dragon Star 2013 QianQin 同济大学 Workflow Mapping(BWA/Bow8e) QC Reads filtering and format(samtools /Picard) qrqc, FastQC 1. Sampling down by mappable reads 2. Scale mappable

More information

ChIP-Seq Tutorial on Galaxy

ChIP-Seq Tutorial on Galaxy 1 Introduction ChIP-Seq Tutorial on Galaxy 2 December 2010 (modified April 6, 2017) Rory Stark The aim of this practical is to give you some experience handling ChIP-Seq data. We will be working with data

More information

Identifying ChIP-seq enrichment using MACS

Identifying ChIP-seq enrichment using MACS Identifying ChIP-seq enrichment using MACS Jianxing Feng 1,3, Tao Liu 2,3, Bo Qin 1, Yong Zhang 1 & Xiaole Shirley Liu 2 1 Department of Bioinformatics, School of Life Sciences and Technology, Tongji University,

More information

High-throughout sequencing and using short-read aligners. Simon Anders

High-throughout sequencing and using short-read aligners. Simon Anders High-throughout sequencing and using short-read aligners Simon Anders High-throughput sequencing (HTS) Sequencing millions of short DNA fragments in parallel. a.k.a.: next-generation sequencing (NGS) massively-parallel

More information

ChIP-seq Analysis Practical

ChIP-seq Analysis Practical ChIP-seq Analysis Practical Vladimir Teif (vteif@essex.ac.uk) An updated version of this document will be available at http://generegulation.info/index.php/teaching In this practical we will learn how

More information

Useful software utilities for computational genomics. Shamith Samarajiwa CRUK Autumn School in Bioinformatics September 2017

Useful software utilities for computational genomics. Shamith Samarajiwa CRUK Autumn School in Bioinformatics September 2017 Useful software utilities for computational genomics Shamith Samarajiwa CRUK Autumn School in Bioinformatics September 2017 Overview Search and download genomic datasets: GEOquery, GEOsearch and GEOmetadb,

More information

Welcome to MAPHiTS (Mapping Analysis Pipeline for High-Throughput Sequences) tutorial page.

Welcome to MAPHiTS (Mapping Analysis Pipeline for High-Throughput Sequences) tutorial page. Welcome to MAPHiTS (Mapping Analysis Pipeline for High-Throughput Sequences) tutorial page. In this page you will learn to use the tools of the MAPHiTS suite. A little advice before starting : rename your

More information

User's guide to ChIP-Seq applications: command-line usage and option summary

User's guide to ChIP-Seq applications: command-line usage and option summary User's guide to ChIP-Seq applications: command-line usage and option summary 1. Basics about the ChIP-Seq Tools The ChIP-Seq software provides a set of tools performing common genome-wide ChIPseq analysis

More information

Bioinformatics in next generation sequencing projects

Bioinformatics in next generation sequencing projects Bioinformatics in next generation sequencing projects Rickard Sandberg Assistant Professor Department of Cell and Molecular Biology Karolinska Institutet March 2011 Once sequenced the problem becomes computational

More information

Easy visualization of the read coverage using the CoverageView package

Easy visualization of the read coverage using the CoverageView package Easy visualization of the read coverage using the CoverageView package Ernesto Lowy European Bioinformatics Institute EMBL June 13, 2018 > options(width=40) > library(coverageview) 1 Introduction This

More information

Galaxy Platform For NGS Data Analyses

Galaxy Platform For NGS Data Analyses Galaxy Platform For NGS Data Analyses Weihong Yan wyan@chem.ucla.edu Collaboratory Web Site http://qcb.ucla.edu/collaboratory Collaboratory Workshops Workshop Outline ü Day 1 UCLA galaxy and user account

More information

Today's outline. Resources. Genome browser components. Genome browsers: Discovering biology through genomics. Genome browser tutorial materials

Today's outline. Resources. Genome browser components. Genome browsers: Discovering biology through genomics. Genome browser tutorial materials Today's outline Genome browsers: Discovering biology through genomics BaRC Hot Topics April 2013 George Bell, Ph.D. http://jura.wi.mit.edu/bio/education/hot_topics/ Genome browser introduction Popular

More information

Genomic Analysis with Genome Browsers.

Genomic Analysis with Genome Browsers. Genomic Analysis with Genome Browsers http://barc.wi.mit.edu/hot_topics/ 1 Outline Genome browsers overview UCSC Genome Browser Navigating: View your list of regions in the browser Available tracks (eg.

More information

de.nbi and its Galaxy interface for RNA-Seq

de.nbi and its Galaxy interface for RNA-Seq de.nbi and its Galaxy interface for RNA-Seq Jörg Fallmann Thanks to Björn Grüning (RBC-Freiburg) and Sarah Diehl (MPI-Freiburg) Institute for Bioinformatics University of Leipzig http://www.bioinf.uni-leipzig.de/

More information

Sequence Analysis Pipeline

Sequence Analysis Pipeline Sequence Analysis Pipeline Transcript fragments 1. PREPROCESSING 2. ASSEMBLY (today) Removal of contaminants, vector, adaptors, etc Put overlapping sequence together and calculate bigger sequences 3. Analysis/Annotation

More information

ChIP-Seq data analysis workshop

ChIP-Seq data analysis workshop ChIP-Seq data analysis workshop Exercise 1. ChIP-Seq peak calling 1. Using Putty (Windows) or Terminal (Mac) to connect to your assigned computer. Create a directory /workdir/myuserid (replace myuserid

More information

RNA-seq. Manpreet S. Katari

RNA-seq. Manpreet S. Katari RNA-seq Manpreet S. Katari Evolution of Sequence Technology Normalizing the Data RPKM (Reads per Kilobase of exons per million reads) Score = R NT R = # of unique reads for the gene N = Size of the gene

More information

HIPPIE User Manual. (v0.0.2-beta, 2015/4/26, Yih-Chii Hwang, yihhwang [at] mail.med.upenn.edu)

HIPPIE User Manual. (v0.0.2-beta, 2015/4/26, Yih-Chii Hwang, yihhwang [at] mail.med.upenn.edu) HIPPIE User Manual (v0.0.2-beta, 2015/4/26, Yih-Chii Hwang, yihhwang [at] mail.med.upenn.edu) OVERVIEW OF HIPPIE o Flowchart of HIPPIE o Requirements PREPARE DIRECTORY STRUCTURE FOR HIPPIE EXECUTION o

More information

RNA-Seq in Galaxy: Tuxedo protocol. Igor Makunin, UQ RCC, QCIF

RNA-Seq in Galaxy: Tuxedo protocol. Igor Makunin, UQ RCC, QCIF RNA-Seq in Galaxy: Tuxedo protocol Igor Makunin, UQ RCC, QCIF Acknowledgments Genomics Virtual Lab: gvl.org.au Galaxy for tutorials: galaxy-tut.genome.edu.au Galaxy Australia: galaxy-aust.genome.edu.au

More information

Genomic Files. University of Massachusetts Medical School. October, 2015

Genomic Files. University of Massachusetts Medical School. October, 2015 .. Genomic Files University of Massachusetts Medical School October, 2015 2 / 55. A Typical Deep-Sequencing Workflow Samples Fastq Files Fastq Files Sam / Bam Files Various files Deep Sequencing Further

More information

Copy Number Variations Detection - TD. Using Sequenza under Galaxy

Copy Number Variations Detection - TD. Using Sequenza under Galaxy Copy Number Variations Detection - TD Using Sequenza under Galaxy I. Data loading We will analyze the copy number variations of a human tumor (parotid gland carcinoma), limited to the chr17, from a WES

More information

!"#$%&$'()#$*)+,-./).01"0#,23+3,303456"6,&((46,7$+-./&((468,

!#$%&$'()#$*)+,-./).010#,23+3,3034566,&((46,7$+-./&((468, !"#$%&$'()#$*)+,-./).01"0#,23+3,303456"6,&((46,7$+-./&((468, 9"(1(02)1+(',:.;.4(*.',?9@A,!."2.4B.'#A,C(;.

More information

Dr. Gabriela Salinas Dr. Orr Shomroni Kaamini Rhaithata

Dr. Gabriela Salinas Dr. Orr Shomroni Kaamini Rhaithata Analysis of RNA sequencing data sets using the Galaxy environment Dr. Gabriela Salinas Dr. Orr Shomroni Kaamini Rhaithata Microarray and Deep-sequencing core facility 30.10.2017 RNA-seq workflow I Hypothesis

More information

The ChIP-seq quality Control package ChIC: A short introduction

The ChIP-seq quality Control package ChIC: A short introduction The ChIP-seq quality Control package ChIC: A short introduction April 30, 2018 Abstract The ChIP-seq quality Control package (ChIC) provides functions and data structures to assess the quality of ChIP-seq

More information

Genomic Files. University of Massachusetts Medical School. October, 2014

Genomic Files. University of Massachusetts Medical School. October, 2014 .. Genomic Files University of Massachusetts Medical School October, 2014 2 / 39. A Typical Deep-Sequencing Workflow Samples Fastq Files Fastq Files Sam / Bam Files Various files Deep Sequencing Further

More information

Ensembl RNASeq Practical. Overview

Ensembl RNASeq Practical. Overview Ensembl RNASeq Practical The aim of this practical session is to use BWA to align 2 lanes of Zebrafish paired end Illumina RNASeq reads to chromosome 12 of the zebrafish ZV9 assembly. We have restricted

More information

BGGN-213: FOUNDATIONS OF BIOINFORMATICS (Lecture 14)

BGGN-213: FOUNDATIONS OF BIOINFORMATICS (Lecture 14) BGGN-213: FOUNDATIONS OF BIOINFORMATICS (Lecture 14) Genome Informatics (Part 1) https://bioboot.github.io/bggn213_f17/lectures/#14 Dr. Barry Grant Nov 2017 Overview: The purpose of this lab session is

More information

ASAP - Allele-specific alignment pipeline

ASAP - Allele-specific alignment pipeline ASAP - Allele-specific alignment pipeline Jan 09, 2012 (1) ASAP - Quick Reference ASAP needs a working version of Perl and is run from the command line. Furthermore, Bowtie needs to be installed on your

More information

Chromatin signature discovery via histone modification profile alignments Jianrong Wang, Victoria V. Lunyak and I. King Jordan

Chromatin signature discovery via histone modification profile alignments Jianrong Wang, Victoria V. Lunyak and I. King Jordan Supplementary Information for: Chromatin signature discovery via histone modification profile alignments Jianrong Wang, Victoria V. Lunyak and I. King Jordan Contents Instructions for installing and running

More information

Colorado State University Bioinformatics Algorithms Assignment 6: Analysis of High- Throughput Biological Data Hamidreza Chitsaz, Ali Sharifi- Zarchi

Colorado State University Bioinformatics Algorithms Assignment 6: Analysis of High- Throughput Biological Data Hamidreza Chitsaz, Ali Sharifi- Zarchi Colorado State University Bioinformatics Algorithms Assignment 6: Analysis of High- Throughput Biological Data Hamidreza Chitsaz, Ali Sharifi- Zarchi Although a little- bit long, this is an easy exercise

More information

Identiyfing splice junctions from RNA-Seq data

Identiyfing splice junctions from RNA-Seq data Identiyfing splice junctions from RNA-Seq data Joseph K. Pickrell pickrell@uchicago.edu October 4, 2010 Contents 1 Motivation 2 2 Identification of potential junction-spanning reads 2 3 Calling splice

More information

Helpful Galaxy screencasts are available at:

Helpful Galaxy screencasts are available at: This user guide serves as a simplified, graphic version of the CloudMap paper for applicationoriented end-users. For more details, please see the CloudMap paper. Video versions of these user guides and

More information

panda Documentation Release 1.0 Daniel Vera

panda Documentation Release 1.0 Daniel Vera panda Documentation Release 1.0 Daniel Vera February 12, 2014 Contents 1 mat.make 3 1.1 Usage and option summary....................................... 3 1.2 Arguments................................................

More information

Nature Biotechnology: doi: /nbt Supplementary Figure 1

Nature Biotechnology: doi: /nbt Supplementary Figure 1 Supplementary Figure 1 Detailed schematic representation of SuRE methodology. See Methods for detailed description. a. Size-selected and A-tailed random fragments ( queries ) of the human genome are inserted

More information

m6aviewer Version Documentation

m6aviewer Version Documentation m6aviewer Version 1.6.0 Documentation Contents 1. About 2. Requirements 3. Launching m6aviewer 4. Running Time Estimates 5. Basic Peak Calling 6. Running Modes 7. Multiple Samples/Sample Replicates 8.

More information

CLC Server. End User USER MANUAL

CLC Server. End User USER MANUAL CLC Server End User USER MANUAL Manual for CLC Server 10.0.1 Windows, macos and Linux March 8, 2018 This software is for research purposes only. QIAGEN Aarhus Silkeborgvej 2 Prismet DK-8000 Aarhus C Denmark

More information

User Manual of ChIP-BIT 2.0

User Manual of ChIP-BIT 2.0 User Manual of ChIP-BIT 2.0 Xi Chen September 16, 2015 Introduction Bayesian Inference of Target genes using ChIP-seq profiles (ChIP-BIT) is developed to reliably detect TFBSs and their target genes by

More information

NGS Analysis Using Galaxy

NGS Analysis Using Galaxy NGS Analysis Using Galaxy Sequences and Alignment Format Galaxy overview and Interface Get;ng Data in Galaxy Analyzing Data in Galaxy Quality Control Mapping Data History and workflow Galaxy Exercises

More information

Maize genome sequence in FASTA format. Gene annotation file in gff format

Maize genome sequence in FASTA format. Gene annotation file in gff format Exercise 1. Using Tophat/Cufflinks to analyze RNAseq data. Step 1. One of CBSU BioHPC Lab workstations has been allocated for your workshop exercise. The allocations are listed on the workshop exercise

More information

EpiGnome Methyl Seq Bioinformatics User Guide Rev. 0.1

EpiGnome Methyl Seq Bioinformatics User Guide Rev. 0.1 EpiGnome Methyl Seq Bioinformatics User Guide Rev. 0.1 Introduction This guide contains data analysis recommendations for libraries prepared using Epicentre s EpiGnome Methyl Seq Kit, and sequenced on

More information

Agilent Genomic Workbench Lite Edition 6.5

Agilent Genomic Workbench Lite Edition 6.5 Agilent Genomic Workbench Lite Edition 6.5 SureSelect Quality Analyzer User Guide For Research Use Only. Not for use in diagnostic procedures. Agilent Technologies Notices Agilent Technologies, Inc. 2010

More information

Unix Essentials. BaRC Hot Topics Bioinformatics and Research Computing Whitehead Institute October 12 th

Unix Essentials. BaRC Hot Topics Bioinformatics and Research Computing Whitehead Institute October 12 th Unix Essentials BaRC Hot Topics Bioinformatics and Research Computing Whitehead Institute October 12 th 2016 http://barc.wi.mit.edu/hot_topics/ 1 Outline Unix overview Logging in to tak Directory structure

More information

Variant calling using SAMtools

Variant calling using SAMtools Variant calling using SAMtools Calling variants - a trivial use of an Interactive Session We are going to conduct the variant calling exercises in an interactive idev session just so you can get a feel

More information

A short Introduction to UCSC Genome Browser

A short Introduction to UCSC Genome Browser A short Introduction to UCSC Genome Browser Elodie Girard, Nicolas Servant Institut Curie/INSERM U900 Bioinformatics, Biostatistics, Epidemiology and computational Systems Biology of Cancer 1 Why using

More information

Demo 1: Free text search of ENCODE data

Demo 1: Free text search of ENCODE data Demo 1: Free text search of ENCODE data 1. Go to h(ps://www.encodeproject.org 2. Enter skin into the search box on the upper right hand corner 3. All matches on the website will be shown 4. Select Experiments

More information

Tutorial on gene-c ancestry es-ma-on: How to use LASER. Chaolong Wang Sequence Analysis Workshop June University of Michigan

Tutorial on gene-c ancestry es-ma-on: How to use LASER. Chaolong Wang Sequence Analysis Workshop June University of Michigan Tutorial on gene-c ancestry es-ma-on: How to use LASER Chaolong Wang Sequence Analysis Workshop June 2014 @ University of Michigan LASER: Loca-ng Ancestry from SEquence Reads Main func:ons of the so

More information

ATAC-Seq pipeline v1 specifications

ATAC-Seq pipeline v1 specifications ATAC-Seq pipeline v1 specifications ATAC-seq parameters: function detect_adapter() 0a. FASTQ read adaptor detecting Program(s) detect_adapter.py in GGR_code ( https://github.com/nboley/ggr_code ) (https://github.com/kundajelab/tf_chipseq_pipeline/blob/master/utils/detect_adapter.py)

More information

Our typical RNA quantification pipeline

Our typical RNA quantification pipeline RNA-Seq primer Our typical RNA quantification pipeline Upload your sequence data (fastq) Align to the ribosome (Bow>e) Align remaining reads to genome (TopHat) or transcriptome (RSEM) Make report of quality

More information

modencode Galaxy: Uniform ChIP-Seq Processing Tools for modencode and ENCODE Data

modencode Galaxy: Uniform ChIP-Seq Processing Tools for modencode and ENCODE Data modencode Galaxy: Uniform ChIP-Seq Processing Tools for modencode and ENCODE Data Quang M Trinh Ontario Institute for Cancer Research qtrinh@oicr.on.ca Outline Model Organism ENCyclopedia Of DNA Elements

More information

preparation methods and new bacterial strains. Parts of the pipeline that can be updated will be annotated in this guide.

preparation methods and new bacterial strains. Parts of the pipeline that can be updated will be annotated in this guide. BacSeq Introduction The purpose of this guide is to aid current and future Whiteley Lab members and University of Texas microbiologists with bacterial RNA?Seq analysis. Once you have analyzed your data

More information

Next-Generation Sequencing applied to adna

Next-Generation Sequencing applied to adna Next-Generation Sequencing applied to adna Hands-on session June 13, 2014 Ludovic Orlando - Lorlando@snm.ku.dk Mikkel Schubert - MSchubert@snm.ku.dk Aurélien Ginolhac - AGinolhac@snm.ku.dk Hákon Jónsson

More information

QIAseq DNA V3 Panel Analysis Plugin USER MANUAL

QIAseq DNA V3 Panel Analysis Plugin USER MANUAL QIAseq DNA V3 Panel Analysis Plugin USER MANUAL User manual for QIAseq DNA V3 Panel Analysis 1.0.1 Windows, Mac OS X and Linux January 25, 2018 This software is for research purposes only. QIAGEN Aarhus

More information

RNA- SeQC Documentation

RNA- SeQC Documentation RNA- SeQC Documentation Description: Author: Calculates metrics on aligned RNA-seq data. David S. DeLuca (Broad Institute), gp-help@broadinstitute.org Summary This module calculates standard RNA-seq related

More information

The BEDTools manual. Last updated: 21-September-2010 Current as of BEDTools version Aaron R. Quinlan and Ira M. Hall University of Virginia

The BEDTools manual. Last updated: 21-September-2010 Current as of BEDTools version Aaron R. Quinlan and Ira M. Hall University of Virginia The BEDTools manual Last updated: 21-September-2010 Current as of BEDTools version 2.10.0 Aaron R. Quinlan and Ira M. Hall University of Virginia Contact: aaronquinlan@gmail.com 1. OVERVIEW... 7 1.1 BACKGROUND...7

More information

Short Read Sequencing Analysis Workshop

Short Read Sequencing Analysis Workshop Short Read Sequencing Analysis Workshop Day 8: Introduc/on to RNA-seq Analysis In-class slides Day 7 Homework 1.) 14 GABPA ChIP-seq peaks 2.) Error: Dataset too large (> 100000). Rerun with larger maxsize

More information

How To: Run the ENCODE histone ChIP- seq analysis pipeline on DNAnexus

How To: Run the ENCODE histone ChIP- seq analysis pipeline on DNAnexus How To: Run the ENCODE histone ChIP- seq analysis pipeline on DNAnexus Overview: In this exercise, we will run the ENCODE Uniform Processing ChIP- seq Pipeline on a small test dataset containing reads

More information

Bioinformatics I. Teaching assistant(s): Eudes Barbosa Markus List

Bioinformatics I. Teaching assistant(s): Eudes Barbosa Markus List Bioinformatics I Lecturer: Jan Baumbach Teaching assistant(s): Eudes Barbosa Markus List Question How can we study protein/dna binding events on a genome-wide scale? 2 Outline Short outline/intro to ChIP-Sequencing

More information

Sequencing. Short Read Alignment. Sequencing. Paired-End Sequencing 6/10/2010. Tobias Rausch 7 th June 2010 WGS. ChIP-Seq. Applied Biosystems.

Sequencing. Short Read Alignment. Sequencing. Paired-End Sequencing 6/10/2010. Tobias Rausch 7 th June 2010 WGS. ChIP-Seq. Applied Biosystems. Sequencing Short Alignment Tobias Rausch 7 th June 2010 WGS RNA-Seq Exon Capture ChIP-Seq Sequencing Paired-End Sequencing Target genome Fragments Roche GS FLX Titanium Illumina Applied Biosystems SOLiD

More information

NGS Data and Sequence Alignment

NGS Data and Sequence Alignment Applications and Servers SERVER/REMOTE Compute DB WEB Data files NGS Data and Sequence Alignment SSH WEB SCP Manpreet S. Katari App Aug 11, 2016 Service Terminal IGV Data files Window Personal Computer/Local

More information

SAM : Sequence Alignment/Map format. A TAB-delimited text format storing the alignment information. A header section is optional.

SAM : Sequence Alignment/Map format. A TAB-delimited text format storing the alignment information. A header section is optional. Alignment of NGS reads, samtools and visualization Hands-on Software used in this practical BWA MEM : Burrows-Wheeler Aligner. A software package for mapping low-divergent sequences against a large reference

More information

The BEDTools manual. Aaron R. Quinlan and Ira M. Hall University of Virginia. Contact:

The BEDTools manual. Aaron R. Quinlan and Ira M. Hall University of Virginia. Contact: The BEDTools manual Aaron R. Quinlan and Ira M. Hall University of Virginia Contact: aaronquinlan@gmail.com 1. OVERVIEW... 6 1.1 BACKGROUND...6 1.2 SUMMARY OF AVAILABLE TOOLS...7 1.3 FUNDAMENTAL CONCEPTS

More information

TECH NOTE Improving the Sensitivity of Ultra Low Input mrna Seq

TECH NOTE Improving the Sensitivity of Ultra Low Input mrna Seq TECH NOTE Improving the Sensitivity of Ultra Low Input mrna Seq SMART Seq v4 Ultra Low Input RNA Kit for Sequencing Powered by SMART and LNA technologies: Locked nucleic acid technology significantly improves

More information

CBSU/3CPG/CVG Joint Workshop Series Reference genome based sequence variation detection

CBSU/3CPG/CVG Joint Workshop Series Reference genome based sequence variation detection CBSU/3CPG/CVG Joint Workshop Series Reference genome based sequence variation detection Computational Biology Service Unit (CBSU) Cornell Center for Comparative and Population Genomics (3CPG) Center for

More information

Package GreyListChIP

Package GreyListChIP Type Package Version 1.14.0 Package GreyListChIP November 2, 2018 Title Grey Lists -- Mask Artefact Regions Based on ChIP Inputs Date 2018-01-21 Author Gord Brown Maintainer Gordon

More information

Using Galaxy for NGS Analyses Luce Skrabanek

Using Galaxy for NGS Analyses Luce Skrabanek Using Galaxy for NGS Analyses Luce Skrabanek Registering for a Galaxy account Before we begin, first create an account on the main public Galaxy portal. Go to: https://main.g2.bx.psu.edu/ Under the User

More information

Differential gene expression analysis

Differential gene expression analysis Differential gene expression analysis Overview In this exercise, we will analyze RNA-seq data to measure changes in gene expression levels between wild-type and a mutant strain of the bacterium Listeria

More information

Practical Linux Examples

Practical Linux Examples Practical Linux Examples Processing large text file Parallelization of independent tasks Qi Sun & Robert Bukowski Bioinformatics Facility Cornell University http://cbsu.tc.cornell.edu/lab/doc/linux_examples_slides.pdf

More information

Integrative Genomics Viewer. Prat Thiru

Integrative Genomics Viewer. Prat Thiru Integrative Genomics Viewer Prat Thiru 1 Overview User Interface Basics Browsing the Data Data Formats IGV Tools Demo Outline Based on ISMB 2010 Tutorial by Robinson and Thorvaldsdottir 2 Why IGV? IGV

More information

Triform: peak finding in ChIP-Seq enrichment profiles for transcription factors

Triform: peak finding in ChIP-Seq enrichment profiles for transcription factors Triform: peak finding in ChIP-Seq enrichment profiles for transcription factors Karl Kornacker * and Tony Håndstad October 30, 2018 A guide for using the Triform algorithm to predict transcription factor

More information

NGS FASTQ file format

NGS FASTQ file format NGS FASTQ file format Line1: Begins with @ and followed by a sequence idenefier and opeonal descripeon Line2: Raw sequence leiers Line3: + Line4: Encodes the quality values for the sequence in Line2 (see

More information

Copyright 2014 Regents of the University of Minnesota

Copyright 2014 Regents of the University of Minnesota Quality Control of Illumina Data using Galaxy August 18, 2014 Contents 1 Introduction 2 1.1 What is Galaxy?..................................... 2 1.2 Galaxy at MSI......................................

More information

Illumina Next Generation Sequencing Data analysis

Illumina Next Generation Sequencing Data analysis Illumina Next Generation Sequencing Data analysis Chiara Dal Fiume Sr Field Application Scientist Italy 2010 Illumina, Inc. All rights reserved. Illumina, illuminadx, Solexa, Making Sense Out of Life,

More information

11/8/2017 Trinity De novo Transcriptome Assembly Workshop trinityrnaseq/rnaseq_trinity_tuxedo_workshop Wiki GitHub

11/8/2017 Trinity De novo Transcriptome Assembly Workshop trinityrnaseq/rnaseq_trinity_tuxedo_workshop Wiki GitHub trinityrnaseq / RNASeq_Trinity_Tuxedo_Workshop Trinity De novo Transcriptome Assembly Workshop Brian Haas edited this page on Oct 17, 2015 14 revisions De novo RNA-Seq Assembly and Analysis Using Trinity

More information

Rsubread package: high-performance read alignment, quantification and mutation discovery

Rsubread package: high-performance read alignment, quantification and mutation discovery Rsubread package: high-performance read alignment, quantification and mutation discovery Wei Shi 14 September 2015 1 Introduction This vignette provides a brief description to the Rsubread package. For

More information

Introduction to Read Alignment. UCD Genome Center Bioinformatics Core Tuesday 15 September 2015

Introduction to Read Alignment. UCD Genome Center Bioinformatics Core Tuesday 15 September 2015 Introduction to Read Alignment UCD Genome Center Bioinformatics Core Tuesday 15 September 2015 From reads to molecules Why align? Individual A Individual B ATGATAGCATCGTCGGGTGTCTGCTCAATAATAGTGCCGTATCATGCTGGTGTTATAATCGCCGCATGACATGATCAATGG

More information

RNA-Seq Analysis With the Tuxedo Suite

RNA-Seq Analysis With the Tuxedo Suite June 2016 RNA-Seq Analysis With the Tuxedo Suite Dena Leshkowitz Introduction In this exercise we will learn how to analyse RNA-Seq data using the Tuxedo Suite tools: Tophat, Cuffmerge, Cufflinks and Cuffdiff.

More information

Sequence Preprocessing: A perspective

Sequence Preprocessing: A perspective Sequence Preprocessing: A perspective Dr. Matthew L. Settles Genome Center University of California, Davis settles@ucdavis.edu Why Preprocess reads We have found that aggressively cleaning and processing

More information

NGS Data Analysis. Roberto Preste

NGS Data Analysis. Roberto Preste NGS Data Analysis Roberto Preste 1 Useful info http://bit.ly/2r1y2dr Contacts: roberto.preste@gmail.com Slides: http://bit.ly/ngs-data 2 NGS data analysis Overview 3 NGS Data Analysis: the basic idea http://bit.ly/2r1y2dr

More information

Basics of high- throughput sequencing

Basics of high- throughput sequencing InsBtute for ComputaBonal Biomedicine Basics of high- throughput sequencing Olivier Elemento, PhD TA: Jenny Giannopoulou, PhD Plan 1. What high- throughput sequencing is used for 2. Illumina technology

More information

Galaxy workshop at the Winter School Igor Makunin

Galaxy workshop at the Winter School Igor Makunin Galaxy workshop at the Winter School 2016 Igor Makunin i.makunin@uq.edu.au Winter school, UQ, July 6, 2016 Plan Overview of the Genomics Virtual Lab Introduce Galaxy, a web based platform for analysis

More information

Under the Hood of Alignment Algorithms for NGS Researchers

Under the Hood of Alignment Algorithms for NGS Researchers Under the Hood of Alignment Algorithms for NGS Researchers April 16, 2014 Gabe Rudy VP of Product Development Golden Helix Questions during the presentation Use the Questions pane in your GoToWebinar window

More information

Molecular Identifier (MID) Analysis for TAM-ChIP Paired-End Sequencing

Molecular Identifier (MID) Analysis for TAM-ChIP Paired-End Sequencing Molecular Identifier (MID) Analysis for TAM-ChIP Paired-End Sequencing Catalog Nos.: 53126 & 53127 Name: TAM-ChIP antibody conjugate Description Active Motif s TAM-ChIP technology combines antibody directed

More information

Analyzing Variant Call results using EuPathDB Galaxy, Part II

Analyzing Variant Call results using EuPathDB Galaxy, Part II Analyzing Variant Call results using EuPathDB Galaxy, Part II In this exercise, we will work in groups to examine the results from the SNP analysis workflow that we started yesterday. The first step is

More information

Introduction to Galaxy

Introduction to Galaxy Introduction to Galaxy Saint Louis University St. Louis, Missouri April 30, 2013 Dave Clements, Emory University http://galaxyproject.org/ Agenda 9:00 Welcome 9:20 Basic Analysis with Galaxy 10:30 Basic

More information

David Crossman, Ph.D. UAB Heflin Center for Genomic Science. GCC2012 Wednesday, July 25, 2012

David Crossman, Ph.D. UAB Heflin Center for Genomic Science. GCC2012 Wednesday, July 25, 2012 David Crossman, Ph.D. UAB Heflin Center for Genomic Science GCC2012 Wednesday, July 25, 2012 Galaxy Splash Page Colors Random Galaxy icons/colors Queued Running Completed Download/Save Failed Icons Display

More information

epigenomegateway.wustl.edu

epigenomegateway.wustl.edu Everything can be found at epigenomegateway.wustl.edu REFERENCES 1. Zhou X, et al., Nature Methods 8, 989-990 (2011) 2. Zhou X & Wang T, Current Protocols in Bioinformatics Unit 10.10 (2012) 3. Zhou X,

More information