Supplementary Materials
Total Page:16
File Type:pdf, Size:1020Kb
Load more
										Recommended publications
									
								- 
												  Choudhury 22.11.2018 SupplThe Set1 complex is dimeric and acts with Jhd2 demethylation to convey symmetrical H3K4 trimethylation Rupam Choudhury, Sukdeep Singh, Senthil Arumugam, Assen Roguev and A. Francis Stewart Supplementary Material 9 Supplementary Figures 1 Supplementary Table – an Excel file not included in this document Extended Materials and Methods Supplementary Figure 1. Sdc1 mediated dimerization of yeast Set1 complex. (A) Multiple sequence alignment of the dimerizaton region of the protein kinase A regulatory subunit II with Dpy30 homologues and other proteins (from Roguev et al, 2001). Arrows indicate the three amino acids that were changed to alanine in sdc1*. (B) Expression levels of TAP-Set1 protein in wild type and sdc1 mutant strains evaluated by Westerns using whole cell extracts and beta-actin (B-actin) as loading control. (C) Spp1 associates with the monomeric Set1 complex. Spp1 was tagged with a Myc epitope in wild type and sdc1* strains that carried TAP-Set1. TAP-Set1 was immunoprecipitated from whole cell extracts and evaluated by Western with an anti-myc antibody. Input, whole cell extract from the TAP-set1; spp1-myc strain. W303, whole cell extract from the W303 parental strain. a Focal Volume Fluorescence signal PCH Molecular brightness comparison Intensity 25 20 Time 15 10 Frequency Brightness (au) 5 0 Intensity Intensity (counts /ms) GFP1 GFP-GFP2 Time c b 1x yEGFP 2x yEGFP 3x yEGFP 1 X yEGFP ADH1 yEGFP CYC1 2 X yEGFP ADH1 yEGFP yEGFP CYC1 3 X yEGFP ADH1 yEGFP yEGFP yEGFP CYC1 d 121-165 sdc1 wt sdc1 sdc1 Swd1-yEGFP B-Actin Supplementary Figure 2. Molecular analysis of Sdc1 mediated dimerization of Set1C by Fluorescence Correlation Spectroscopy (FCS).
- 
												  RNA-‐Seq: Revelation of the MessengersSupplementary Material Hands-On Tutorial RNA-Seq: revelation of the messengers Marcel C. Van Verk†,1, Richard Hickman†,1, Corné M.J. Pieterse1,2, Saskia C.M. Van Wees1 † Equal contributors Corresponding author: Van Wees, S.C.M. ([email protected]). Bioinformatics questions: Van Verk, M.C. ([email protected]) or Hickman, R. ([email protected]). 1 Plant-Microbe Interactions, Department of Biology, Utrecht University, Padualaan 8, 3584 CH Utrecht, The Netherlands 2 Centre for BioSystems Genomics, PO Box 98, 6700 AB Wageningen, The Netherlands INDEX 1. RNA-Seq tools websites……………………………………………………………………………………………………………………………. 2 2. Installation notes……………………………………………………………………………………………………………………………………… 3 2.1. CASAVA 1.8.2………………………………………………………………………………………………………………………………….. 3 2.2. Samtools…………………………………………………………………………………………………………………………………………. 3 2.3. MiSO……………………………………………………………………………………………………………………………………………….. 4 3. Quality Control: FastQC……………………………………………………………………………………………………………………………. 5 4. Creating indeXes………………………………………………………………………………………………………………………………………. 5 4.1. Genome IndeX for Bowtie / TopHat alignment……………………………………………………………………………….. 5 4.2. Transcriptome IndeX for Bowtie alignment……………………………………………………………………………………… 6 4.3. Genome IndeX for BWA alignment………………………………………………………………………………………………….. 7 4.4. Transcriptome IndeX for BWA alignment………………………………………………………………………………………….7 5. Read Alignment………………………………………………………………………………………………………………………………………… 8 5.1. Preliminaries…………………………………………………………………………………………………………………………………… 8 5.2. Genome read alignment with Bowtie………………………………………………………………………………………………
- 
												  Software List for Biology, Bioinformatics and Biostatistics CCTSoftware List for biology, bioinformatics and biostatistics v CCT - Delta Software Version Application short read assembler and it works on both small and large (mammalian size) ALLPATHS-LG 52488 genomes provides a fast, flexible C++ API & toolkit for reading, writing, and manipulating BAMtools 2.4.0 BAM files a high level of alignment fidelity and is comparable to other mainstream Barracuda 0.7.107b alignment programs allows one to intersect, merge, count, complement, and shuffle genomic bedtools 2.25.0 intervals from multiple files Bfast 0.7.0a universal DNA sequence aligner tool analysis and comprehension of high-throughput genomic data using the R Bioconductor 3.2 statistical programming BioPython 1.66 tools for biological computation written in Python a fast approach to detecting gene-gene interactions in genome-wide case- Boost 1.54.0 control studies short read aligner geared toward quickly aligning large sets of short DNA Bowtie 1.1.2 sequences to large genomes Bowtie2 2.2.6 Bowtie + fully supports gapped alignment with affine gap penalties BWA 0.7.12 mapping low-divergent sequences against a large reference genome ClustalW 2.1 multiple sequence alignment program to align DNA and protein sequences assembles transcripts, estimates their abundances for differential expression Cufflinks 2.2.1 and regulation in RNA-Seq samples EBSEQ (R) 1.10.0 identifying genes and isoforms differentially expressed EMBOSS 6.5.7 a comprehensive set of sequence analysis programs FASTA 36.3.8b a DNA and protein sequence alignment software package FastQC
- 
												  Rnaseq2017 Course Salerno, September 27-29, 2017RNASeq2017 Course Salerno, September 27-29, 2017 RNA-seq Hands on Exercise Fabrizio Ferrè, University of Bologna Alma Mater ([email protected]) Hands-on tutorial based on the EBI teaching materials from Myrto Kostadima and Remco Loos at https://www.ebi.ac.uk/training/online/ Index 1. Introduction.......................................2 1.1 RNA-Seq analysis tools.........................2 2. Your data..........................................3 3. Quality control....................................6 4. Trimming...........................................8 5. The tuxedo pipeline...............................12 5.1 Genome indexing for bowtie....................12 5.2 Insert size and mean inner distance...........13 5.3 Read mapping using tophat.....................16 5.4 Transcriptome reconstruction and expression using cufflinks...................................19 5.5 Differential Expression using cuffdiff........22 5.6 Transcriptome reconstruction without genome annotation........................................24 6. De novo assembly with Velvet......................27 7. Variant calling...................................29 8. Duplicate removal.................................31 9. Using STAR for read mapping.......................32 9.1 Genome indexing for STAR......................32 9.2 Read mapping using STAR.......................32 9.3 Using cuffdiff on STAR mapped reads...........34 10. Concluding remarks..............................35 11. Useful references...............................36 1 1. Introduction The goal of this
- 
												  Integrative Analysis of Transcriptomic Data for Identification of T-Cellwww.nature.com/scientificreports OPEN Integrative analysis of transcriptomic data for identifcation of T‑cell activation‑related mRNA signatures indicative of preterm birth Jae Young Yoo1,5, Do Young Hyeon2,5, Yourae Shin2,5, Soo Min Kim1, Young‑Ah You1,3, Daye Kim4, Daehee Hwang2* & Young Ju Kim1,3* Preterm birth (PTB), defned as birth at less than 37 weeks of gestation, is a major determinant of neonatal mortality and morbidity. Early diagnosis of PTB risk followed by protective interventions are essential to reduce adverse neonatal outcomes. However, due to the redundant nature of the clinical conditions with other diseases, PTB‑associated clinical parameters are poor predictors of PTB. To identify molecular signatures predictive of PTB with high accuracy, we performed mRNA sequencing analysis of PTB patients and full‑term birth (FTB) controls in Korean population and identifed diferentially expressed genes (DEGs) as well as cellular pathways represented by the DEGs between PTB and FTB. By integrating the gene expression profles of diferent ethnic groups from previous studies, we identifed the core T‑cell activation pathway associated with PTB, which was shared among all previous datasets, and selected three representative DEGs (CYLD, TFRC, and RIPK2) from the core pathway as mRNA signatures predictive of PTB. We confrmed the dysregulation of the candidate predictors and the core T‑cell activation pathway in an independent cohort. Our results suggest that CYLD, TFRC, and RIPK2 are potentially reliable predictors for PTB. Preterm birth (PTB) is the birth of a baby at less than 37 weeks of gestation, as opposed to the usual about 40 weeks, called full term birth (FTB)1.
- 
												  RNA-Seq Lecture 2Intermediate RNA-Seq Tips, Tricks and Non-Human Organisms Kevin Silverstein PhD, John Garbe PhD and Ying Zhang PhD, Research Informatics Support System (RISS) MSI September 25, 2014 Slides available at www.msi.umn.edu/tutorial-materials RNA-Seq Tutorials • Tutorial 1 – RNA-Seq experiment design and analysis – Instruction on individual software will be provided in other tutorials • Tutorial 2 – Thursday Sept. 25 – Advanced RNA-Seq Analysis topics • Hands-on tutorials - – Analyzing human and potato RNA-Seq data using Tophat and Cufflinks in Galaxy – Human: Thursday Oct. 2 – Potato: Tuesday Oct. 14 RNA-seq Tutorial 2 Tips, Tricks and Non-Human Organisms Part I: Review and Considerations for Different Goals and Biological Systems (Kevin Silverstein) Part II: Read Mapping Statistics and Visualization (John Garbe) Part III: Post-Analysis Processing – Exploring the Data and Results (Ying Zhang) Part I Review and Considerations for Different Goals and Biological Systems Typical RNA-seq experimental protocol and analysis Sample mRNA isolation Fragmentation RNA -> cDNA PairedSingle End (PE)(SE) Sequencing Map reads Genome A B Reference Transcriptome Steps in RNA-Seq data analysis depend on your goals and biological system Step 1: Quality Control KIR HLA Step 2: Data prepping Step 3: Map Reads to Reference Genome/Transcriptome Step 4: Assemble Transcriptome “microarray simulation” Discovery mode Other applications: Identify Differentially De novo Assembly Expressed Genes Refine gene models Programs used in RNA-Seq data analysis depend on your goals and biological system FastQC Step 1: Quality Control Trimmomatic, cutadapt Step 2: Data prepping TopHat, GSNAP Step 3: Map Reads to Reference Genome/Transcriptome Cufflinks, Cuffmerge Step 4: Assemble Transcriptome IGV Cuffdiff Other applications: Identify Differentially Refine gene models Expressed Genes Specific Note for Prokaryotes • Cufflinks developer: “We don’t recommend assembling bacteria transcripts using Cufflinks at first.
- 
												  Structure Characterization of a Peroxidase from TheSTRUCTURE CHARACTERIZATION OF A PEROXIDASE FROM THE WINDMILL PALM TREE TRACHYCARPUS FORTUNEI A DISSERTATION SUBMITTED TO THE GRADUATE DIVISION OF THE UNIVERSITY OF HAWAI‘I AT MĀNOA IN PARTIAL FULFILLMENT OF THE REQUIREMENTS FOR THE DEGREE OF DOCTOR OF PHILOSOPHY IN MOLECULAR BIOSCIENCES AND BIOENGINEERING MAY 2015 By Margaret R. Baker Dissertation Committee: Qing X. Li, Chairperson Jon-Paul Bingham Dulal Borthakur Ho Leung Ng Monika Ward Keywords: palm tree, peroxidase, N-glycosylation, mass spectrometry © 2015, Margaret R. Baker ii DEDICATION I dedicate this work to my husband, Adam, a constant source of support and encouragement. I also dedicate it to my sister, Lydia and my nephews, Morgan and Hunter. It was difficult to be so far away from you three. iii ACKNOWLEDGEMENTS I would like to thank the members of the Li Laboratory for support, discussions, and advice. I will particularly miss lunchtime with the lab! I appreciate the fruitful collaborations with the Bingham Laboratory. Dr. Ivan Sakharov graciously provided the purified windmill palm tree peroxidase, but more than that, he has been a wonderful mentor by discussing peroxidases, and giving invaluable comments on my manuscripts. Dr. David Tabb and his laboratory were very gracious in showing me the ropes in bioinformatics. Thank you to Mr. Sam Fu for consultation about the method for solid-phase reduction of disulfide bonds and for the delicious lunches at McDonald’s. I want to acknowledge Dr. Li and my committee members for their mentorship and guidance throughout this process. Undoubtedly, I could not have done this work without the support and encouragement of my family- my mom, dad, and step-dad; brother, brother-in-law, and sisters; and nephews in Texas.
- 
												  Comparative Analysis of Genome Aligners Shows HISAT2 and BWA Are Among the Best ToolsRochester Institute of Technology RIT Scholar Works Theses 5-18-2020 A Recent (2020) Comparative Analysis of Genome Aligners Shows HISAT2 and BWA are Among the Best Tools Ryan J. Musich [email protected] Follow this and additional works at: https://scholarworks.rit.edu/theses Recommended Citation Musich, Ryan J., "A Recent (2020) Comparative Analysis of Genome Aligners Shows HISAT2 and BWA are Among the Best Tools" (2020). Thesis. Rochester Institute of Technology. Accessed from This Thesis is brought to you for free and open access by RIT Scholar Works. It has been accepted for inclusion in Theses by an authorized administrator of RIT Scholar Works. For more information, please contact [email protected]. A Recent (2020) Comparative Analysis of Genome Aligners Shows HISAT2 and BWA are Among the Best Tools by Ryan J. Musich A Thesis Submitted in Partial Fulfillment of the Requirements for the Degree of Master of Science in Bioinformatics Thomas H. Gosnell School of Life Sciences College of Science Rochester Institute of Technology Rochester, NY May 18, 2020 Abstract Genome aligners are an important tool in bioinformatics research as they can be used to detect gene variants to create higher crop yields, detect abnormal gene production in cancer cell lines, or identify weaknesses in a newly discovered pathogen. Aligners work by taking sequenced DNA or RNA and mapping these reads to their corresponding location in a reference genome. Although beneficial as a tool, choosing which aligner to use for a project is often a difficult decision due to the large number of tools available and each one claiming to be the best at what it does.
- 
												  Tophat2: Accurate Alignment of Transcriptomes in the Presence OfKim et al. Genome Biology 2013, 14:R36 http://genomebiology.com/2013/14/4/R36 METHOD Open Access TopHat2: accurate alignment of transcriptomes in the presence of insertions, deletions and gene fusions Daehwan Kim1,2,3*, Geo Pertea3, Cole Trapnell5,6, Harold Pimentel7, Ryan Kelley8 and Steven L Salzberg3,4 Abstract TopHat is a popular spliced aligner for RNA-sequence (RNA-seq) experiments. In this paper, we describe TopHat2, which incorporates many significant enhancements to TopHat. TopHat2 can align reads of various lengths produced by the latest sequencing technologies, while allowing for variable-length indels with respect to the reference genome. In addition to de novo spliced alignment, TopHat2 can align reads across fusion breaks, which can occur after genomic translocations. TopHat2 combines the ability to identify novel splice sites with direct mapping to known transcripts, producing sensitive and accurate alignments, even for highly repetitive genomes or in the presence of pseudogenes. TopHat2 is available at http://ccb.jhu.edu/software/tophat. Background particularly acute for the human genome, which contains RNA-sequencing technologies [1], which sequence the over 14,000 pseudogenes [2]. RNA molecules being transcribed in cells, allow explora- In the most recent Ensembl GRCh37 gene annota- tion of the process of transcription in exquisite detail. One tions, the average length of a mature mRNA transcript of the primary goals of RNA-sequencing analysis software in the human genome is 2,227 bp long, and the average is to reconstruct the full set of transcripts (isoforms) of exon length is 235 bp. The average number of exons genes that were present in the original cells.
- 
												  Omics Data Exploration: Across Scales and DimensionsOMICS DATA EXPLORATION: ACROSS SCALES AND DIMENSIONS by Gang Su A dissertation submitted in partial fulfillment of the requirements for the degree of Doctor of Philosophy (Bioinformatics) in the University of Michigan 2013 Doctoral Committee: Professor Brian D. Athey, Co-Chair Research Associate Professor Fan Meng, Co-Chair Professor Charles F. Burant Associate Research Scientist Barbara Mirel Assistant Professor Maureen Sartor DEDICATION I dedicate this thesis especially to my grandparents. My grandfather grew up in a shattered nation, and survived in countless brutal battles through WWII, but he never lost his hopes and disciplines, and lived happily even to this day. Whenever I talk with him, I realize that my peaceful life today is nothing but a gift from those great sacrifices the older generations have made – and I should struggle to make my own contributions in this new era and to make something better for the future. He wished his grandson could reach the summit of knowledge someday on behalf of the family, and now I am proudly fulfilling his wish. My grandmother, loved her family all her life, and loved me every second since my first day. I also dedicate this work to my parents, it’s with their persistent love and care that I had a carefree and beautiful childhood. My father was the inspiration for me to go out and see the world. As a sailor in his early years, his footprints covered the majority of the globe, leaving only Europe and North America uncovered due to the political segregation back then. I am now completing the left pieces of this big puzzle, and hopefully I will have much more in the future to pass on to.
- 
												  Magic-BLAST, an Accurate DNA and RNA-Seq Aligner for Long and Short ReadsbioRxiv preprint doi: https://doi.org/10.1101/390013; this version posted August 13, 2018. The copyright holder for this preprint (which was not certified by peer review) is the author/funder. This article is a US Government work. It is not subject to copyright under 17 USC 105 and is also made available for use under a CC0 license. Magic-BLAST, an accurate DNA and RNA-seq aligner for long and short reads Grzegorz M Boratyn, Jean Thierry-Mieg*, Danielle Thierry-Mieg, Ben Busby and Thomas L Madden* National Center for Biotechnology Information, National Library of Medicine, National Institutes of Health, 8600 Rockville Pike, Bethesda, MD, 20894, USA * To whom correspondence should be addressed. Tel: 301-435-5987; Fax: 301-480-4023; Email: [email protected]. Correspondence may also be addressed to [email protected]. ABSTRACT Next-generation sequencing technologies can produce tens of millions of reads, often paired-end, from transcripts or genomes. But few programs can align RNA on the genome and accurately discover introns, especially with long reads. To address these issues, we introduce Magic-BLAST, a new aligner based on ideas from the Magic pipeline. It uses innovative techniques that include the optimization of a spliced alignment score and selective masking during seed selection. We evaluate the performance of Magic-BLAST to accurately map short or long sequences and its ability to discover introns on real RNA-seq data sets from PacBio, Roche and Illumina runs, and on six benchmarks, and compare it to other popular aligners. Additionally, we look at alignments of human idealized RefSeq mRNA sequences perfectly matching the genome.
- 
												  Rbm10 Facilitates Heterochromatin Assembly Via the Clr6 HDAC ComplexWeigt et al. Epigenetics & Chromatin (2021) 14:8 https://doi.org/10.1186/s13072-021-00382-y Epigenetics & Chromatin RESEARCH Open Access Rbm10 facilitates heterochromatin assembly via the Clr6 HDAC complex Martina Weigt1†, Qingsong Gao1†, Hyoju Ban2†, Haijin He2, Guido Mastrobuoni3, Stefan Kempa3, Wei Chen1,4,5* and Fei Li2* Abstract Splicing factors have recently been shown to be involved in heterochromatin formation, but their role in control- ling heterochromatin structure and function remains poorly understood. In this study, we identifed a fssion yeast homologue of human splicing factor RBM10, which has been linked to TARP syndrome. Overexpression of Rbm10 in fssion yeast leads to strong global intron retention. Rbm10 also interacts with splicing factors in a pattern resembling that of human RBM10, suggesting that the function of Rbm10 as a splicing regulator is conserved. Surprisingly, our deep-sequencing data showed that deletion of Rbm10 caused only minor efect on genome-wide gene expression and splicing. However, the mutant displays severe heterochromatin defects. Further analyses indicated that the het- erochromatin defects in the mutant did not result from mis-splicing of heterochromatin factors. Our proteomic data revealed that Rbm10 associates with the histone deacetylase Clr6 complex and chromatin remodelers known to be important for heterochromatin silencing. Deletion of Rbm10 results in signifcant reduction of Clr6 in heterochroma- tin. Our work together with previous fndings further suggests that diferent splicing subunits may play distinct roles in heterochromatin regulation. Keywords: Epigenetics, Splicing factor, Schizosaccharomyces pombe, Histone deacetylase, H3K9 methylation Introduction expression, chromosome segregation, and genome stabil- In eukaryotic cells, DNA and histones are organized ity [1–3].