Schedule
For the Fall 2023 quarter we will meet twice a week on Wednesday and Friday at 1:00-4:00 pm in TATA 2501 (Map). Clicking on the topics below will take you to supporting class content including video lectures, hands-on “lab session” sheets, walk-through screencasts, required reading material and homework assignments.
# | Date | Topics for Fall 2023 |
---|---|---|
0 | - | Getting Oriented Course introduction, Learning goals & expectations, Meet the instructional team. Setup your computer with required software. |
1 | Wed 10/04/23 | Welcome to Bioinformatics Biology is an information science, History of Bioinformatics, Types of data, Application areas and introduction to upcoming course segments, Hands on with major Bioinformatics databases and key online NCBI and EBI resources |
2 | Fri 10/06/23 | Sequence alignment fundamentals, algorithms and applications Homology, Sequence similarity, Local and global alignment, classic Needleman-Wunsch, Smith-Waterman and BLAST heuristic approaches, Hands on with dot plots, Needleman-Wunsch and BLAST algorithms highlighting their utility and limitations. |
3 | Wed 10/11/23 | Project: Find a gene project assignment (Part 1) Principles of database searching, due in 2 weeks. (Part 2) Sequence analysis, structure analysis and general data analysis with R due at the end of the quarter. |
* | 10/11/23 | Optional: Advanced sequence alignment and database searching Detecting remote sequence similarity, Database searching beyond BLAST, Substitution matrices, Using PSI-BLAST, Profiles and HMMs, Protein structure comparisons as a gold standard. |
4 | Fri 10/13/23 | Bioinformatics data analysis with R Why do we use R for bioinformatics? R language basics and the RStudio IDE, Major R data structures and functions, Using R interactively from the RStudio console. Introducing Rmarkdown documents. |
5 | Wed 10/18/23 | Data exploration and visualization in R The exploratory data analysis mindset, Data visualization best practices, Simple base graphics (including scatterplots, histograms, bar graphs, dot chats, boxplots and heatmaps), Building more complex charts with ggplot. |
6 | Fri 10/20/23 | Why, when and how of writing your own R functions The basics of writing your own functions that promote code robustness, reduce duplication and facilitate code re-use. Extending functionality and utility with R packages from CRAN and BioConductor, Working with Bio3D for molecular data. |
7 | Wed 10/25/23 | Introduction to machine learning for Bioinformatics 1 Unsupervised learning, K-means clustering, Hierarchical clustering, Heatmap representations. Dimensionality reduction, Principal Component Analysis (PCA) |
8 | Fri 10/27/23 | Halloween Candy Mini-Project A fun and topical mini-project with unsupervised learning analysis of halloween_candy, Practical considerations and best practices for the exploratory analysis and visualization of high dimensional datasets. |
9 | Wed 11/01/23 | Unsupervised learning mini-project Longer hands-on session with unsupervised learning analysis of cancer cells further highlighting Practical considerations and best practices for the analysis and visualization of high dimensional datasets |
10 | Fri 11/03/23 | Structural Bioinformatics (pt1) Comparative structure and sequence analysis. The importance of Multiple Sequence Alignments (MSAs). Structure prediction with AlphaFold2 and the new age of structural biology. Working with sequence and structure data in R. (If time allows) Protein motion and conformational variants, Molecular simulation and small molecule docking and drug optimization. |
11 | Wed 11/08/23 | AlphaFold and Structural Prediction (pt2) The new age of structural biology. Structure prediction with AlphaFold2 and the importance of learning from Multiple Sequence Alignments (MSAs). ESM-Fold and large language models for protein structure. |
12 | Fri 11/10/23 | Veterans Day Holiday/Genome informatics and high throughput sequencing review No in-person class today. Review of searching genes and gene functions, Genome databases, Variation in the Genome, High-throughput sequencing technologies, biological applications, bioinformatics analysis methods; The Galaxy platform along with resources from the EBI & UCSC N.B. This is an online session! |
13 | Wed 11/15/23 | Transcriptomics, RNA-Seq analysis, and the interpretation of gene lists RNA-Seq aligners, Differential expression tests, RNA-Seq statistics, Counts and FPKMs and avoiding P-value misuse, Hands-on analysis of RNA-Seq data with R. Gene functional annotation, Functional databases KEGG, InterPro, GO ontologies and functional enrichment. |
14 | Fri 11/17/23 | RNA-Seq mini project Differential expression analysis project with DESeq2 followed by gene enrichment and functional annotation with KEGG, InterPro, and GO ontologies. |
15 | Wed 11/22/23 | Hands-on with Git and GitHub Why you should use a version control system, How to perform common operations with Git. Creating and working with your own GitHub repos and navagating and using those of others. |
16 | Fri 11/24/23 | Thanksgiving holiday No class today. Happy Thanksgiving! |
17 | Wed 11/29/23 | Essential UNIX for bioinformatics Bioinformatics on the command line, Understanding processes, File system structure, Connecting to remote servers, Redirection, streams and pipes, Workflows for batch processing, Launching and using AWS EC2 instances (A.K.A. Virtual Machines). |
18 | Fri 12/01/23 | Analyzing sequencing data in the cloud A mini-project using AWS EC2 to query, download, decompress and analyze large data sets from the Sequence Read Archive. Practical considerations and best practices for installing bioinformatics software on Linux, transfering large data sets, and performing analysis either locally or on AWS. |
19 | Wed 12/06/23 | Investigating pertussis resurgence mini project A topical mini-project using web-scraping, JSON based APIs and advanced dplyr and ggplot to investigate brand new datasets associated with pertussis cases and longitudinal RNA-Seq on the immune response to vaccination. |
20 | Fri 12/08/23 | Portfolio building and discussion of bioinformatics in industry Course summary and review, Making a public facing GitHub pages portfolio of your bioinformatics work; Livestream interview with leading bioinformatics and genomics scientists from industry. Project: Find a gene assignment due! |
Class material
0: Getting oriented
Topics:
Course introduction, Learning goals & expectations, Meet the instructional team. Seting up your computer with required software.
Goals:
- Understand course scope, expectations, logistics and ethics code.
- Complete the pre-course questionnaire.
- Setup your computer for this course.
Videos:
- 0.1 - Welcome to BGGN 213 (course introduction and overview)
- 0.2 - Website overview (finding course content and installing software)
Supporting material:
- Handout: Class Syllabus,
- Pre-course Questionnaire,
- Computer Setup Instructions.
- Sign up for our Piazza class Q&A site,
- View the class GradeBook.
1: Welcome to Bioinformatics
Topics: Biology is an information science, History of Bioinformatics, Types of data, Application areas and introduction to upcoming course segments, Introduction to NCBI & EBI resources for the molecular domain of bioinformatics, Hands-on session using NCBI-BLAST, Entrez, GENE, UniProt, Muscle and PDB bioinformatics tools and databases.
Goals:
- Understand the increasing necessity for computation in modern life sciences research.
- Get introduced to how bioinformatics is practiced.
- Be able to query, search, compare and contrast the data contained in major bioinformatics databases (GenBank, GENE, UniProt, PFAM, OMIM, PDB) and describe how these databases intersect.
- The goals of the hands-on session is to introduce a range of core bioinformatics databases and associated online services whilst actively investigating the molecular basis of several common human disease.
Videos:
- 1.1 - Introduction to bioinformatics (what, where and why of bioinformatics),
- 1.2 - Major bioinformatics resource providers (NCBI and EBI),
- 1.3 - A quick tour of major NCBI and EBI resources (GENE, UniProt, GO, OMIM, PDB, PFAM).
Supporting Material:
- Lecture Slides: Large PDF, Small PDF,
- Handout: Major Bioinformatics Databases,
- Lab: Hands-on section worksheet,
- Lab: Video walk-through,
- Office/Student Hours: Zoom on Fri @ 4pm,
- Feedback: Muddy Point Assessment,
Homework:
- Questions,
- Submit your completed lab report (i.e. filled in PDF form) to GradeScope,
- Readings:
2: Sequence alignment fundamentals, algorithms and applications
Topics: Sequence Alignment and Database Searching: Homology, Sequence similarity, Local and global alignment, Heuristic approaches, Database searching with BLAST, E-values and evaluating alignment scores and statistics.
Goals:
- Be able to describe how dynamic programming works for pairwise sequence alignment.
- Appreciate the differences between global and local alignment along with their major application areas.
- Understand how aligning novel sequences with previously characterized genes or proteins provides important insights into their common attributes and evolutionary origins.
- The goals of the hands-on session are to explore the principles underlying the computational tools that can be used to compute and evaluate sequence alignments.
Videos:
- 2.1 - Alignment fundamentals,
- 2.2 - Dot plots,
- 2.3 - Dynamic programing, global alignment,
- 2.4 - Dynamic programing, local alignment and BLAST basics,
Supporting Material:
- Lecture Slides: Large PDF, Small PDF,
- Dot Plot App Mirrors: app-1, app-2,
- Lab: Hands-on section worksheet
- Lab: Video walk-through,
- Student Hours: Zoom on Fri @ 4pm,
- Feedback: Muddy Point Assessment.
Homework:
- Questions,
- Submit your completed lab report (i.e. filled in PDF form) to GradeScope,
- OPTIONAL: Complete the following Alignment Problem,
- For next week please install R and RStudio,
- DataCamp: Sign-up to our 24_bioinformatics group/organization via the link on Piazza or in your UCSD email. We will use this from next week onward. However, feel free to get started with your first course Introduction to R!.
Readings:
- Readings: PDF1: What is dynamic programming?,
- Readings: PDF2 Fundamentals of database searching.
(Project:) Find a Gene Assignment Part 1
The find-a-gene project is a required assignment for BGGN-213. The objective with this assignment is for you to demonstrate your grasp of database searching, sequence analysis, structure analysis and the R environment that we have covered to date in class.
You may wish to consult the scoring rubric at the end of the above linked project description and the example report for format and content guidance.
Your responses to questions Q1-Q4 are due in two weeks time.
The complete assignment, including responses to all questions, is due Monday of week 10 at 12pm San Diego time.
In both instances your PDF format report should be submitted to GradeScope. Late responses will not be accepted under any circumstances.
Videos:
- 3.1 - Project introduction Please note: due dates may differ from those in video.
3: Advanced sequence alignment and database searching
Topics:
Detecting remote sequence similarity, Substitution matrices, Database searching beyond BLAST with PSI-BLAST, Profiles and HMMs, Protein structure comparisons, Beginning with command line based database searches.
Goal:
- Be able to calculate the alignment score between protein (or nucleotide) sequences using a provided scoring matrix such as BLOSUM62.
- Understand the limits of homology detection with tools such as BLAST.
- Know how to derive a PROSITE style regular expression for aligned motifs.
- Be able to calculate a PSSM profile and for aligned sequences and subsequently score new sequences using a PSSM.
- Be able to perform PSI-BLAST, HMMER and protein structure based database searches and interpret the results in terms of the biological significance of an e-value.
- Be familiar with the concepts of True Positives, False Positives, Sensitivity and Specificity.
Material:
- Lecture Slides: Large PDF, Small PDF,
- Lab: Hands-on section worksheet,
- Bonus: Alignment App,
- Feedback: Muddy Point Assessment.
Homework:
- Questions click and select “make a copy” then follow instructions,
- DataCamp: Sign-up to our 24_bioinformatics group/organization via the link in your UCSD email and start (you do not have to finish yet) Introduction to R! (we will complete this next week).
- RStudio and R download and setup.
4: Bioinformatics data analysis with R
Topics: Why do we use R for bioinformatics? R language basics and the RStudio IDE, Major R data structures and functions, Using R interactively from the RStudio console.
Goal:
- Understand why we use R for bioinformatics
- Familiarity with R’s basic syntax,
- Familiarity with major R data structures (vectors, data.frames and lists),
- Understand the basics of using functions (arguments, vectorizion and re-cycling).
Videos:
- 4.1 Why R and RStudio,
- 4.2 Major R data structures, data types, and using functions,
- 4.3 Working with DataCamp N.B. Use your UCSD email invite to sign up and visit our class group/organization.
Supporting Material:
- Lecture Slides: Large PDF, Small PDF,
- Cheat Sheet: Base R overview,
- Lab: Hands-on section,
- Lab: Video walk-through focusing on introducing R data structures and core syntax,
- Extra credit lab: Introduction to data in R,
- Optional extension: Advanced conservation analysis of globins with R this demonstrates where we are going on our R learning journey. You should be able to do analysis like this on your own at the end of the course.
- Student Hours: Zoom on Fri @ 4pm,
- Feedback: Muddy point assessment,
Homework:
- Questions,
- DataCamp: Make sure you have joined our DataCamp 24_bioinformatics group and then complete the Introduction to R! course (4hrs).
5: Data exploration and visualization in R
Topics: The exploratory data analysis mindset, Data visualization best practices, Simple base graphics (including scatterplots, histograms, bar graphs, dot chats, boxplots and heatmaps), Building more complex charts with ggplot.
Goal:
- Appreciate the major elements of exploratory data analysis and why it is important to visualize data.
- Be conversant with data visualization best practices and understand how good visualizations optimize for the human visual system.
- Be able to generate informative graphical displays including scatterplots, histograms, bar graphs, boxplots, dendrograms and heatmaps and thereby gain exposure to the extensive graphical capabilities of R.
- Appreciate that you can build even more complex charts with ggplot and additional R packages.
- Be able to write and (re)use basic R scripts to aid with reproducibility.
Videos:
- 5.1 - Why visualize data?,
- 5.2 - Data visualization best practices,
- 5.3 - Introduction to ggplot,
- 5.4 - Optional: The grammar of graphics - the gg in ggplot,
Supporting Material:
- Lecture Slides: Large PDF, Small PDF,
- Lab: Hands-on worksheet,
- Lab: Live screencast video walk-through,
- Student Hours: Zoom on Fri @ 4pm,
- Feedback: Muddy point assessment,
Homework:
- Questions,
- Submit your completed PDF lab report to GradeScope,
- DataCamp: Introduction to Data Visualization with ggplot2 (~4hrs).
- SideNote: Convincing with graphics.
- Check-out the new website: Data-to-Viz and ggplot cheat sheat.
6: R functions and R packages from CRAN and BioConductor
Topics: The why, when and how of writing your own R functions with worked examples. Further extending functionality and utility with R packages, Obtaining R packages from CRAN and Bioconductor, Working with Bio3D for molecular data, Managing genome-scale data with bioconductor.
Goals:
- Understand the structure and syntax of R functions and how to view the code of any R function,
- Be able to follow a step by step process of going from a working code snippet to a more robust function that reduces duplication and facilitate code re-use,
- Be able to find and install R packages from CRAN and bioconductor,
- Understand how to find and use package vignettes, demos, documentation, tutorials and source code repository where available.
Videos:
- 6.1 - Writing your own functions (why, when and how),
- 6.2 - Introduction to CRAN & BioConductor,
- 6.3 - Quick introduction to RMarkdown,
- 6.4 - Optional longer video: Getting started with RMarkdown.
Supporting material:
- Lecture Slides: Pt1. Large PDF, Pt2. Large PDF,
- Lab: Hands-on section worksheet,
- Lab supplement: Hands-on section supplemental information,
- Lab: Live screencast video walk-through,
- Extra: Introductory tutorial on R packages,
- Student Hours: Zoom on Fri @ 4pm,
- Feedback: Muddy point assessment.
Homework:
- Questions,
- Submit your completed PDF lab report to GradeScope,
- Write a function: See Q6 of the hands-on lab supplement above. This entails turning a supplied code snippet into a more robust and re-usable function that will take any of the three listed input proteins and plot the effect of drug binding. Note assessment rubric and submission instructions within document.
- DataCamp: Please work toward completing any outstanding courses including Intro to R, Intro to ggplot2 and Intermediate R.
Other:
7: Introduction to machine learning for Bioinformatics
Topics: Unsupervised learning, supervised learning and reinforcement learning; Focus on unsupervised learning, K-means clustering, Hierarchical clustering, Dimensionality reduction, visualization and analysis, Principal Component Analysis (PCA) Practical considerations and best practices for the analysis of high dimensional datasets.
Goal:
- Understand the major differences between unsupervised and supervised learning.
- Be able to create k-means and hierarchical cluster models in R
- Be able to describe how the k-means and bottom-up hierarchical cluster algorithms work.
- Know how to visualize and integrate clustering results and select good cluster models.
- Be able to describe in general terms how PCA works and its major objectives.
- Be able to apply PCA to high dimensional datasets and visualize and integrate PCA results (e.g identify outliers, find structure in features and aid in complex dataset visualization).
Videos:
- 7.1 - Introduction to unsupervised learning and K-means clustering,
- 7.2 - Hierarchical clustering,
- 7.3 - Principal component analysis (PCA) Pt.1.
Supporting material:
- Lecture Slides: Large PDF, Small PDF,
- WebApp: Introduction to PCA,
- Lab: Hands-on section worksheet for PCA,
- Data files: UK_foods.csv, WisconsinCancer.csv, new_samples.csv.
- Lab: Live screencast video walk-through,
Student Hours: Zoom on Fri @ 4pm,
- Feedback: Muddy point assessment.
Homework:
- Submit your completed PDF lab report to GradeScope,
- DataCamp: Introduction to the Tidyverse (~4hrs).
Other Material:
- Bonus: StackExchange discussion on PCA.
8: Halloween Candy Mini-Project
Topics: A fun and topical mini-project with unsupervised learning analysis of halloween_candy, Practical considerations and best practices for the analysis and visualization of high dimensional datasets.
9: Unsupervised Learning Mini-Project
Topics: Hands-on project session with unsupervised learning analysis of cancer cells, Practical considerations and best practices for the analysis and visualization of high dimensional datasets.
Goals:
- Be able to import data and prepare data for unsupervised learning analysis.
- Be able to apply and test combinations of PCA, k-means and hierarchical clustering to high dimensional datasets and critically review results.
Material:
- Lecture Slides: Large PDF, Small PDF,
- Lab Mini-Project: Unsupervised learning analysis of breast cancer cells,
- Data file: WisconsinCancer.csv, new_samples.csv.
Feedback: Muddy point assessment.
- Bonus: Kevin’s StackExchange Link on PCA.
Homework:
- Submit your completed PDF lab report to GradeScope,
- DataCamp: Complete Introduction to the Tidyverse (~4hrs).
10: Structural Bioinformatics (Focus on new AlphaFold2)
Topics: Protein structure function relationships, Protein structure and visualization resources, Modeling energy as a function of structure, Homology modeling, AlphaFold, Predicting functional dynamics, Inferring protein function from structure.
Goal:
- View and interpret the structural models in the PDB,
- Understand the classic
Sequence>Structure>Function
via energetics and dynamics paradigm, - Be able to use VMD for biomolecular visualization and analysis,
- Appreciate the role of AlphaFold in advancing structural bioinformatics,
- Be able to use the Bio3D package for exploratory analysis of protein sequence-structure-function-dynamics relationships.
Videos:
- 10.1 - Introduction to structural bioinformatics,
10.2 - Visualization, interpretation and modeling of protein structure,
- 10.3 - The story of AlphaFold,
Material:
- Lecture Slides: Large PDF, Small PDF,
- Feedback: Muddy point assessment.
Homework:
- Your Homework is to complete the lab session.
11: Structure prediction with AlphaFold2 (Structural Bioinformatics pt2.)
Topics: The new age of structural biology. Structure prediction with AlphaFold2 and the importance of learning from Multiple Sequence Alignments (MSAs). ESM-Fold and large language models for protein structure. Modeling protein energy as a function of structure.
- Lab: Protein Structure Prediction with AlphaFold,
- AlphaFold: ColabFold Notebook,
- ESM-Fold: Metagenomic Atlas Fold Sequence.
- Slides: Small PDF.
Homework:
- Your Homework is to complete the lab session.
12: Genome informatics
Topics: Genome sequencing technologies past, present and future (Sanger, Shotgun, PacBio, Illumina, toward the $500 human genome), Biological applications of sequencing, Variation in the genome, RNA-Sequencing for gene expression analysis; Major genomic databases, tools and visualization resources from the EBI & UCSC, The Galaxy platform for quality control and analysis; Sample Galaxy RNA-Seq workflow with FastQC and Bowtie2. N.B. This is an online-only class session.
Goals:
- Appreciate and describe in general terms the rapid advances in sequencing technologies and the new areas of investigation that these advances have made accessible.
- Understand the process by which genomes are currently sequenced and the bioinformatics processing and analysis required for their interpretation.
- For a genomic region of interest (e.g. the neighborhood of a particular SNP), use a genome browser to view nearby genes, transcription factor binding regions, epigenetic information, etc.
- Be able to use the Galaxy platform for basic RNA-Seq analysis from raw reads to expression value determination.
- Understand the FASTQ file format and the information it holds.
- Understand the SAM/BAM file format and the information it holds.
Videos:
- 12.1 - Introduction to genomics,
- 12.2 - Sequencing methods from Jonathan Weissman (UCSF),
- 12.3 - The basics of RNASeq work-flows,
- 12.4 - Optional: Lessons from the Human Genome Project.
Supporting material:
- Lecture Slides: Large PDF, Small PDF,
- Lab: Hands-on section worksheet (as PDF form),
- Lab: Live screencast video walk-through,
- Galaxy Server, create a free account for section 3 of the lab.
- RNA-Seq data files: HG00109_1.fastq, HG00109_2.fastq, genes.chr17.gtf, Expression genotype results.
- SAM/BAM file format description.
Student Hours: Zoom on Fri @ 4pm,
- Feedback: Muddy point assessment.
Homework:
- Population analysis: Submit to GradeScope your RMarkdown/Quarto generated PDF with working code, output and narrative text answering Q13 and Q14 in this weeks Hands-on section worksheet.
13: Transcriptomics and the analysis of RNA-Seq data
Topics: Analysis of RNA-Seq data with R, Differential expression tests, RNA-Seq statistics, Counts and FPKMs, Normalizing for sequencing depth, DESeq2 analysis. Gene finding and functional annotation from high throughput sequencing data, Functional databases KEGG, InterPro, GO ontologies and functional enrichment.
Goals:
- Given an RNA-Seq dataset, find the set of significantly differentially expressed genes and their annotations.
- Gain competency with data import, processing and analysis with DESeq2 and other bioconductor packages.
- Understand the structure of count data and metadata required for running analysis.
- Be able to extract, explore, visualize and export results.
- Perform a GO analysis to identify the pathways relevant to a set of genes (e.g. identified by transcriptomic study or a proteomic experiment). Use both Bioconductor packages and online tools to interpret gene lists and annotate potential gene functions.
Videos:
- 13.1 - Differential expression analysis of RNA-Seq data,
- 13.2 - Differential expression tests and pathway analysis,
- 13.3 - Installing Bioconductor and DESeq2,
- Lab screencast - Live video walk-through @ 10am Fri SD time.
Supporting material:
- Lecture Slides: Large PDF, Small PDF.
- Detailed Bioconductor setup instructions.
- Lab: Hands-on section worksheet,
- Lab: Live screencast video walk-through,
- Data files: airway_scaledcounts.csv, airway_metadata.csv.
- Student Hours: Zoom on Fri @ 4pm,
- Muddy point assessment.
Readings:
- Excellent review article: Conesa et al. A survey of best practices for RNA-seq data analysis. Genome Biology 17:13 (2016).
- An oldey but a goodie: Soneson et al. “Differential analyses for RNA-seq: transcript-level estimates improve gene-level inferences.” F1000Research 4 (2015).
- Good review article: Trapnell C, Hendrickson DG, Sauvageau M, Goff L et al. “Differential analysis of gene regulation at transcript resolution with RNA-seq”. Nat Biotechnol 2013 Jan;31(1):46-53. PMID: 23222703.
- Abstract and introduction sections of: Himes et al. “RNA-Seq transcriptome profiling identifies CRISPLD2 as a glucocorticoid responsive gene that modulates cytokine function in airway smooth muscle cells.” PLoS ONE 9.6 (2014): e99625.
Homework:
- Submit your completed PDF lab report to GradeScope,
14: RNA-Seq analysis mini-project
Topics: Differential expression analysis project with DESeq2 followed by gene enrichment and functional annotation with KEGG, InterPro, and GO ontologies.
- Lab: DESeq2 analysis mini-project Submit to your work gradescope,
- Data files: GSE37704_featurecounts.csv, GSE37704_metadata.csv.
15: Hands-on with Git and GitHub
Topics: Today’s lecture and hands-on sessions introduce Git, currently the most popular version control system. We will learn how to perform common operations with Git and RStudio. We will also cover syncing your bioinformatics work to date to GitHub.
Videos:
- 15.1 - OPTIONAL: Git for humans,
Supporting material:
- Lecture Slides: Large PDF,
- Lab: Hands-on with Git and GitHub,
Homework:
Submit yoour GitHub class repository URL on GradeScope.
16: Thanksgiving holiday
17: Essential UNIX for bioinformatics
Topics: Bioinformatics on the command line, Why do we use UNIX for bioinformatics? UNIX philosophy, 21 Key commands, Understanding processes, File system structure, Connecting to remote servers, Redirection, streams and pipes, Workflows for batch processing, Organizing computational projects, Going further with your own computer in the cloud, Launching and using AWS EC2 instances (A.K.A. Virtual Machines).
Goals:
- Understand why we use UNIX for bioinformatics
- Use UNIX command-line tools for file system navigation and text file manipulation.
- Have a familiarity with 21 key UNIX commands that we will use ~90% of the time.
- Be able to connect to remote servers from the command line.
- Use existing programs at the UNIX command line to analyze bioinformatics data.
- Understand IO Redirection, Streams and pipes.
- Understand best practices for organizing computational projects.
Videos:
- 17.1 - Essential UNIX for bioinformatics I,
- 17.2 - Essential UNIX for bioinformatics II,
- 17.3 - Manipulating files on UNIX machines
- 17.4 - UNIX superpowers: using pipes and conecting to remote machines.
Supporting material:
- Lecture Slides: Large PDF, Small PDF.
- Lab screencast Launching an AWS EC2 instance,
- Hands-on section worksheet
- (Part I) Starting your own computer in the cloud,
- (Part II) Accessing and using your AWS instance,
- AWS Console URL: https://awsed.ucsd.edu/.
- Student Hours: Zoom on Fri @ 4pm,
- Muddy point assessment.
Homework:
- Questions (complete PDF form with your answers, save, and submit to GradeScope under “15. HW Class15 (Unix Basics)”),
- No lab report due this week,
- DataCamp: Introduction to the Unix shell (~4hrs).
18: Analyzing sequencing data in the cloud
Topics: A mini-project whre we use bespoke cloud computing resources to query, download, decompress and analyze large data sets from NCBI’s main Sequence Read Archive (SRA). Practical considerations and best practices for installing bioinformatics software on Linux, transfering large data sets, and performing analysis either locally or on AWS.
- Lab: Obtaining and processing SRA datasets on AWS,
- AWS Console URL: https://awsed.ucsd.edu/.
- Paper: “A Quick Guide to Organizing Computational Biology Projects”.
X: Vaccination rate mini project
Topics: A topical mini-project using ggplot and dplyr on with the latest state wide COVID-19 vaccination data. Practical considerations and best practices for exploratory data analysis.
- Lab: COVID-19 vaccination rates mini-project submit your lab report to gradescope,
- Data files: Statewide COVID-19 Vaccines Administered by ZIP Code,
19: Mini Project: Investigating Pertussis Resurgence
Topics: A topical mini-project using web-scraping, JSON based APIs and advanced dplyr and ggplot to investigate new datasets associated with pertussis cases and longitudinal RNA-Seq on the immune response to distinct vaccination strategies. This class will be co-taught with Dr. Bjoern Peters from the La Jolla Institute for Immunology.
- Lab: Investigating pertussis resurgence mini-project submit your lab report to gradescope,
- Lecture Slides: Large PDF,
- Additional resources: CDC pertussis tracking data, The CMI-PB resource, Pertussis annotated timeline,
- Feedback: Feedback for Bjoern.
Homework:
- Generate a complete lab report with all sections and question responses for submission to gradescope.
- There are no homework quiz questions this week.
20: Online portfolio completion plus bonus Bioinformatics in industry session
Topics: Course review and feedback. Making a public facing GitHub pages portfolio of your bioinformatics work. Project assignment troubleshooting. Discussion of Bioinformatics and genomics career opportunities.
Videos:
- 20.1 - OPTIONAL: Git for humans,
- 20.2 Introduction to GitHub Pages that we will use for building your portfolio website.
- 20.3 Live stream interview with leading bioinformatics and genomics scientists from industry including Dr Ali Crawford (Associate Director, Scientific Research, Illumina Inc.), Dr. Bjoern Peters (Full Professor and Principal Investigator, La Jolla Institute) and Dr. Ana Grant (Director of Research Informatics, Synthetic Genomics Inc.).
Supporting material:
- Lecture Slides: Large PDF,
Ether-pad: Feedback.
- Resource for going further: Happy Git with R,
- DataCamp: Bioinformatics Extension Track
Or student topic of choice to be selected from those below:
- Biological network analysis
- Cancer genomics
- Unix tips and tricks for Bioinformatics
- Structural Bioinformatics and computational drug design
- Introduction to the tidyverse
- Writing R packages
- Advanced RMarkdown
- Creating online work portfolios with GitHub-pages
UNK: Guest lecture: Immunoinformatics, immunotherapy and cancer
Topics: Cancer genomics resources and bioinformatics tools for investigating the molecular basis of cancer. Large scale cancer sequencing projects; NCI Genomic Data Commons; What has been learned from genome sequencing of cancer? Immunoinformatics, immunotherapy and cancer; Using genomics and bioinformatics to harness a patient’s own immune system to fight cancer. Implications for the development of personalized medicine.
Material:
- Lecture Slides: Pt1 PDF, Pt2 PDF
- Lab: Hands-on Worksheet Part 1.
- Lab: Hands-on Worksheet Part 2.
- Data files:
- Solutions:
- Example mutant identification and subsequence extraction with R walk through.
- subsequences.fa,
- Solutions.pdf.
IEDB HLA binding prediction website http://tools.iedb.org/mhci/.
- Feedback: Muddy-Point-Assesment