/12-days-of-biopython

12 days of Biopython is a collection of 12 videos explaining in details how to work with Biopython, a bioinformatics tool using a real life examples.

Primary LanguageJupyter Notebook

12 days of Biopython

12 days of Biopython is a collection of 12 videos explaining in details how to work with Biopython, a bioinformatics tool using a real life examples.

Day 1: Checking quality of the reads - Working with FASTQ files

Day 2: Accessing NCBI databases with Biopython

Day 3: Pairwise Sequence alignments in Biopython

Day 4: BLAST in Biopython

Day 5: COVID-19 Genome Analysis using Biopython

Day 6: BLAST search of COVID

Day 7: Visualisation of COVID protein

Day 8: Motif objects in Biopython

Day 9: Plotting sequence length and GC content

Day 10: Indexing a FASTQ file - how to read big FASTQ file faster?

Day 11: Sorting a sequence file (FASTA or FASTQ file)

Day 12: Simple quality filtering for FASTQ files