Zebrafish Illumina Data Analysis Protocol

Total Page:16

File Type:pdf, Size:1020Kb

Zebrafish Illumina Data Analysis Protocol Zebrafish Illumina Data Analysis Protocol Accompanying the publication: Efficient Mapping and Cloning of Mutations in Zebrafish by Low Coverage Whole Genome Sequencing Margot E. Bowen & Katrin Henke, Kellee Siegfried-Harris, Matthew L. Warman, Matthew P. Harris. Genetics, 2012 Described in this protocol are the steps required for the analysis of low coverage Illumina whole genome sequence data from a pool of F2 mutants. This protocol utilizes whole genome sequence data from the Tü, WK, TLF and AB laboratory strains to: (1) facilitate the accurate identification of common polymorphisms present in a mutant pool, which can be used for homozygosity mapping; (2) identify the likely parental origin of alleles in a mutant pool, which can be used for mapping based on strain specific signatures; (3) within the linked interval, distinguish common polymorphisms from variants unique to the mutant pool, which will be candidates for the causative mutation. Contents 1. Software requirements……………………………………………….. 2 2. Downloading datasets………………………………………………… 2 3. Command line usage…………………………………………………. 3 4. Preparing the reference genome……………………………………. 3 5. Alignment of reads to the reference genome……………………… 4 6. Preparing BAM files……………………………………….………….. 5 7. Variant calling…………………………………………………………. 6 8. Rough Mapping……………………………………………………….. 7 9. Narrowing down the linked interval…………………………………. 8 10. Identifying candidate mutations…………………………………….. 10 11. Identifying candidate causative mutations in regions covered by only one read……..………………………… 11 12. Identifying candidate causative mutations: indels………………… 12 13. Appendix 1: visualizing the data used for calculating the mapping score…………………………………… 13 1 1. Software requirements The following publically available software should be installed: 1. Any suitable alignment software, such as Novoalign (http://www.novocraft.com/). 2. SAMtools (http://samtools.sourceforge.net/). 3. Picard (http://sourceforge.net/projects/picard/) 4. Genome Analysis Toolkit (GATK) (http://www.broadinstitute.org/gsa/wiki/index.php/The_Genome_Analysis_Toolkit) 5. Integrative Genomics Viewer (IGV) (http://www.broadinstitute.org/igv/) 6. Annovar (http://www.openbioinformatics.org/annovar/) 2. Downloading datasets The following datasets should be downloaded from http://fishyskeleton.com/: 1. Whole genome sequence data for six reference strain pools Folder name: aligned_sequences Example file name: TLF_chr1.bam, TLF_chr1.bam.bai Illumina sequencing reads (100bp single end), for the Tü, WIK, AB, TLF laboratory strains, aligned to the zebrafish reference genome (Zv9/danRer7). For the Tü and WIK strains, sequencing was performed separately on fish maintained in Tübingen, Germany (referred to as TUG and WKG) and fish maintained at Children’s Hospital, Boston (referred to as TUB and WKB). Each aligned sequence file (in the BAM file format) is paired with an index file (.bai). 2. Coordinates of repetitive sequences Folder name: repeat_mask Example file name: danRer7_repeatmask_chr1.bed Coordinates of all interspersed repeats and low complexity sequences in the zebrafish genome. This is the output of the RepeatMasker (http://www.repeatmasker.org/) that has been converted to the BED file format. 3. Physical coordinates of cM intervals Folder name: MGH_map Example file name: chr1_cM Estimated coordinates for each 0.25 cM interval in the genome. These estimates are based on the genetic distance of markers in the MGH meiotic map (http://zfin.org/zf_info/downloads.html#map) that have been mapped to the zv9 reference genome. 2 4. Zebrafish genes and dbSNPs Folder name: zebradb Example file name: danRer7_ensGene.txt Coordinates and sequences of Ensembl and Refseq zebrafish genes (http://hgdownload.cse.ucsc.edu/goldenPath/danRer7/database/) and dbSNPs (http://useast.ensembl.org/info/data/ftp/index.html) that have been formatted for use in the Annovar software. 5. Coding exon bases Folder name: coding_exon_bases Example file name: coding_bases_chr1 The genomic coordinate of each coding exon base as well as bases up to 15 bp upstream and downstream of each coding exon. This list was constructed from the merged dataset of all Refseq and Ensemble coding exons. 6. Perl scripts Folder name: perl Example file name: mapping_score.pl Perl scripts used for mapping and candidate mutation identification. 3. Command line usage Since it is often required to run the same command on multiple files, wild cards and for loops are used in this protocol. The wild card symbol “*” can be used to represent any character or characters in a file name, while the wild card symbol “?” can be used to represent any single character in a file name. For Loops can, for example, be used to run the same command on files from all 25 chromosomes (for f in {1..25} ; do echo $f ; command chr"$f" ; done). Users unfamiliar with these concepts are encouraged to consult an introductory Unix text. 4. Preparing the reference genome Some programs, such as the GATK, require the reference genome to have the .fasta extension, and that a .dict dictionary file and a .fai fasta index file are present in the same folder as the reference genome. See the GATK website for more details: http://www.broadinstitute.org/gsa/wiki/index.php/Preparing_the_essential_GATK_input_file s:_the_reference_genome 3 1. Download the zebrafish genome sequence The zebrafish genome sequence, danRer7.fa, can be downloaded from the UCSC Genome Bioinformatics site (http://hgdownload.cse.ucsc.edu/goldenPath/danRer7/bigZips/). 2. Rename the reference genome to .fasta mv danRer7.fa danRer7.fasta 3. Create a fasta sequence dictionary file, using the CreateSequenceDictionary.jar file from Picard java -jar CreateSequenceDictionary.jar R=danRer7.fasta O=danRer7.dict 4. Create a fasta index file (.fai) using SAMtools samtools faidx danRer6.fasta 5. Aligning reads to the reference genome Alignment can be performed using any suitable alignment software. As an example, the commands for Novoalign are provided: 1. Prepare the reference genome for use in Novoalign: novoindex danRer7_novoindex danRer7.fasta 2. To speed up the alignment, the input file can first be split into multiple smaller files split -l 5000000 sequence.txt splitsequence_ This splits up the input fastq file (sequence.txt) into files each containing 5 million lines (1.25 million reads) that are named splitsequence_aa, splitsequence _ab, splitsequence _ac etc. 3. Align the reads to the reference genome using Novoalign for f in splitsequence_* ; do echo $f ; novoalign -f $f -d danRer7.fa_novoindex -o SAM -F ILMFQ -a AGATCGGAAGAGCGGTTCAGCAGGAATGCCGAGACCGATCTCGTATGCCGTCTTCTGCTTG > "$f".sam 3’ adaptor trimming (-a) is necessary if it is expected that a significant fraction of library fragments will have an insert size less than the Illumina read length. For example, libraries prepared from degraded genomic DNA in our laboratory had a significant fraction of fragments with an insert size below 100bp. When Illumina 100bp sequencing is performed on these fragments, the 3’ end of some reads will correspond to the adaptor sequence, which should be removed before alignment to the reference genome. The sequence listed above is the sequence corresponding to the Illumina paired end adaptor used in our laboratory (which can be used for both paired and single end sequencing). 4 6. Preparing BAM files 1. Convert SAM files to BAM files for f in splitsequence_*.sam ; do echo $f ; samtools import danRer7.fasta $f "$f".bam ; done 2. Sort reads based on their location in the genome for f in splitsequence_*.sam.bam ; do echo $f ; samtools sort $f "$f".sort ; done 3. Merge multiple BAM files samtools merge -rh readgroup.txt merge_mutant1.bam splitsequence_*.sam.bam.sort.bam For each read, a read group tag will be added which will specify which input file contained that read. Some programs, such as the GATK, require that all reads contain a read group tag. The readgroup.txt file must first be created as a text file. It should contain one line for each input file. Shown here are the first three lines: @RG ID:splitsequence_aa.sort SM:mutant1 LB:mutant1 PL:Illumina @RG ID:splitsequence_ab.sort SM:mutant1 LB:mutant1 PL:Illumina @RG ID:splitsequence_ac.sort SM:mutant1 LB:mutant1 PL:Illumina The ID tag must contain the input file name (excluding the .bam extension) The SM tag must contain the name of the sample (for example mutant1) The LB tag lists the name of the library. If only one library was made for each mutant, the library name will be the same as the sample name. The PL tag contains the name of the sequencing platform. 4. Index the merged BAM file samtools index merge_mutant1.bam 5. Remove PCR duplicates java -jar picard-tools/MarkDuplicates.jar I= merge_mutant1.bam O= merge_mutant1.PCR.bam METRICS_FILE= merge_mutant1_PCRmetrics ASSUME_SORTED=TRUE REMOVE_DUPLICATES=true 6. Index the merged PCR duplicate removed file samtools index merge_mutant1.PCR.bam 7. Create a file for each chromosome for f in {1..25} ; do echo $f ; samtools view -b merge_mutant1.PCR.bam chr"$f" -o mutant1_chr"$f".bam ; done To decrease the computational load, downstream analyses are performed on one chromosome at a time. 5 8. Index the BAM file for each chromosome samtools index mutant1_chr*.bam 9. Determine the depth of coverage for each chromosome for f in {1..25} ; do echo $f ; java -jar GenomeAnalysisTK.jar -T DepthOfCoverage -R danRer7.fasta -I mutant1_chr"$f".bam -o depth_mutant1_chr"$f" -L chr"$f" -- omitDepthOutputAtEachBase ; done 7. Variant calling 1. Perform variant calling on all mutants and reference
Recommended publications
  • Whole Genome Sequencing Identifies Novel Structural Variant in a Large Indian Family Affected with X - Linked Agammaglobulinemia
    medRxiv preprint doi: https://doi.org/10.1101/2020.10.05.20200949; this version posted October 6, 2020. The copyright holder for this preprint (which was not certified by peer review) is the author/funder, who has granted medRxiv a license to display the preprint in perpetuity. It is made available under a CC-BY-ND 4.0 International license . Whole Genome Sequencing identifies novel structural variant in a large Indian family affected with X - linked agammaglobulinemia 1,2,# 3,5,#,$ 3,4 3 Abhinav Jain ,​ Geeta Madathil Govindaraj ,​ Athulya Edavazhippurath ,​ Nabeel Faisal ,​ Rahul C ​ ​ ​ ​ 1 1,2 6 3 1 1 Bhoyar ,​ Vishu Gupta ,​ Ramya Uppuluri ,​ Shiny Padinjare Manakkad ,​ Atul Kashyap ,​ Anoop Kumar ,​ ​ ​ ​ ​ ​ ​ 1,2 1,2 7 7 3 Mohit Kumar Divakar ,​ Mohamed Imran ,​ Sneha Sawant ,​ Aparna Dalvi ,​ Krishnan Chakyar ,​ ​ ​ ​ ​ ​ 7 6 1,2,$ 1,2,$ Manisha Madkaikar ,​ Revathi Raj ,​ Sridhar Sivasubbu ,​ Vinod Scaria ​ ​ ​ ​ 1 CSIR-Institute​ of Genomics and Integrative Biology, Mathura Road, New Delhi, Delhi, India 2 Academy​ of Scientific and Innovative Research (AcSIR), Mathura Road, New Delhi, Delhi, India 3 Department​ of Pediatrics, Government Medical College Kozhikode, Kozhikode, Kerala, India 4 Multidisciplinary​ Research Unit, Government College Kozhikode, Kozhikode, Kerala, India 5 FPID​ Regional Diagnostic Centre, Government Medical College Kozhikode, Kozhikode, Kerala India 6 Department​ of Pediatric Hematology, Oncology, Blood and Marrow Transplantation, Apollo Hospitals, 320, Padma complex, Anna salai, Teynampet, Chennai, Tamil Nadu, India 7 Department​ of Pediatric Immunology and Leukocyte Biology, ICMR-National Institute of Immunohaematology, KEM Hospital, Parel, Mumbai, Maharashtra, India. # Joint first authors $ Corresponding author Vinod Scaria: [email protected] ​ Sridhar Sivasubbu: [email protected] ​ Geeta Madathil Govindaraj: [email protected] ​ NOTE: This preprint reports new research that has not been certified by peer review and should not be used to guide clinical practice.
    [Show full text]
  • Exome Sequencing and Functional Validation in Zebrafish Identify
    View metadata, citation and similar papers at core.ac.uk brought to you by CORE provided by Elsevier - Publisher Connector REPORT Exome Sequencing and Functional Validation in Zebrafish Identify GTDC2 Mutations as a Cause of Walker-Warburg Syndrome M. Chiara Manzini,1,2 Dimira E. Tambunan,1,2 R. Sean Hill,1,2 Tim W. Yu,1,2 Thomas M. Maynard,3 Erin L. Heinzen,4 Kevin V. Shianna,4 Christine R. Stevens,5 Jennifer N. Partlow,1,2 Brenda J. Barry,1,2 Jacqueline Rodriguez,1,2 Vandana A. Gupta,1,6 Abdel-Karim Al-Qudah,7 Wafaa M. Eyaid,8 Jan M. Friedman,9,10 Mustafa A. Salih,11 Robin Clark,12 Isabella Moroni,13 Marina Mora,14 Alan H. Beggs,1,6 Stacey B. Gabriel,5 and Christopher A. Walsh1,2,5,* Whole-exome sequencing (WES), which analyzes the coding sequence of most annotated genes in the human genome, is an ideal approach to studying fully penetrant autosomal-recessive diseases, and it has been very powerful in identifying disease-causing muta- tions even when enrollment of affected individuals is limited by reduced survival. In this study, we combined WES with homozygosity analysis of consanguineous pedigrees, which are informative even when a single affected individual is available, to identify genetic mutations responsible for Walker-Warburg syndrome (WWS), a genetically heterogeneous autosomal-recessive disorder that severely affects the development of the brain, eyes, and muscle. Mutations in seven genes are known to cause WWS and explain 50%–60% of cases, but multiple additional genes are expected to be mutated because unexplained cases show suggestive linkage to diverse loci.
    [Show full text]
  • Genomic Approaches for Understanding the Genetics of Complex Disease
    Downloaded from genome.cshlp.org on September 25, 2021 - Published by Cold Spring Harbor Laboratory Press Perspective Genomic approaches for understanding the genetics of complex disease William L. Lowe Jr.1 and Timothy E. Reddy2,3 1Division of Endocrinology, Metabolism and Molecular Medicine, Department of Medicine, Northwestern University Feinberg School of Medicine, Chicago, Illinois 60611, USA; 2Department of Biostatistics and Bioinformatics, Duke University Medical School, Durham, North Carolina 27708, USA; 3Center for Genomic and Computational Biology, Duke University Medical School, Durham, North Carolina 27708, USA There are thousands of known associations between genetic variants and complex human phenotypes, and the rate of novel discoveries is rapidly increasing. Translating those associations into knowledge of disease mechanisms remains a fundamental challenge because the associated variants are overwhelmingly in noncoding regions of the genome where we have few guiding principles to predict their function. Intersecting the compendium of identified genetic associations with maps of regulatory activity across the human genome has revealed that phenotype-associated variants are highly enriched in candidate regula- tory elements. Allele-specific analyses of gene regulation can further prioritize variants that likely have a functional effect on disease mechanisms; and emerging high-throughput assays to quantify the activity of candidate regulatory elements are a promising next step in that direction. Together, these technologies have created the ability to systematically and empirically test hypotheses about the function of noncoding variants and haplotypes at the scale needed for comprehensive and system- atic follow-up of genetic association studies. Major coordinated efforts to quantify regulatory mechanisms across genetically diverse populations in increasingly realistic cell models would be highly beneficial to realize that potential.
    [Show full text]
  • QTL Analysis Reveals Genomic Variants Linked to High-Temperature
    Wang et al. Biotechnol Biofuels (2019) 12:59 https://doi.org/10.1186/s13068-019-1398-7 Biotechnology for Biofuels RESEARCH Open Access QTL analysis reveals genomic variants linked to high-temperature fermentation performance in the industrial yeast Zhen Wang1,2†, Qi Qi1,2†, Yuping Lin1*, Yufeng Guo1, Yanfang Liu1,2 and Qinhong Wang1* Abstract Background: High-temperature fermentation is desirable for the industrial production of ethanol, which requires thermotolerant yeast strains. However, yeast thermotolerance is a complicated quantitative trait. The understanding of genetic basis behind high-temperature fermentation performance is still limited. Quantitative trait locus (QTL) map- ping by pooled-segregant whole genome sequencing has been proved to be a powerful and reliable approach to identify the loci, genes and single nucleotide polymorphism (SNP) variants linked to quantitative traits of yeast. Results: One superior thermotolerant industrial strain and one inferior thermosensitive natural strain with distinct high-temperature fermentation performances were screened from 124 Saccharomyces cerevisiae strains as parent strains for crossing and segregant isolation. Based on QTL mapping by pooled-segregant whole genome sequencing as well as the subsequent reciprocal hemizygosity analysis (RHA) and allele replacement analysis, we identifed and validated total eight causative genes in four QTLs that linked to high-temperature fermentation of yeast. Interestingly, loss of heterozygosity in fve of the eight causative genes including RXT2, ECM24, CSC1, IRA2 and AVO1 exhibited posi- tive efects on high-temperature fermentation. Principal component analysis (PCA) of high-temperature fermentation data from all the RHA and allele replacement strains of those eight genes distinguished three superior parent alleles including VPS34, VID24 and DAP1 to be greatly benefcial to high-temperature fermentation in contrast to their inferior parent alleles.
    [Show full text]
  • A Comprehensive Database of Putative Human Microrna Target Site
    bioRxiv preprint doi: https://doi.org/10.1101/554485; this version posted May 26, 2019. The copyright holder for this preprint (which was not certified by peer review) is the author/funder, who has granted bioRxiv a license to display the preprint in perpetuity. It is made available under aCC-BY-NC-ND 4.0 International license. dbMTS: a comprehensive database of putative human microRNA target site SNVs and their functional predictions Chang Li1,2, Michael D. Swartz3, Bing Yu1, Yongsheng Bai4, Xiaoming Liu1,2* 1Human Genetics Center and Department of Epidemiology, Human Genetics and Environmental Sciences, School of Public Health, The University of Texas Health Science Center at Houston, Houston, TX 2USF Genomics, College of Public Health, University of South Florida, Tampa, FL 3Department of Biostatistics, School of Public Health, The University of Texas Health Science Center at Houston, Houston, TX 4Department of Internal Medicine, University of Michigan, Ann Arbor, MI *Correspondence: Xiaoming Liu, [email protected] Funding information: This work is supported partially by NIH funding 1UM1HG008898 and partially by the startup funding for XL from the University of South Florida. bioRxiv preprint doi: https://doi.org/10.1101/554485; this version posted May 26, 2019. The copyright holder for this preprint (which was not certified by peer review) is the author/funder, who has granted bioRxiv a license to display the preprint in perpetuity. It is made available under aCC-BY-NC-ND 4.0 International license. Abstract microRNAs (miRNAs) are short non-coding RNAs that can repress the expression of protein coding messenger RNAs (mRNAs) by binding to the 3’UTR of the target.
    [Show full text]
  • Interleukin 10 Mutant Zebrafish Have an Enhanced Interferon
    www.nature.com/scientificreports OPEN Interleukin 10 mutant zebrafsh have an enhanced interferon gamma response and improved Received: 22 August 2017 Accepted: 20 June 2018 survival against a Mycobacterium Published: xx xx xxxx marinum infection Sanna-Kaisa E. Harjula1, Markus J. T. Ojanen1,2, Sinja Taavitsainen3, Matti Nykter3 & Mika Rämet1,4,5,6 Tuberculosis ranks as one of the world’s deadliest infectious diseases causing more than a million casualties annually. IL10 inhibits the function of Th1 type cells, and IL10 defciency has been associated with an improved resistance against Mycobacterium tuberculosis infection in a mouse model. Here, we utilized M. marinum infection in the zebrafsh (Danio rerio) as a model for studying Il10 in the host response against mycobacteria. Unchallenged, nonsense il10e46/e46 mutant zebrafsh were fertile and phenotypically normal. Following a chronic mycobacterial infection, il10e46/e46 mutants showed enhanced survival compared to the controls. This was associated with an increased expression of the Th cell marker cd4-1 and a shift towards a Th1 type immune response, which was demonstrated by the upregulated expression of tbx21 and ifng1, as well as the down-regulation of gata3. In addition, at 8 weeks post infection il10e46/e46 mutant zebrafsh had reduced expression levels of proinfammatory cytokines tnf and il1b, presumably indicating slower progress of the infection. Altogether, our data show that Il10 can weaken the immune defense against M. marinum infection in zebrafsh by restricting ifng1 response. Importantly, our fndings support the relevance of M. marinum infection in zebrafsh as a model for tuberculosis. Annually more than 10 million new tuberculosis cases are estimated to emerge, leading to over a million casualties1.
    [Show full text]
  • Comparison of Structural and Short Variants Detectedby Linked-Read
    cancers Article Comparison of Structural and Short Variants Detected by Linked-Read and Whole-Exome Sequencing in Multiple Myeloma Ashwini Kumar 1,2 , Sadiksha Adhikari 1,2, Matti Kankainen 2,3,4,5 and Caroline A. Heckman 1,2,* 1 Institute for Molecular Medicine Finland-FIMM, HiLIFE-Helsinki Institute of Life Science, iCAN Digital Cancer Medicine Flagship, University of Helsinki, Tukholmankatu 8, 00290 Helsinki, Finland; ashwini.kumar@helsinki.fi (A.K.); sadiksha.adhikari@helsinki.fi (S.A.) 2 iCAN Digital Precision Cancer Medicine, University of Helsinki, 00014 Helsinki, Finland; matti.kankainen@helsinki.fi 3 Medical and Clinical Genetics, University of Helsinki, Helsinki University Hospital, 00029 Helsinki, Finland 4 Translational Immunology Research Program and Department of Clinical Chemistry, University of Helsinki, 00290 Helsinki, Finland 5 Hematology Research Unit Helsinki, Department of Hematology, Helsinki University Hospital Comprehensive Cancer Center, 00290 Helsinki, Finland * Correspondence: caroline.heckman@helsinki.fi; Tel.: +358-29-412-5769 Simple Summary: The wide variety of next-generation sequencing technologies requires thorough evaluation and understanding of their advantages and shortcomings of these different approaches prior to their implementation in a precision medicine setting. Here, we compared the performance of two DNA sequencing methods, whole-exome and linked-read exome sequencing, to detect large Citation: Kumar, A.; Adhikari, S.; structural variants (SVs) and short variants in eight multiple myeloma (MM) patient cases. For three Kankainen, M.; Heckman, C.A. patient cases, matched tumor-normal samples were sequenced with both methods to compare somatic Comparison of Structural and Short SVs and short variants. The methods’ clinical relevance was also evaluated, and their sensitivity Variants Detected by Linked-Read and specificity to detect MM-specific cytogenetic alterations and other short variants were measured.
    [Show full text]
  • Variant Annotation
    Variant annotation Theorical part V1.1 10/10/18 Ready for annotating variants!! Variant annotation and prioritization Annotation Databases Eilbeck, Karen & Quinlan, Aaron & Yandell, Mark. (2017). Settling the score: variant prioritization and Mendelian disease. Nature Reviews Genetics. 10.1038/nrg.2017.52. Genomic data repositories - 1000 Genomes The 1000 Genomes Project (abbreviated as 1KGP), launched in January 2008, was an international research effort to establish by far the most detailed catalogue of human genetic variation. - ESP (NHLBI Exome Sequencing Project) Exists in 3 flavours : evs annotation data was generated from approximately 2500 exomes, evs_5400 from approximately 5400 exomes and the last one, evs_6500 from approximately 6500 exomes - ExAC (Exome Aggregation Consortium) Coalition of investigators seeking to aggregate and harmonize exome sequencing data from a variety of large-scale sequencing projects, and to make summary data available for the wider scientific community. - gnomAD (Genome Aggregation Database) Developed by an international coalition of investigators, with the goal of aggregating and harmonizing both exome and genome sequencing data from a wide variety of large-scale sequencing projects. - FREX (THE FRENCH EXOME) A REFERENCE PANEL OF EXOMES FROM FRENCH REGIONS Annotation Databases Eilbeck, Karen & Quinlan, Aaron & Yandell, Mark. (2017). Settling the score: variant prioritization and Mendelian disease. Nature Reviews Genetics. 10.1038/nrg.2017.52. Databases of variant-disease and gene-disease associations
    [Show full text]
  • 1 Mapping Challenging Mutations by Whole-Genome Sequencing Harold
    bioRxiv preprint doi: https://doi.org/10.1101/036046; this version posted January 6, 2016. The copyright holder for this preprint (which was not certified by peer review) is the author/funder, who has granted bioRxiv a license to display the preprint in perpetuity. It is made available under aCC-BY-NC 4.0 International license. Mapping challenging mutations by whole-genome sequencing Harold E. Smith, Amy S. Fabritius, Aimee Jaramillo-Lambert, and Andy Golden National Institute of Diabetes and Digestive and Kidney Diseases, National Institutes of Health, Bethesda, Maryland 20892 1 bioRxiv preprint doi: https://doi.org/10.1101/036046; this version posted January 6, 2016. The copyright holder for this preprint (which was not certified by peer review) is the author/funder, who has granted bioRxiv a license to display the preprint in perpetuity. It is made available under aCC-BY-NC 4.0 International license. Running title: Challenging mutations by WGS Keywords: Forward genetics, variant detection, complex alleles, SNP mapping Corresponding author: Harold E. Smith 8 Center Drive Bethesda, MD 20892 301-594-6554 [email protected] 2 bioRxiv preprint doi: https://doi.org/10.1101/036046; this version posted January 6, 2016. The copyright holder for this preprint (which was not certified by peer review) is the author/funder, who has granted bioRxiv a license to display the preprint in perpetuity. It is made available under aCC-BY-NC 4.0 International license. ABSTRACT Whole-genome sequencing provides a rapid and powerful method for identifying mutations on a global scale, and has spurred a renewed enthusiasm for classical genetic screens in model organisms.
    [Show full text]
  • Phase 3. Functional Variant Discovery
    Phase 3. Functional Variant Discovery Introduction There is no single ‘recipe’ for identifying functional variants. Every filtering strategy inevitably starts with multiple often-logical assumptions about the properties of causal variants that may also discard candidates too early. Novelty is one example, where the variant is not expected to be present in public repositories, even though apparently healthy individuals carrying it may have been sequenced in unrelated studies. High predicted functional impact is another, where a variant is expected to simultaneously occur at an evolutionarily conserved genomic location and also be scored as deleterious by multiple predictive algorithms may even be too stringent a rule in a Mendelian trait. In a similar vein, in a population genetics study, a novel amino acid class-changing variant that is not predicted to have a functional effect by the standard tools may have a molecular effect. An inheritance model may itself be incorrect, e.g. a condition may be autosomal recessive rather than X-linked as hypothesized, or digenic rather than recessive, etc. It is therefore important not to conclude too early that the variant(s) of interest “are not in the exome” and to exhaust all alternate plausible rules and scenarios before that conclusion is reached. Using disease variant discovery as a context, we aim to present here a range of guidelines that can be used to develop an appropriate variant prioritisation strategy. This phase will be presented as 5 sub-phases: 1. Variant annotation - using ANNOVAR (Wang et al, 2010) as an example 2. Frequency 3. Case-control filtering 4. Variant class filtering 5.
    [Show full text]
  • A Pipeline for Identifying Saccharomyces Cerevisiae Mutations
    SOFTWARE AND DATA RESOURCES MutantHuntWGS: A Pipeline for Identifying Saccharomyces cerevisiae Mutations Mitchell A. Ellison,1 Jennifer L. Walker, Patrick J. Ropp, Jacob D. Durrant, and Karen M. Arndt1 Department of Biological Sciences, University of Pittsburgh, PA, 15260 ORCID IDs: 0000-0002-5682-096X (M.A.E.); 0000-0003-1320-9957 (K.M.A.) ABSTRACT MutantHuntWGS is a user-friendly pipeline for analyzing Saccharomyces cerevisiae whole- KEYWORDS genome sequencing data. It uses available open-source programs to: (1) perform sequence alignments for Mutant hunt paired and single-end reads, (2) call variants, and (3) predict variant effect and severity. MutantHuntWGS variant calling outputs a shortlist of variants while also enabling access to all intermediate files. To demonstrate its utility, we Saccharomyces use MutantHuntWGS to assess multiple published datasets; in all cases, it detects the same causal variants cerevisiae reported in the literature. To encourage broad adoption and promote reproducibility, we distribute a bulk segregant containerized version of the MutantHuntWGS pipeline that allows users to install and analyze data with only analysis two commands. The MutantHuntWGS software and documentation can be downloaded free of charge from lab evolution https://github.com/mae92/MutantHuntWGS. Saccharomyces cerevisiae is a powerful model system for under- WGS is particularly powerful when used in conjunction with lab- standing the complex processes that direct cellular function and evolution (Goldgof et al. 2016; Ottilie et al. 2017) or mutant-hunt underpin many human diseases (Birkeland et al. 2010; Botstein experiments, both with (Birkeland et al. 2010; Reavey et al. 2015) and Fink 2011; Kachroo et al. 2015; Hamza et al.
    [Show full text]
  • Gain-Of-Function Mutation of Microrna-140 in Human Skeletal Dysplasia
    LETTERS https://doi.org/10.1038/s41591-019-0353-2 Gain-of-function mutation of microRNA-140 in human skeletal dysplasia Giedre Grigelioniene1,2,3,15, Hiroshi I. Suzuki 4,15, Fulya Taylan 2, Fatemeh Mirzamohammadi1, Zvi U. Borochowitz5, Ugur M. Ayturk6, Shay Tzur7,8, Eva Horemuzova9,10, Anna Lindstrand2,3, Mary Ann Weis11, Gintautas Grigelionis 2, Anna Hammarsjö 2,3, Elin Marsk12, Ann Nordgren2,3, Magnus Nordenskjöld2,3, David R. Eyre11, Matthew L. Warman 6, Gen Nishimura13, Phillip A. Sharp 4,14 and Tatsuya Kobayashi 1* MicroRNAs (miRNAs) are post-transcriptional regulators of A novel skeletal dysplasia was identified in two unrelated fam- gene expression. Heterozygous loss-of-function point muta- ilies in a project for molecular diagnosis of ultrarare congenital tions of miRNA genes are associated with several human con- skeletal disorders (Fig. 1a,b). In family 1, individual II-2, patient genital disorders1–5, but neomorphic (gain-of-new-function) 1, P1, is affected, as is one of her sons (III-2, P2). In family 2, II-1, mutations in miRNAs due to nucleotide substitutions have not P3 is the only affected individual. Clinical features of the skel- been reported. Here we describe a neomorphic seed region etal dysplasia included disproportionate short stature with short mutation in the chondrocyte-specific, super-enhancer-asso- limbs, small hands and feet, and midface hypoplasia with small ciated MIR140 gene encoding microRNA-140 (miR-140) in nose. The radiological hallmarks were mild spondylar dysplasia, a novel autosomal dominant human skeletal dysplasia. Mice delayed epiphyseal ossification of the hip and knee, and severe with the corresponding single nucleotide substitution show brachydactyly with cone-shaped phalangeal epiphyses (Fig.
    [Show full text]