Bioinformatics learning and data analysis tips and tricks. Please, contribute and get in touch!
- RNA-seq notes
- scRNA-seq notes
- ChIP-seq notes
- Methylation notes
- scATAC-seq notes
- SNP notes
- Hi-C tools
- Hi-C data
- scHi-C notes
- Cancer notes
- Immuno notes
See MDmisc notes for other programming and genomics-related notes.
- Diploid reference genome assembly. Combination of different technologies (Oxford Nanopore ultra-long, PacBio HiFi, BioNano, Hi-C), tools (12 assembly algorithms), combination strategies. Compared with the T2T CHM13 genome. All raw sequence data used in this study are available at the HPRC GitHub. The final HPRC-HG002 curated assemblies are available in the NCBI under the BioProject IDs PRJNA794175 and PRJNA794172, with the accession numbers GCA_021951015.1 and GCA_021950905.1, for the maternal and paternal haplotypes, respectively.
Paper
Jarvis, Erich D., Giulio Formenti, Arang Rhie, Andrea Guarracino, Chentao Yang, Jonathan Wood, Alan Tracey, et al. “Semi-Automated Assembly of High-Quality Diploid Human Reference Genomes.” Nature 611, no. 7936 (November 17, 2022): 519–31. https://doi.org/10.1038/s41586-022-05325-5.
- Historical perspective on genome sequencing technologies. From the landmark 1953 Watson and Crick publication through sequencing of nucleic acids, shotgun sequencing (Messing, Sanger), Human Genome Project (HGP) & Celera Genomics, milestones in genome assembly, Next and Third generation sequencing, single molecule sequencing (SMRT, ONT, PacBio), long-read genome assemblers (FALCON, Canu). Box1 - companies developing sequencing technologies, Box 2 - more details on HGP, Box 3 - bioinformatics tools for genome assembly.
Paper
Giani, Alice Maria, Guido Roberto Gallo, Luca Gianfranceschi, and Giulio Formenti. “Long Walk to Genomics: History and Current Approaches to Genome Sequencing and Assembly.” Computational and Structural Biotechnology Journal, November 2019, S2001037019303277. https://doi.org/10.1016/j.csbj.2019.11.002.
- The complete assembly of human genome (haploid CHM13 cell line). 3.055 billion base pairs, no gaps for all 22 chromosomes plus ChrX, new genes. Resolving ribosomal rDNA sequences. PacBio, Oxford Nanopore, other technologies. The Telomere-to-Telomere (T2T) consortium, UCSC, NCBI PRJNA559484, GitHub with download links to FASTA, gff3, liftover chains. Assembly issues tracker
Paper
Nurk, Sergey, Sergey Koren, Arang Rhie, Mikko Rautiainen, Andrey V. Bzikadze, Alla Mikheenko, Mitchell R. Vollger et al. "The complete sequence of a human genome." bioRxiv (2021). https://doi.org/10.1101/2021.05.26.445798
- T2T-Y - Complete sequencing of human Y chromosome, as a part of the T2T project. Lots of information about corrected errors, complete structures of sex-determining genes, additional protein-coding genes, alternating satellite patterns, centromere structure, repeats. Illumina 33X, PacBio HiFi 42X, ONT 125X sequencing. Table 1 - stats comparison with GRCh38-Y. Improves alignment, variant calling, helps removing human contamination from microbial studies. Code used in the paper.
Paper
Rhie, Arang, Sergey Nurk, Monika Cechova, Savannah J. Hoyt, Dylan J. Taylor, Nicolas Altemose, Paul W. Hook, et al. “The Complete Sequence of a Human Y Chromosome.” Preprint. Genomics, December 1, 2022. https://doi.org/10.1101/2022.12.01.518724.
-
Milestones in Genomic Sequencing by Nature, 2000-2021 period, interactive infographics
-
Awesome-Bioinformatics - A curated list of awesome Bioinformatics libraries and software, by Daniel Cook and community-contributed
-
awosome-bioinformatics - A curated list of resources for learning bioinformatics
-
awesome-bioinformatics-education - A curated list of resources specific to learning bioinformatics. Courses, hands-on training, tools.
-
awesome-cancer-variant-databases - A community-maintained repository of cancer clinical knowledge bases and databases focused on cancer variants, by Sean Davis and community-maintained
-
awesome-single-cell - List of software packages for single-cell data analysis, including RNA-seq, ATAC-seq, etc. By Sean Davis and community-maintained
-
awesome-alternative-splicing - Alternative splicing resources
-
awesome-10x-genomics - List of tools and resources related to the 10x genomics GEMCode/Chromium system, by Johan Dahlberg and community-contributed
-
awesome-multi-omics - List of software packages for multi-omics analysis, by Mike Love and community-maintained
-
awesome-bioinformatics-benchmarks - A curated list of bioinformatics bench-marking papers and resources
-
awesome_genome_browsers - genome browsers and genomic visualization tools. By David McGaughey
-
awesome-expression-browser - A curated list of software and resources for exploring and visualizing (browsing) expression data, and more. By Federico Marini and community-maintained
-
awesome-genome-visualization - A list of interesting genome browser or genome-browser-like implementations. By Colin Diesh
-
awesome-microbes - List of software packages (and the people developing these methods) for microbiome (16S), metagenomics (WGS, Shot-gun sequencing), and pathogen identification/detection/characterization. By Steve Tsang and community-contributed
-
aws-for-bioinformatics - Amazon Web Services for Bioinformatics Researchers
-
algorithmsInBioinformatics - Bioinformatics algorithms: Needleman-Wunsch, Feng-Doolittle, Gotoh and Nussinov implemented in Python. By Joachim Wolff, with lecture notes. Also, rklib - Rabin-Karp implementation of sequence substring search for DNA/RNA, and lv89 - C implementation of the Landau-Vishkin algorithm to compute the edit distance between two strings.
-
BAM-tricks - Tip and tricks for BAM files
-
bioicons - A library of free open source icons for science illustrations in biology and chemistry. SVG downloads. GitHub
-
bioconvert - converter between various data formats. Python, command line.
-
biotools - A massive collection of references on the topics of bioinformatics, sequencing technologies, programming, machine learning, and more. By John Didion
-
bio.tools - a community-driven comprehensive and consistent registry of bioinformatics resources. Supported by ELIXIR - the European infrastructure for biological information.
Paper
Ison, Jon, Kristoffer Rapacki, Hervé Ménager, Matúš Kalaš, Emil Rydza, Piotr Chmura, Christian Anthon, et al. “Tools and Data Services Registry: A Community Effort to Document Bioinformatics Resources.” Nucleic Acids Research 44, no. D1 (January 4, 2016): D38–47. https://doi.org/10.1093/nar/gkv1116.
- BioNumPy - Numpy-like analysis of biological data (FASTQ, BED, BAM, etc.). Indexing, vectorized functions, high efficiency on BED intersection, kmer counting, and VCF operations. Documentation with examples of filtering FASTQ reads, working with BAM files, computing GC content, general handling of sequences, intervals, PWMs.
Paper
Rand, Knut Dagestad, Ivar Grytten, Milena Pavlovic, Chakravarthi Kanduri, and Geir Kjetil Sandve. “BioNumPy: Fast and Easy Analysis of Biological Data with Python.” Preprint. Bioinformatics, December 22, 2022. https://doi.org/10.1101/2022.12.21.521373.
-
Circa - online tool for Circos plot creation
-
Jbrowse 2 - Java-based genome browser that includes linear and advanced visualization for synteny, dotplots, breakpoints, gene fusions, whole genome overview, Circos, Spreadsheet view, SV inspector. Many file formats, including Hi-C (hic), BAM/CRAM (various sort pileup options), plain text (VFC, BED, etc.), some specific to specific views. Bookmarks (can be imported from BED), sessions (shareable). Web, desktop versions, can be run from Jupyter notebooks, R (JBrovseR), command line, extended with plugins. Documentation, Demos/tutorials.
Paper
Diesh, Colin, Garrett J Stevens, Peter Xie, Teresa De Jesus Martinez, Elliot A. Hershberg, Angel Leung, Emma Guo, et al. “JBrowse 2: A Modular Genome Browser with Views of Synteny and Structural Variation.” Preprint. Bioinformatics, July 31, 2022. https://doi.org/10.1101/2022.07.28.501447.
-
genome_assembly_tools - List of genome assembly tools. Links to software, publications
-
For all your seq... DNA & RNA - Illumina flyer with infographics of all sequencing-by-synthesis technologies. RNA and DNA versions
-
learngenomics.dev - A guided, intuitive introduction to genomics for software engineers. Curated by the community. Website
-
List of software/websites/databases/other stuff for genome engineering
-
multimodal-scRNA-seq - Figure depicting the breadth of multimodal scRNA-seq technologies. References to technology-specific papers
-
ref-gen - Human reference genome analysis sets, by Heng Li. Recommended human genome sequences for various genome asseblies, justification.
-
SequencEnG - Hierarchical summary of 66 sequencing technologies, computational algorithms, references to papers.
- Zhang, Y., Manjunath, M., Kim, Y., Heintz, J., and Song, J.S. (2019). SequencEnG: an interactive knowledge base of sequencing techniques. Bioinformatics 35, 1438–1440.
-
SRPlot - free online visualization platform of many bioinformatics-specific plots. Tang D, Chen M, Huang X, Zhang G, Zeng L, Zhang G, Wu S, Wang Y. SRplot: A free online platform for data visualization and graphing. PLoS One. 2023 Nov 9;18(11):e0294236. doi: 10.1371/journal.pone.0294236. PMID: 37943830.
-
Wasm - WebAssembly, a framework for deploying tools and code on the web.
- webR/WebAssembly Demo - running R in web browser
- biowasm - running C/C++ genomics tools in the browser
- sandbox.bio - an interactive bedtools tutorial developed by the Quinlan Lab
- Perkel, Jeffrey M. "No installation required: how WebAssembly is changing scientific computing." Nature 627, no. 8003 (2024): 455-456.
-
The Leek group guide to genomics papers- Jeff Leek recommended list of genomics papers
-
Unix, R and python tools for genomics and data science - links and references to many computational biology resources, by Ming Tang
-
bioinformatics-one-liners - collection of bioinformatics-genomics bash one liners, using awk, sed etc., by Ming Tang
-
cloud_computing_resources - genomics-oriented cloud resources.
-
RNA-seq-analysis - RNAseq analysis notes, by Ming Tang
-
ChIP-seq-analysis - ChIP-seq analysis notes, by Ming Tang
-
DNA-seq-analysis - Notes on whole exome and whole genome sequencing analysis, by Ming Tang
-
DNA-methylation-analysis - DNA methylation analysis notes from Ming Tang
-
scATAC-seq-analysis-notes - single-cell ATAC-seq notes, by Ming Tang
-
List of bioinformatics tools developed by IHEC Int'l Human Epigenome Consortium researchers - tools for all types of genomic analyses
-
Learning Nextflow in 2020 - Materials to learn NextFlow
-
Nextflow Tower - management of Nextflow data pipelines. Video overview
-
nf-core - a framework for Nextflow-based pipeline creation, community-driven. Integrated with Conda, Docker, Biocontainers. Scalable to a cloud level. Pipeline assemblers: Flowcraft, Pipeliner. nf-core GitHub. All pipelines are on the nf-core hub.
- Ewels, Philip, Alexander Peltzer, Sven Fillinger, Johannes Alneberg, Harshil Patel, Andreas Wilm, Maxime Garcia, Paolo Di Tommaso, and Sven Nahnsen. “Nf-Core: Community Curated Bioinformatics Pipelines.” Preprint. Bioinformatics, April 16, 2019.
-
bcbio-nextgen - Validated, scalable, community developed variant calling and RNA-seq analysis. Documentation
-
Appyters Catalog of over 40 Appyters. Appyters extend Jupyter Notebooks into standalone web-based bioinformatics applications. Adds Jupyter "magics" to construct output Python code with jinja, the UI is built with svelte and Bootstrap and served with nginx, while data-persistent capabilities such as page hits are deferred to a PostgreSQL database that can be accessed via a PostgREST microservice API. Many bioinformatics workflows, including machine learning, omics data analysis. Entry form for data upload and settings, the Appyter executes the corresponding notebook in the cloud or locally. Comparison with Google Colab, Binder, Papermill and similar tools. Ability to convert Appyters to Docker images. Examples of bulk RNA-seq Appyter (preprocessing, differential expression using limma, edgeR, DESeq2, etc., enrichment using GO, KEGG, Reactome etc., correlation with LINCS L1000 databases), scRNA-seq Appyter (filtering by mitochondria, counts, imputation, clustering, differential analysis, pseudotime, cell type prediction), the Harmonizome-ML Appyter (organized gene-centric data from multiple databases, used to benchmark ML algorithms to predict gene-gene functional associations), the Drugmonizome-ML Appyter (ML interface to the Drugmonizome database for predicting drug and small-molecule attributes), the patient-cohort RNA-seq data viewer for exploring patient's characteristics, e.g., from TCGA, data processing Appyters to extract, transform, and load data for Harmonizome, the Enrichr visualization Appyter, the set comparison Appyter. Table 1 - overview of 27 Appyters.
Paper
Clarke, Daniel J.B., Minji Jeon, Daniel J. Stein, Nicole Moiseyev, Eryk Kropiwnicki, Charles Dai, Zhuorui Xie, et al. “Appyters: Turning Jupyter Notebooks into Data-Driven Web Apps.” Patterns, March 2021, 100213. https://doi.org/10.1016/j.patter.2021.100213.
- Benchmarking of six liftover tools (UCSC liftOver, rtracklayer::liftOver, CrossMap, NCBI Remap, flo and segment liftover) on converting CpG sites and WGBS samples. Considering integrity-preserving and non integrity-preserving. Explanation of chain file format (Figure 1). segment liftover generates more reliable results than USCS liftOver.
Paper
Luu, Phuc-Loi, Phuc-Thinh Ong, Thanh-Phuoc Dinh, and Susan J Clark. “Benchmark Study Comparing Liftover Tools for Genome Conversion of Epigenome Sequencing Data.” NAR Genomics and Bioinformatics 2, no. 3 (September 1, 2020): lqaa054. https://doi.org/10.1093/nargab/lqaa054.
- AirLift - command-line tool (C) for remapping reads between genome assemblies. Very fast, highly accurate in identifying ground truth SNP/InDels in lifted data. Describe limitations of current tools. Methods, lookup tables, eight steps, each read remapped using one of four independent cases. Supports multiple file formats, from BAM to BED. Compared with liftOver, CrossMap. Supplementary - description of other tools (liftOver, CrossMap, MCBI Genome Remapping Service, Segment_liftover, PyLiftover, nf-LO, LevioSAM, Liftoff).
Paper
Kim, Jeremie S., Can Firtina, Meryem Banu Cavlak, Damla Senol Cali, Mohammed Alser, Nastaran Hajinazar, Can Alkan, and Onur Mutlu. “AirLift: A Fast and Comprehensive Technique for Remapping Alignments between Reference Genomes.” arXiv, November 21, 2022. http://arxiv.org/abs/1912.08735.
- BCFtools/liftover - best performing tool for SNP/InDel liftover. Improved support for multiallelic SNPs and indels. Compared with Picard/LiftoverVcf, CrossMap/VCF, GenomeWarp, Transanno/liftvcf, Genozip/DVCF. Algorithm for maximally extending/normalizing VCF records. Details about chains. Lowest dropout rate, memory usage, fastest.
Paper
Genovese, Giulio, Nicole B Rockweiler, Bryan R Gorman, Tim B Bigdeli, Michelle T Pato, Carlos N Pato, Kiku Ichihara, and Steven A McCarroll. “BCFtools/Liftover: An Accurate and Comprehensive Tool to Convert Genetic Variants across Genome Assemblies,” n.d.
-
CrossMap - genome coordinates conversion between different assemblies (such as hg18 (NCBI36) <=> hg19 (GRCh37)). It supports commonly used file formats including BAM, CRAM, SAM, Wiggle, BigWig, BED, GFF, GTF, MAF VCF, and gVCF. Documentation
-
HiCLift - coordinate liftover for region pairs. Converts chromatin contacts in pairs format, allValidPairs outputted by HiC-Pro, cool format and hic (highest resolution) format. Uses UCSC chain files, represented as IntervalTrees, and the T2T chain files. Benchmarked using HiCRep on the original and converted matrices.
Paper
Wang, Xiaotao, and Feng Yue. “HiCLift: A Fast and Efficient Tool for Converting Chromatin Interaction Data between Genome Assemblies.” Edited by Tobias Marschall. Bioinformatics 39, no. 6 (June 1, 2023): btad389. https://doi.org/10.1093/bioinformatics/btad389.
-
Liftoff - An accurate GFF3/GTF lift over pipeline
-
liftover - liftover for python, made fast with cython
-
liftOverBedpe - A liftOver wrapper to accomodate BEDPE files, by Doug Phanstiel, requires Python 2.7
-
pairLiftOver - Python package that converts the two-dimensional genomic coordinates of chromatin contact pairs between assemblies, by Xiaotao Wang. Input - 4D-DCIC pairs format or allValidPairs defined by HiC-Pro. Based on pyliftover
- Mercury - reference-free k-mer analysis for genome assemblies. Also assess completeness, phasing. Works with haplotype-specific assemblies. Visualization, k-mer, hap-mer spectrum plots, can be used to infer CNVs. Inspired by KAT. Benchmarked on model organism and human genomes.
Paper
Rhie, Arang, Brian P. Walenz, Sergey Koren, and Adam M. Phillippy. “Merqury: Reference-Free Quality, Completeness, and Phasing Assessment for Genome Assemblies.” Genome Biology 21, no. 1 (December 2020): 245. https://doi.org/10.1186/s13059-020-02134-9.
-
KAT - The K-mer Analysis Toolkit, compares k-mer spectra. Analyzes jellyfish hashes or FASTQ/FASTA files.
-
kcmbt_mt - A very fast k-mer counter
-
kmertools - kmer based feature extraction tool for bioinformatics, metagenomics, AI/ML and more. Rust, Bioconda installable
-
kmdiff - Differential k-mer analysis
-
Dot - dotplot visualization
-
ComputationalGenomicsManual - material for the computational genomics and bioinformatics class. Videos
-
computational_biology - computational biology lectures (pdf) and labs (ipynb). Alignment algorithms (BLAST, BW transform, dynamic programming), molecular evolution (Markov models, likelihood), phylogenetics (trees, pruning, MCMC), annotations (HMM), motifs (PWMs), machine learning (clustering, classification), bioinformatics (pipelines), biophysics (protein structure, prediction).
-
training-collection - Bioinformatics training materials: Scripting and languages (UNIX shell, Python, R, git), Sequence data analysis (General, Miscellaneous, RNA-seq, ChIP-seq, Single cell, Variant analysis, Genome assembly, Metagenomics), Computational methods and pipelines (Containers, Nextflow, Snakemake, Galaxy, CWL, High performance computing), Statistics and machine learning, Reproducibility and data management. By SIB Swiss Institute of Bioinformatics
-
2020-GGG298 - Course materials for GGG298 - Tools to support data-intensive research, by Titus Brown. Unix, Conda, Snakemake, project organization, Git, Slurm, R/Rmarkdown
-
BI-BE-CS-183-2023 - Introduction to Computational Biology and Bioinformatics Course at Caltech, 2023.
-
biocomp-book - a course on Fundamentals of Computational Biology. Sequencing analysis and genome assembly/analysis. Website
-
bioinformatics - Path to a free self-taught education in Bioinformatics! Systematically organized links to courses.
-
biomedicalresearch2021 - Course Materials for EN.601.452 / AS.020.415 Computational Biomedical Research & Advanced Biomedical Research, by Michael Schatz. Links to other courses, papers.
-
bggn213_W23 - A hands-on introduction to the computer-based analysis of genomic and biomolecular data from the Division of Biological Sciences, UCSD. By prof. Barry Grant. Lecture slides, lab, homework material, videos. Website
-
RNA-seq theory and analysis - theory and practical guidelines for RNA-seq data analysis, by Skyler Kuhn
-
Introduction to Bioinformatics and Computational Biology - the course material for STAT115/215 BIO/BST282 at Harvard University. YouTube
-
Introduction to Bioimage Analysis - This book tries explain the main ideas of image analysis in a practical and engaging way. By Pete Bankhead. GitHub
-
GRanges tutorial - Working with Genomic Ranges, by Sean Davis
-
Data science for economists - from R, tidyverse to GitHub, web scraping, Docker, Google Cloud and more. By Grant McDermott
-
Reproducible research and data analysis with Linux containers and Nextflow pipelines, GitHub
-
Bioinformatics Coffee Hour - Short lessons from FAS Informatics coffee hour,data science, command line, R basics, Snakemake
-
The Biostar Handbook: 2nd Edition - Biostar Handbook - bioinformatics survival guide. A practical overview for the data analysis methods of bioinformatics. From Unix/command line to each type of sequencing data ana analysis
-
Beginner's Handbook to Next Generation Sequencing by GenoHub - omics technologies, experimental descriptions
-
Computational Genomics with R book by Altuna Akalin. From R basics to different types of bioinformatics analyses. GitHub
-
The Bioinformatics algorithms web site. Videos and Texts covering topics from biology to genome assembly algorithms, motif finding, sequence comparisons and more bioinformatics tasks and solutions. By Phillip Compeau and Pavel Pevzner
-
Algorithms for DNA Sequencing - Ben Langmead's course material. Slides on GitHub, Python/Colab code examples, Youtube videos
-
Applied Computational Genomics Course at UU by Aaron Quinlan. All slides on Google drive, Youtube videos for each lecture
-
Introduction to Computational Biology course by Mike Love. GitHub
-
Data Analysis in Genome Biology course by Thomas Girke. Bioinformatics of NGS data analysis GitHub
-
Bioconductor for Genomic Data Science course by Kasper Hansen. Includes videos, code examples and lecture material. GitHub
-
BPA-CSIRO Workshops - Cancer Genomics, Introduction to Next Generation Sequencing Hands-on Workshop. Links to topic-oriented GitHub repositories, PDF handouts. GitHub
-
The Bioconductor 2018 Workshop Compilation, editors - Levi Waldron, Sean Davis, Marcel Ramos, Lori Shepherd, Martin Morgan. Task-oriented workshops covering a range of genomics/Bioconductor analyses. GitHub
-
CSAMA - Course material for CSAMA: Statistical Data Analysis for Genome Scale Biology, by Bioconductor team. Lectures, Labs
-
JHU EN.601.749: Computational Genomics: Applied Comparative Genomics course, by Michael Schatz. Links to similar courses there. Other courses by Michael
-
JHU Data Science lab - several data science courses, links to topic-specific GitHub repositories, other resources
-
CSE 549 - Introduction to Computational Biology by Steven Skiena. Includes video lectures. Another course: CSE 519 - Data Science
-
DIYtranscriptomics.github.io - Course material for the "do-it-yourself" RNA-seq course, by Daniel Beiting. GitHub
-
Informatics for RNA-seq: A web resource for analysis on the cloud by Griffith lab. All aspects of RNA-seq analysis
-
RNA-seqlopedia - one long page of all steps of RNA-seq data analysis, from molecular biology to computational analysis, very detailed
-
BaRC Hot Topics - lecture slides and handouts on all genomics topics, from Unix to microarray, sequencing, genomics and statistics
-
Courses by Dr. Raghu Machiraju. Topics: data visualization, biomedical informatics, computer graphics, linked from the homepage. CSE5599-BMI7830 - biomedical informatics. CSE5544 – Introduction to Data Visualization
-
alignment-and-variant-calling-tutorial - basic walk-throughs for alignment and variant calling from NGS sequencing data, PDF lecture, by Erik Garrison.
-
Oxford Nanopore sequencing tutorial using procaryotic genomes. Supplementary material - walkthrough, tools, data, VM image available.
Paper
Salazar, Alex N., Franklin L. Nobrega, Christine Anyansi, Cristian Aparicio-Maldonado, Ana Rita Costa, Anna C. Haagsma, Anwar Hiralal, et al. “[An Educational Guide for Nanopore Sequencing in the Classroom](https://doi.org/10.1371/journal.pcbi.1007314).” PLOS Computational Biology, (January 23, 2020)
-
Machine Learning in Genomics - Fall 2019 by Manolis Kellis. Course website
-
Free online training in bioinformatics and biostatistics! by David Tabb. Various topics beyond genomics
-
Bioconductor Workshop 2: RNA Seq and ChIP Seq Analysis - 6 hours workshop on RNA-seq and ChIP-seq technology and analysis by Levi Waldron and others
-
Differential Splicing Analysis with RNA-Seq: Current Applications, Approaches, & Limitations - 1 hour overview of differential splicing analysis
-
NHGRI_Genomics2016 - "Current Topics in Genome Analysis 2016" course - A lecture series covering contemporary areas in genomics and bioinformatics, slides
-
MIT_SysBiol2014 - "Foundations of Computational and Systems Biology", slides
-
Regulatory Genomics and Epigenomics - series of genomcs-oriented talks by Simons Institute. 26 videos, ~30min each.
-
Foundations of Data Science — Spring 2016 - course from UC Berkeley. Instructor: John DeNero. Video and slides. This course is accompanied by other "connector" courses from UC Berkeley
-
A Roadmap to the Living Genome by John Stamatoyannopoulos. An overview of cell type-specific (epi)genomic landscapes, visualization and analysis techniques, association and enrichment of disease-associated variants in regulatory regions.
-
RNA-Seq Methods and Algorithms - short video course by Harold Pimentel, pseudoalignment, kallisto, sleuth, practical
-
Integrating ENCODE Data With Your Research: An Interactive Survey of ENCODE Tools and Resources - set of short videos about ENCODE data and functionality
-
Bioinfo-core.org - the community of Bioinformatics Core FAcilities, ISMB workshops, slides, resources about Cores.
-
List of bioinformatics core facilities at bioinfo-core.org
-
Dragon, Julie A., Chris Gates, Shannan Ho Sui, John N. Hutchinson, R. Krishna Murthy Karuturi, Alper Kucukural, Shawn Polson, et al. “Bioinformatics Core Survey Highlights the Challenges Facing Data Analysis Facilities.” Journal of Biomolecular Techniques, June 2020 - Bioinformatics core facility considerations. Responsibilities, finansial models, software/data, reporting/accreditation, challenges and concerns, future.
-
Kallioniemi, O., L. Wessels, and A. Valencia. “On the Organization of Bioinformatics Core Services in Biology-Based Research Institutes.” Bioinformatics, (May 15, 2011) - 1-page Bioinformatics core recommendations.
-
Lewitter, Fran, Michael Rebhan, Brent Richter, and David Sexton. “The Need for Centralization of Computational Biology Resources.” PLoS Computational Biology, (June 26, 2009) - Bioinformatics core as the center of computational resources, advantages and disadvantages. Questions to consider: IT and computational infrastructure, keeping up with science, training and education, funding model, hiring, evaluation, esternal affitiates with the core, outreach.
-
Richter, Brent G., and David P. Sexton. “Managing and Analyzing Next-Generation Sequence Data.” PLoS Computational Biology, (June 26, 2009) - Sequencing data computational analysis and storage, skills for data analysis (Unix, scripting, parallel computing, network, databases, biology/genomics, connect science with (novel) software solutions).
-
Lewitter, Fran, and Michael Rebhan. “Establishing a Successful Bioinformatics Core Facility Team.” PLoS Computational Biology, (June 26, 2009) - Considerations for successful bioinformatics core development (objectives, personnel, prioritization/time management, staying connected with research trends, outreach). Slides from the ISMB 2008 BoF on best practices in running bioinformatics cores.