SlideShare a Scribd company logo
1 of 27
The 8th annual Bioinformatics Open Source Conference (BOSC 2007) 18 th  July, Vienna, Austria Biopython Project Update Peter Cock, MOAC Doctoral Training Centre, University of Warwick, UK
Talk Outline ,[object Object],[object Object],[object Object],[object Object],[object Object],[object Object],[object Object],The 8 th  annual Bioinformatics Open Source Conference Biopython Project Update @ BOSC 2007, Vienna, Austria
What is Python? ,[object Object],[object Object],[object Object],[object Object],[object Object],The 8 th  annual Bioinformatics Open Source Conference Biopython Project Update @ BOSC 2007, Vienna, Austria
What is Biopython? ,[object Object],[object Object],[object Object],[object Object],The 8 th  annual Bioinformatics Open Source Conference Biopython Project Update @ BOSC 2007, Vienna, Austria
Popularity by Google Hits ,[object Object],[object Object],[object Object],[object Object],98 million 101 million 101 million 289 million ,[object Object],[object Object],[object Object],[object Object],252,000 610,000 122,000 185,000 ,[object Object],[object Object],The 8 th  annual Bioinformatics Open Source Conference Biopython Project Update @ BOSC 2007, Vienna, Austria BioPerl  610,000
Biopython history ,[object Object],[object Object],[object Object],[object Object],[object Object],[object Object],[object Object],[object Object],[object Object],The 8 th  annual Bioinformatics Open Source Conference Biopython Project Update @ BOSC 2007, Vienna, Austria
Biopython Project Organisation ,[object Object],[object Object],[object Object],[object Object],[object Object],[object Object],[object Object],[object Object],[object Object],[object Object],The 8 th  annual Bioinformatics Open Source Conference Biopython Project Update @ BOSC 2007, Vienna, Austria
What can you do with Biopython? ,[object Object],[object Object],[object Object],[object Object],[object Object],[object Object],[object Object],[object Object],The 8 th  annual Bioinformatics Open Source Conference Biopython Project Update @ BOSC 2007, Vienna, Austria
Manipulating Sequences ,[object Object],[object Object],[object Object],[object Object],The 8 th  annual Bioinformatics Open Source Conference Biopython Project Update @ BOSC 2007, Vienna, Austria
Manipulating Sequences from Bio.Seq import Seq from Bio.Alphabet.IUPAC import unambiguous_dna my_dna=Seq('CTAAACATCCTTCAT', unambiguous_dna) print 'Original:' print my_dna print 'Reverse complement:' print my_dna.reverse_complement() Original: Seq('CTAAACATCCTTCAT', IUPACUnambiguousDNA()) Reverse complement: Seq('ATGAAGGATGTTTAG', IUPACUnambiguousDNA()) The 8 th  annual Bioinformatics Open Source Conference Biopython Project Update @ BOSC 2007, Vienna, Austria
Translating Sequences from Bio import Translate bact_trans=Translate.unambiguous_dna_by_id[11] print 'Forward translation' print bact_trans.translate(my_dna) print 'Reverse complement translation' print bact_trans.translate( my_dna.reverse_complement()) Forward translation Seq('LNILH', HasStopCodon(IUPACProtein(), '*')) Reverse complement translation Seq('MKDV*', HasStopCodon(IUPACProtein(), '*')) The 8 th  annual Bioinformatics Open Source Conference Biopython Project Update @ BOSC 2007, Vienna, Austria
Sequence Input/Output ,[object Object],[object Object],[object Object],[object Object],The 8 th  annual Bioinformatics Open Source Conference Biopython Project Update @ BOSC 2007, Vienna, Austria
SeqIO – Sequence Input from Bio import SeqIO handle = open('ls_orchid.fasta') format = 'fasta' for rec in SeqIO.parse(handle, format) : print "%s, len %i" % (rec.id, len(rec.seq)) print rec.seq[:40].tostring() + "..." handle.close() gi|2765658|emb|Z78533.1|CIZ78533, len 740 CGTAACAAGGTTTCCGTAGGTGAACCTGCGGAAGGATCAT... gi|2765657|emb|Z78532.1|CCZ78532, len 753 CGTAACAAGGTTTCCGTAGGTGAACCTGCGGAAGGATCAT... ... The 8 th  annual Bioinformatics Open Source Conference Biopython Project Update @ BOSC 2007, Vienna, Austria
SeqIO – Sequence Input from Bio import SeqIO handle = open('ls_orchid.gbk') format = 'genbank' for rec in SeqIO.parse(handle, format) : print "%s, len %i" % (rec.id, len(rec.seq)) print rec.seq[:40].tostring() + "..." handle.close() The 8 th  annual Bioinformatics Open Source Conference Biopython Project Update @ BOSC 2007, Vienna, Austria Z78533.1, len 740 CGTAACAAGGTTTCCGTAGGTGAACCTGCGGAAGGATCAT... Z78532.1, len 753 CGTAACAAGGTTTCCGTAGGTGAACCTGCGGAAGGATCAT... ...
SeqIO – Extracting Data from Bio import SeqIO handle = open('ls_orchid.gbk') format = 'genbank' from sets import Set print Set([rec.annotations['organism'] for rec in SeqIO.parse(handle, format)]) handle.close() Set(['Cypripedium acaule', 'Paphiopedilum primulinum', 'Phragmipedium lindenii', 'Paphiopedilum papuanum', 'Paphiopedilum stonei', 'Paphiopedilum urbanianum', 'Paphiopedilum dianthum', ...]) The 8 th  annual Bioinformatics Open Source Conference Biopython Project Update @ BOSC 2007, Vienna, Austria
SeqIO – Filtering Output i_handle = open('ls_orchid.gbk') o_handle = open('small_orchid.faa', 'w') SeqIO.write([rec for rec in SeqIO.parse(i_handle, 'genbank') if len(rec.seq) < 600], o_handle, 'fasta') i_handle.close() o_handle.close() >Z78481.1 P.insigne 5.8S rRNA gene and ITS1 ... CGTAACAAGGTTTCCGTAGGTGAACCTGCGGAAGGATCATTGTT... >Z78480.1 P.gratrixianum 5.8S rRNA gene and ... CGTAACAAGGTTTCCGTAGGTGAACCTGCGGAAGGATCATTGTT... ... The 8 th  annual Bioinformatics Open Source Conference Biopython Project Update @ BOSC 2007, Vienna, Austria
3D Structures ,[object Object],[object Object],[object Object],The 8 th  annual Bioinformatics Open Source Conference Biopython Project Update @ BOSC 2007, Vienna, Austria
Newick Tree Parsing (Bovine:0.69395,(Gibbon:0.36079,(Orang:0.33636,(Gorilla:0.17147,(Chimp:0.19268, Human:0.11927):0.08386):0.06124):0.15057):0.54939,Mouse:1.21460):0.10; from Bio.Nexus.Trees import Tree tree_str = open(&quot;simple.tree&quot;).read() tree_obj = Tree(tree_str) print tree_obj tree a_tree = (Bovine,(Gibbon,(Orang,(Gorilla, (Chimp,Human)))),Mouse); The 8 th  annual Bioinformatics Open Source Conference Biopython Project Update @ BOSC 2007, Vienna, Austria
Newick Tree Parsing #  taxon  prev  succ  brlen  blen (sum) support 0  -  None  [1,2,11]  0.0  0.0  - 1  Bovine  0  []  0.69395  0.69395  - 2  -  0  [3,4]  0.54939  0.54939  - 3  Gibbon  2  []  0.36079  0.91018  - 4  -  2  [5,6]  0.15057  0.69996  - 5  Orang  4  []  0.33636  1.03632  - 6  -  4  [7,8]  0.06124  0.7612  - 7  Gorilla  6  []  0.17147  0.93267  - 8  -  6  [9,10]  0.08386  0.84506  - 9  Chimp  8  []  0.19268  1.03774  - 10  Human  8  []  0.11927  0.96433  - 11  Mouse  0  []  1.2146  1.2146  - Root: 0 tree_obj.display() The 8 th  annual Bioinformatics Open Source Conference Biopython Project Update @ BOSC 2007, Vienna, Austria
3D Structures ,[object Object],[object Object],The 8 th  annual Bioinformatics Open Source Conference Biopython Project Update @ BOSC 2007, Vienna, Austria
Working with 3D Structures http://www.warwick.ac.uk/go/peter_cock/ python/protein_superposition/ This example (online) uses Bio.PDB to align 21 alternative X-Ray crystal structures for PDB structure 1JOY. Before:  After: The 8 th  annual Bioinformatics Open Source Conference Biopython Project Update @ BOSC 2007, Vienna, Austria
Population Genetics  (planned) ,[object Object],[object Object],[object Object],The 8 th  annual Bioinformatics Open Source Conference Biopython Project Update @ BOSC 2007, Vienna, Austria
Areas for Improvement ,[object Object],[object Object],[object Object],[object Object],[object Object],[object Object],[object Object],[object Object],The 8 th  annual Bioinformatics Open Source Conference Biopython Project Update @ BOSC 2007, Vienna, Austria
How can you Contribute? ,[object Object],[object Object],[object Object],[object Object],[object Object],[object Object],[object Object],[object Object],[object Object],The 8 th  annual Bioinformatics Open Source Conference Biopython Project Update @ BOSC 2007, Vienna, Austria
Biopython Acknowledgements ,[object Object],[object Object],[object Object],The 8 th  annual Bioinformatics Open Source Conference Biopython Project Update @ BOSC 2007, Vienna, Austria
Personal Acknowledgements ,[object Object],[object Object],[object Object],[object Object],The 8 th  annual Bioinformatics Open Source Conference Biopython Project Update @ BOSC 2007, Vienna, Austria
Questions? The 8 th  annual Bioinformatics Open Source Conference Biopython Project Update @ BOSC 2007, Vienna, Austria

More Related Content

What's hot (20)

Clustal W - Multiple Sequence alignment
Clustal W - Multiple Sequence alignment   Clustal W - Multiple Sequence alignment
Clustal W - Multiple Sequence alignment
 
Finding ORF
Finding ORFFinding ORF
Finding ORF
 
Sequence file formats
Sequence file formatsSequence file formats
Sequence file formats
 
Est database
Est databaseEst database
Est database
 
Maximum parsimony
Maximum parsimonyMaximum parsimony
Maximum parsimony
 
Introduction to Bioinformatics
Introduction to BioinformaticsIntroduction to Bioinformatics
Introduction to Bioinformatics
 
Microarray Data Analysis
Microarray Data AnalysisMicroarray Data Analysis
Microarray Data Analysis
 
A Brief Overview of Cheminformatics
A Brief Overview of CheminformaticsA Brief Overview of Cheminformatics
A Brief Overview of Cheminformatics
 
sequence alignment
sequence alignmentsequence alignment
sequence alignment
 
Bioinformatics
BioinformaticsBioinformatics
Bioinformatics
 
Biological networks - building and visualizing
Biological networks - building and visualizingBiological networks - building and visualizing
Biological networks - building and visualizing
 
Overview of Next Gen Sequencing Data Analysis
Overview of Next Gen Sequencing Data AnalysisOverview of Next Gen Sequencing Data Analysis
Overview of Next Gen Sequencing Data Analysis
 
Introduction to Perl and BioPerl
Introduction to Perl and BioPerlIntroduction to Perl and BioPerl
Introduction to Perl and BioPerl
 
Orthologs,Paralogs & Xenologs
 Orthologs,Paralogs & Xenologs  Orthologs,Paralogs & Xenologs
Orthologs,Paralogs & Xenologs
 
BITS: Basics of sequence analysis
BITS: Basics of sequence analysisBITS: Basics of sequence analysis
BITS: Basics of sequence analysis
 
NCBI
NCBINCBI
NCBI
 
Biological networks
Biological networksBiological networks
Biological networks
 
Protein modeling
Protein modelingProtein modeling
Protein modeling
 
Blast and fasta
Blast and fastaBlast and fasta
Blast and fasta
 
MULTIPLE SEQUENCE ALIGNMENT
MULTIPLE  SEQUENCE  ALIGNMENTMULTIPLE  SEQUENCE  ALIGNMENT
MULTIPLE SEQUENCE ALIGNMENT
 

Similar to Biopython

BOSC 2008 Biopython
BOSC 2008 BiopythonBOSC 2008 Biopython
BOSC 2008 Biopythontiago
 
Antao Biopython Bosc2008
Antao Biopython Bosc2008Antao Biopython Bosc2008
Antao Biopython Bosc2008bosc_2008
 
Cock Biopython Bosc2009
Cock Biopython Bosc2009Cock Biopython Bosc2009
Cock Biopython Bosc2009bosc
 
The ProteomeXchange Consoritum: 2017 update
The ProteomeXchange Consoritum: 2017 updateThe ProteomeXchange Consoritum: 2017 update
The ProteomeXchange Consoritum: 2017 updateJuan Antonio Vizcaino
 
Accessing and scripting CDK from Bioclipse
Accessing and scripting CDK from BioclipseAccessing and scripting CDK from Bioclipse
Accessing and scripting CDK from BioclipseOla Spjuth
 
Java Introductie
Java IntroductieJava Introductie
Java Introductiembruggen
 
Biopython Project Update 2013
Biopython Project Update 2013Biopython Project Update 2013
Biopython Project Update 2013pjacock
 
Prins Bio Lib Bosc 2009
Prins Bio Lib Bosc 2009Prins Bio Lib Bosc 2009
Prins Bio Lib Bosc 2009bosc
 
ICAR 2015 Workshop - Nick Provart
ICAR 2015 Workshop - Nick ProvartICAR 2015 Workshop - Nick Provart
ICAR 2015 Workshop - Nick ProvartAraport
 
Histolab: an Open Source Python Library for Reproducible Digital Pathology
Histolab: an Open Source Python Library for Reproducible Digital PathologyHistolab: an Open Source Python Library for Reproducible Digital Pathology
Histolab: an Open Source Python Library for Reproducible Digital PathologyAlessia Marcolini
 
2016 bioinformatics i_bio_python_wimvancriekinge
2016 bioinformatics i_bio_python_wimvancriekinge2016 bioinformatics i_bio_python_wimvancriekinge
2016 bioinformatics i_bio_python_wimvancriekingeProf. Wim Van Criekinge
 
InterPro and InterProScan 5.0
InterPro and InterProScan 5.0InterPro and InterProScan 5.0
InterPro and InterProScan 5.0EBI
 
Online direct import of specimen records from iDigBio infrastructure into tax...
Online direct import of specimen records from iDigBio infrastructure into tax...Online direct import of specimen records from iDigBio infrastructure into tax...
Online direct import of specimen records from iDigBio infrastructure into tax...Viktor Senderov
 
Experiences in the biosciences with the open biological ontologies foundry an...
Experiences in the biosciences with the open biological ontologies foundry an...Experiences in the biosciences with the open biological ontologies foundry an...
Experiences in the biosciences with the open biological ontologies foundry an...Chris Mungall
 

Similar to Biopython (20)

BOSC 2008 Biopython
BOSC 2008 BiopythonBOSC 2008 Biopython
BOSC 2008 Biopython
 
Antao Biopython Bosc2008
Antao Biopython Bosc2008Antao Biopython Bosc2008
Antao Biopython Bosc2008
 
Cock Biopython Bosc2009
Cock Biopython Bosc2009Cock Biopython Bosc2009
Cock Biopython Bosc2009
 
Talk6 biopython bosc2011
Talk6 biopython bosc2011Talk6 biopython bosc2011
Talk6 biopython bosc2011
 
The ProteomeXchange Consoritum: 2017 update
The ProteomeXchange Consoritum: 2017 updateThe ProteomeXchange Consoritum: 2017 update
The ProteomeXchange Consoritum: 2017 update
 
Accessing and scripting CDK from Bioclipse
Accessing and scripting CDK from BioclipseAccessing and scripting CDK from Bioclipse
Accessing and scripting CDK from Bioclipse
 
Java Introductie
Java IntroductieJava Introductie
Java Introductie
 
Biopython Project Update 2013
Biopython Project Update 2013Biopython Project Update 2013
Biopython Project Update 2013
 
Prins Bio Lib Bosc 2009
Prins Bio Lib Bosc 2009Prins Bio Lib Bosc 2009
Prins Bio Lib Bosc 2009
 
ICAR 2015 Workshop - Nick Provart
ICAR 2015 Workshop - Nick ProvartICAR 2015 Workshop - Nick Provart
ICAR 2015 Workshop - Nick Provart
 
ProteomeXchange update HUPO 2016
ProteomeXchange update HUPO 2016ProteomeXchange update HUPO 2016
ProteomeXchange update HUPO 2016
 
Histolab: an Open Source Python Library for Reproducible Digital Pathology
Histolab: an Open Source Python Library for Reproducible Digital PathologyHistolab: an Open Source Python Library for Reproducible Digital Pathology
Histolab: an Open Source Python Library for Reproducible Digital Pathology
 
2015 bioinformatics bio_python
2015 bioinformatics bio_python2015 bioinformatics bio_python
2015 bioinformatics bio_python
 
2016 bioinformatics i_bio_python_wimvancriekinge
2016 bioinformatics i_bio_python_wimvancriekinge2016 bioinformatics i_bio_python_wimvancriekinge
2016 bioinformatics i_bio_python_wimvancriekinge
 
Bioclipse
BioclipseBioclipse
Bioclipse
 
ISMB Workshop 2014
ISMB Workshop 2014ISMB Workshop 2014
ISMB Workshop 2014
 
InterPro and InterProScan 5.0
InterPro and InterProScan 5.0InterPro and InterProScan 5.0
InterPro and InterProScan 5.0
 
Online direct import of specimen records from iDigBio infrastructure into tax...
Online direct import of specimen records from iDigBio infrastructure into tax...Online direct import of specimen records from iDigBio infrastructure into tax...
Online direct import of specimen records from iDigBio infrastructure into tax...
 
Experiences in the biosciences with the open biological ontologies foundry an...
Experiences in the biosciences with the open biological ontologies foundry an...Experiences in the biosciences with the open biological ontologies foundry an...
Experiences in the biosciences with the open biological ontologies foundry an...
 
iGEM Public Debrecen2010
iGEM Public Debrecen2010iGEM Public Debrecen2010
iGEM Public Debrecen2010
 

More from bosc

Swertz Molgenis Bosc2009
Swertz Molgenis Bosc2009Swertz Molgenis Bosc2009
Swertz Molgenis Bosc2009bosc
 
Bosc Intro 20090627
Bosc Intro 20090627Bosc Intro 20090627
Bosc Intro 20090627bosc
 
Software Patterns Panel Bosc2009
Software Patterns Panel Bosc2009Software Patterns Panel Bosc2009
Software Patterns Panel Bosc2009bosc
 
Schbath Rmes Bosc2009
Schbath Rmes Bosc2009Schbath Rmes Bosc2009
Schbath Rmes Bosc2009bosc
 
Kallio Chipster Bosc2009
Kallio Chipster Bosc2009Kallio Chipster Bosc2009
Kallio Chipster Bosc2009bosc
 
Welch Wordifier Bosc2009
Welch Wordifier Bosc2009Welch Wordifier Bosc2009
Welch Wordifier Bosc2009bosc
 
Rice Emboss Bosc2009
Rice Emboss Bosc2009Rice Emboss Bosc2009
Rice Emboss Bosc2009bosc
 
Prlic Bio Java Bosc2009
Prlic Bio Java Bosc2009Prlic Bio Java Bosc2009
Prlic Bio Java Bosc2009bosc
 
Senger Soaplab Bosc2009
Senger Soaplab Bosc2009Senger Soaplab Bosc2009
Senger Soaplab Bosc2009bosc
 
Hanmer Software Patterns Bosc2009
Hanmer Software Patterns Bosc2009Hanmer Software Patterns Bosc2009
Hanmer Software Patterns Bosc2009bosc
 
Snell Psoda Bosc2009
Snell Psoda Bosc2009Snell Psoda Bosc2009
Snell Psoda Bosc2009bosc
 
Procter Vamsas Bosc2009
Procter Vamsas Bosc2009Procter Vamsas Bosc2009
Procter Vamsas Bosc2009bosc
 
Drablos Composite Motifs Bosc2009
Drablos Composite Motifs Bosc2009Drablos Composite Motifs Bosc2009
Drablos Composite Motifs Bosc2009bosc
 
Fauteux Seeder Bosc2009
Fauteux Seeder Bosc2009Fauteux Seeder Bosc2009
Fauteux Seeder Bosc2009bosc
 
Moeller Debian Bosc2009
Moeller Debian Bosc2009Moeller Debian Bosc2009
Moeller Debian Bosc2009bosc
 
Wilczynski_BNFinder_BOSC2009
Wilczynski_BNFinder_BOSC2009Wilczynski_BNFinder_BOSC2009
Wilczynski_BNFinder_BOSC2009bosc
 
Welsh_BioHDF_BOSC2009
Welsh_BioHDF_BOSC2009Welsh_BioHDF_BOSC2009
Welsh_BioHDF_BOSC2009bosc
 
Varre_Biomanycores_BOSC2009
Varre_Biomanycores_BOSC2009Varre_Biomanycores_BOSC2009
Varre_Biomanycores_BOSC2009bosc
 
Trelles_QnormBOSC2009
Trelles_QnormBOSC2009Trelles_QnormBOSC2009
Trelles_QnormBOSC2009bosc
 
Rother_ModeRNA_BOSC2009
Rother_ModeRNA_BOSC2009Rother_ModeRNA_BOSC2009
Rother_ModeRNA_BOSC2009bosc
 

More from bosc (20)

Swertz Molgenis Bosc2009
Swertz Molgenis Bosc2009Swertz Molgenis Bosc2009
Swertz Molgenis Bosc2009
 
Bosc Intro 20090627
Bosc Intro 20090627Bosc Intro 20090627
Bosc Intro 20090627
 
Software Patterns Panel Bosc2009
Software Patterns Panel Bosc2009Software Patterns Panel Bosc2009
Software Patterns Panel Bosc2009
 
Schbath Rmes Bosc2009
Schbath Rmes Bosc2009Schbath Rmes Bosc2009
Schbath Rmes Bosc2009
 
Kallio Chipster Bosc2009
Kallio Chipster Bosc2009Kallio Chipster Bosc2009
Kallio Chipster Bosc2009
 
Welch Wordifier Bosc2009
Welch Wordifier Bosc2009Welch Wordifier Bosc2009
Welch Wordifier Bosc2009
 
Rice Emboss Bosc2009
Rice Emboss Bosc2009Rice Emboss Bosc2009
Rice Emboss Bosc2009
 
Prlic Bio Java Bosc2009
Prlic Bio Java Bosc2009Prlic Bio Java Bosc2009
Prlic Bio Java Bosc2009
 
Senger Soaplab Bosc2009
Senger Soaplab Bosc2009Senger Soaplab Bosc2009
Senger Soaplab Bosc2009
 
Hanmer Software Patterns Bosc2009
Hanmer Software Patterns Bosc2009Hanmer Software Patterns Bosc2009
Hanmer Software Patterns Bosc2009
 
Snell Psoda Bosc2009
Snell Psoda Bosc2009Snell Psoda Bosc2009
Snell Psoda Bosc2009
 
Procter Vamsas Bosc2009
Procter Vamsas Bosc2009Procter Vamsas Bosc2009
Procter Vamsas Bosc2009
 
Drablos Composite Motifs Bosc2009
Drablos Composite Motifs Bosc2009Drablos Composite Motifs Bosc2009
Drablos Composite Motifs Bosc2009
 
Fauteux Seeder Bosc2009
Fauteux Seeder Bosc2009Fauteux Seeder Bosc2009
Fauteux Seeder Bosc2009
 
Moeller Debian Bosc2009
Moeller Debian Bosc2009Moeller Debian Bosc2009
Moeller Debian Bosc2009
 
Wilczynski_BNFinder_BOSC2009
Wilczynski_BNFinder_BOSC2009Wilczynski_BNFinder_BOSC2009
Wilczynski_BNFinder_BOSC2009
 
Welsh_BioHDF_BOSC2009
Welsh_BioHDF_BOSC2009Welsh_BioHDF_BOSC2009
Welsh_BioHDF_BOSC2009
 
Varre_Biomanycores_BOSC2009
Varre_Biomanycores_BOSC2009Varre_Biomanycores_BOSC2009
Varre_Biomanycores_BOSC2009
 
Trelles_QnormBOSC2009
Trelles_QnormBOSC2009Trelles_QnormBOSC2009
Trelles_QnormBOSC2009
 
Rother_ModeRNA_BOSC2009
Rother_ModeRNA_BOSC2009Rother_ModeRNA_BOSC2009
Rother_ModeRNA_BOSC2009
 

Recently uploaded

The Codex of Business Writing Software for Real-World Solutions 2.pptx
The Codex of Business Writing Software for Real-World Solutions 2.pptxThe Codex of Business Writing Software for Real-World Solutions 2.pptx
The Codex of Business Writing Software for Real-World Solutions 2.pptxMalak Abu Hammad
 
How to Remove Document Management Hurdles with X-Docs?
How to Remove Document Management Hurdles with X-Docs?How to Remove Document Management Hurdles with X-Docs?
How to Remove Document Management Hurdles with X-Docs?XfilesPro
 
Key Features Of Token Development (1).pptx
Key  Features Of Token  Development (1).pptxKey  Features Of Token  Development (1).pptx
Key Features Of Token Development (1).pptxLBM Solutions
 
WhatsApp 9892124323 ✓Call Girls In Kalyan ( Mumbai ) secure service
WhatsApp 9892124323 ✓Call Girls In Kalyan ( Mumbai ) secure serviceWhatsApp 9892124323 ✓Call Girls In Kalyan ( Mumbai ) secure service
WhatsApp 9892124323 ✓Call Girls In Kalyan ( Mumbai ) secure servicePooja Nehwal
 
SQL Database Design For Developers at php[tek] 2024
SQL Database Design For Developers at php[tek] 2024SQL Database Design For Developers at php[tek] 2024
SQL Database Design For Developers at php[tek] 2024Scott Keck-Warren
 
08448380779 Call Girls In Friends Colony Women Seeking Men
08448380779 Call Girls In Friends Colony Women Seeking Men08448380779 Call Girls In Friends Colony Women Seeking Men
08448380779 Call Girls In Friends Colony Women Seeking MenDelhi Call girls
 
Hyderabad Call Girls Khairatabad ✨ 7001305949 ✨ Cheap Price Your Budget
Hyderabad Call Girls Khairatabad ✨ 7001305949 ✨ Cheap Price Your BudgetHyderabad Call Girls Khairatabad ✨ 7001305949 ✨ Cheap Price Your Budget
Hyderabad Call Girls Khairatabad ✨ 7001305949 ✨ Cheap Price Your BudgetEnjoy Anytime
 
08448380779 Call Girls In Civil Lines Women Seeking Men
08448380779 Call Girls In Civil Lines Women Seeking Men08448380779 Call Girls In Civil Lines Women Seeking Men
08448380779 Call Girls In Civil Lines Women Seeking MenDelhi Call girls
 
Automating Business Process via MuleSoft Composer | Bangalore MuleSoft Meetup...
Automating Business Process via MuleSoft Composer | Bangalore MuleSoft Meetup...Automating Business Process via MuleSoft Composer | Bangalore MuleSoft Meetup...
Automating Business Process via MuleSoft Composer | Bangalore MuleSoft Meetup...shyamraj55
 
Kotlin Multiplatform & Compose Multiplatform - Starter kit for pragmatics
Kotlin Multiplatform & Compose Multiplatform - Starter kit for pragmaticsKotlin Multiplatform & Compose Multiplatform - Starter kit for pragmatics
Kotlin Multiplatform & Compose Multiplatform - Starter kit for pragmaticscarlostorres15106
 
How to convert PDF to text with Nanonets
How to convert PDF to text with NanonetsHow to convert PDF to text with Nanonets
How to convert PDF to text with Nanonetsnaman860154
 
Next-generation AAM aircraft unveiled by Supernal, S-A2
Next-generation AAM aircraft unveiled by Supernal, S-A2Next-generation AAM aircraft unveiled by Supernal, S-A2
Next-generation AAM aircraft unveiled by Supernal, S-A2Hyundai Motor Group
 
Understanding the Laravel MVC Architecture
Understanding the Laravel MVC ArchitectureUnderstanding the Laravel MVC Architecture
Understanding the Laravel MVC ArchitecturePixlogix Infotech
 
GenCyber Cyber Security Day Presentation
GenCyber Cyber Security Day PresentationGenCyber Cyber Security Day Presentation
GenCyber Cyber Security Day PresentationMichael W. Hawkins
 
Breaking the Kubernetes Kill Chain: Host Path Mount
Breaking the Kubernetes Kill Chain: Host Path MountBreaking the Kubernetes Kill Chain: Host Path Mount
Breaking the Kubernetes Kill Chain: Host Path MountPuma Security, LLC
 
Benefits Of Flutter Compared To Other Frameworks
Benefits Of Flutter Compared To Other FrameworksBenefits Of Flutter Compared To Other Frameworks
Benefits Of Flutter Compared To Other FrameworksSoftradix Technologies
 
08448380779 Call Girls In Diplomatic Enclave Women Seeking Men
08448380779 Call Girls In Diplomatic Enclave Women Seeking Men08448380779 Call Girls In Diplomatic Enclave Women Seeking Men
08448380779 Call Girls In Diplomatic Enclave Women Seeking MenDelhi Call girls
 
Neo4j - How KGs are shaping the future of Generative AI at AWS Summit London ...
Neo4j - How KGs are shaping the future of Generative AI at AWS Summit London ...Neo4j - How KGs are shaping the future of Generative AI at AWS Summit London ...
Neo4j - How KGs are shaping the future of Generative AI at AWS Summit London ...Neo4j
 
Transcript: #StandardsGoals for 2024: What’s new for BISAC - Tech Forum 2024
Transcript: #StandardsGoals for 2024: What’s new for BISAC - Tech Forum 2024Transcript: #StandardsGoals for 2024: What’s new for BISAC - Tech Forum 2024
Transcript: #StandardsGoals for 2024: What’s new for BISAC - Tech Forum 2024BookNet Canada
 

Recently uploaded (20)

The Codex of Business Writing Software for Real-World Solutions 2.pptx
The Codex of Business Writing Software for Real-World Solutions 2.pptxThe Codex of Business Writing Software for Real-World Solutions 2.pptx
The Codex of Business Writing Software for Real-World Solutions 2.pptx
 
How to Remove Document Management Hurdles with X-Docs?
How to Remove Document Management Hurdles with X-Docs?How to Remove Document Management Hurdles with X-Docs?
How to Remove Document Management Hurdles with X-Docs?
 
Key Features Of Token Development (1).pptx
Key  Features Of Token  Development (1).pptxKey  Features Of Token  Development (1).pptx
Key Features Of Token Development (1).pptx
 
WhatsApp 9892124323 ✓Call Girls In Kalyan ( Mumbai ) secure service
WhatsApp 9892124323 ✓Call Girls In Kalyan ( Mumbai ) secure serviceWhatsApp 9892124323 ✓Call Girls In Kalyan ( Mumbai ) secure service
WhatsApp 9892124323 ✓Call Girls In Kalyan ( Mumbai ) secure service
 
SQL Database Design For Developers at php[tek] 2024
SQL Database Design For Developers at php[tek] 2024SQL Database Design For Developers at php[tek] 2024
SQL Database Design For Developers at php[tek] 2024
 
08448380779 Call Girls In Friends Colony Women Seeking Men
08448380779 Call Girls In Friends Colony Women Seeking Men08448380779 Call Girls In Friends Colony Women Seeking Men
08448380779 Call Girls In Friends Colony Women Seeking Men
 
Hyderabad Call Girls Khairatabad ✨ 7001305949 ✨ Cheap Price Your Budget
Hyderabad Call Girls Khairatabad ✨ 7001305949 ✨ Cheap Price Your BudgetHyderabad Call Girls Khairatabad ✨ 7001305949 ✨ Cheap Price Your Budget
Hyderabad Call Girls Khairatabad ✨ 7001305949 ✨ Cheap Price Your Budget
 
08448380779 Call Girls In Civil Lines Women Seeking Men
08448380779 Call Girls In Civil Lines Women Seeking Men08448380779 Call Girls In Civil Lines Women Seeking Men
08448380779 Call Girls In Civil Lines Women Seeking Men
 
Automating Business Process via MuleSoft Composer | Bangalore MuleSoft Meetup...
Automating Business Process via MuleSoft Composer | Bangalore MuleSoft Meetup...Automating Business Process via MuleSoft Composer | Bangalore MuleSoft Meetup...
Automating Business Process via MuleSoft Composer | Bangalore MuleSoft Meetup...
 
Kotlin Multiplatform & Compose Multiplatform - Starter kit for pragmatics
Kotlin Multiplatform & Compose Multiplatform - Starter kit for pragmaticsKotlin Multiplatform & Compose Multiplatform - Starter kit for pragmatics
Kotlin Multiplatform & Compose Multiplatform - Starter kit for pragmatics
 
How to convert PDF to text with Nanonets
How to convert PDF to text with NanonetsHow to convert PDF to text with Nanonets
How to convert PDF to text with Nanonets
 
Next-generation AAM aircraft unveiled by Supernal, S-A2
Next-generation AAM aircraft unveiled by Supernal, S-A2Next-generation AAM aircraft unveiled by Supernal, S-A2
Next-generation AAM aircraft unveiled by Supernal, S-A2
 
Understanding the Laravel MVC Architecture
Understanding the Laravel MVC ArchitectureUnderstanding the Laravel MVC Architecture
Understanding the Laravel MVC Architecture
 
GenCyber Cyber Security Day Presentation
GenCyber Cyber Security Day PresentationGenCyber Cyber Security Day Presentation
GenCyber Cyber Security Day Presentation
 
Breaking the Kubernetes Kill Chain: Host Path Mount
Breaking the Kubernetes Kill Chain: Host Path MountBreaking the Kubernetes Kill Chain: Host Path Mount
Breaking the Kubernetes Kill Chain: Host Path Mount
 
Benefits Of Flutter Compared To Other Frameworks
Benefits Of Flutter Compared To Other FrameworksBenefits Of Flutter Compared To Other Frameworks
Benefits Of Flutter Compared To Other Frameworks
 
08448380779 Call Girls In Diplomatic Enclave Women Seeking Men
08448380779 Call Girls In Diplomatic Enclave Women Seeking Men08448380779 Call Girls In Diplomatic Enclave Women Seeking Men
08448380779 Call Girls In Diplomatic Enclave Women Seeking Men
 
Neo4j - How KGs are shaping the future of Generative AI at AWS Summit London ...
Neo4j - How KGs are shaping the future of Generative AI at AWS Summit London ...Neo4j - How KGs are shaping the future of Generative AI at AWS Summit London ...
Neo4j - How KGs are shaping the future of Generative AI at AWS Summit London ...
 
The transition to renewables in India.pdf
The transition to renewables in India.pdfThe transition to renewables in India.pdf
The transition to renewables in India.pdf
 
Transcript: #StandardsGoals for 2024: What’s new for BISAC - Tech Forum 2024
Transcript: #StandardsGoals for 2024: What’s new for BISAC - Tech Forum 2024Transcript: #StandardsGoals for 2024: What’s new for BISAC - Tech Forum 2024
Transcript: #StandardsGoals for 2024: What’s new for BISAC - Tech Forum 2024
 

Biopython

  • 1. The 8th annual Bioinformatics Open Source Conference (BOSC 2007) 18 th July, Vienna, Austria Biopython Project Update Peter Cock, MOAC Doctoral Training Centre, University of Warwick, UK
  • 2.
  • 3.
  • 4.
  • 5.
  • 6.
  • 7.
  • 8.
  • 9.
  • 10. Manipulating Sequences from Bio.Seq import Seq from Bio.Alphabet.IUPAC import unambiguous_dna my_dna=Seq('CTAAACATCCTTCAT', unambiguous_dna) print 'Original:' print my_dna print 'Reverse complement:' print my_dna.reverse_complement() Original: Seq('CTAAACATCCTTCAT', IUPACUnambiguousDNA()) Reverse complement: Seq('ATGAAGGATGTTTAG', IUPACUnambiguousDNA()) The 8 th annual Bioinformatics Open Source Conference Biopython Project Update @ BOSC 2007, Vienna, Austria
  • 11. Translating Sequences from Bio import Translate bact_trans=Translate.unambiguous_dna_by_id[11] print 'Forward translation' print bact_trans.translate(my_dna) print 'Reverse complement translation' print bact_trans.translate( my_dna.reverse_complement()) Forward translation Seq('LNILH', HasStopCodon(IUPACProtein(), '*')) Reverse complement translation Seq('MKDV*', HasStopCodon(IUPACProtein(), '*')) The 8 th annual Bioinformatics Open Source Conference Biopython Project Update @ BOSC 2007, Vienna, Austria
  • 12.
  • 13. SeqIO – Sequence Input from Bio import SeqIO handle = open('ls_orchid.fasta') format = 'fasta' for rec in SeqIO.parse(handle, format) : print &quot;%s, len %i&quot; % (rec.id, len(rec.seq)) print rec.seq[:40].tostring() + &quot;...&quot; handle.close() gi|2765658|emb|Z78533.1|CIZ78533, len 740 CGTAACAAGGTTTCCGTAGGTGAACCTGCGGAAGGATCAT... gi|2765657|emb|Z78532.1|CCZ78532, len 753 CGTAACAAGGTTTCCGTAGGTGAACCTGCGGAAGGATCAT... ... The 8 th annual Bioinformatics Open Source Conference Biopython Project Update @ BOSC 2007, Vienna, Austria
  • 14. SeqIO – Sequence Input from Bio import SeqIO handle = open('ls_orchid.gbk') format = 'genbank' for rec in SeqIO.parse(handle, format) : print &quot;%s, len %i&quot; % (rec.id, len(rec.seq)) print rec.seq[:40].tostring() + &quot;...&quot; handle.close() The 8 th annual Bioinformatics Open Source Conference Biopython Project Update @ BOSC 2007, Vienna, Austria Z78533.1, len 740 CGTAACAAGGTTTCCGTAGGTGAACCTGCGGAAGGATCAT... Z78532.1, len 753 CGTAACAAGGTTTCCGTAGGTGAACCTGCGGAAGGATCAT... ...
  • 15. SeqIO – Extracting Data from Bio import SeqIO handle = open('ls_orchid.gbk') format = 'genbank' from sets import Set print Set([rec.annotations['organism'] for rec in SeqIO.parse(handle, format)]) handle.close() Set(['Cypripedium acaule', 'Paphiopedilum primulinum', 'Phragmipedium lindenii', 'Paphiopedilum papuanum', 'Paphiopedilum stonei', 'Paphiopedilum urbanianum', 'Paphiopedilum dianthum', ...]) The 8 th annual Bioinformatics Open Source Conference Biopython Project Update @ BOSC 2007, Vienna, Austria
  • 16. SeqIO – Filtering Output i_handle = open('ls_orchid.gbk') o_handle = open('small_orchid.faa', 'w') SeqIO.write([rec for rec in SeqIO.parse(i_handle, 'genbank') if len(rec.seq) < 600], o_handle, 'fasta') i_handle.close() o_handle.close() >Z78481.1 P.insigne 5.8S rRNA gene and ITS1 ... CGTAACAAGGTTTCCGTAGGTGAACCTGCGGAAGGATCATTGTT... >Z78480.1 P.gratrixianum 5.8S rRNA gene and ... CGTAACAAGGTTTCCGTAGGTGAACCTGCGGAAGGATCATTGTT... ... The 8 th annual Bioinformatics Open Source Conference Biopython Project Update @ BOSC 2007, Vienna, Austria
  • 17.
  • 18. Newick Tree Parsing (Bovine:0.69395,(Gibbon:0.36079,(Orang:0.33636,(Gorilla:0.17147,(Chimp:0.19268, Human:0.11927):0.08386):0.06124):0.15057):0.54939,Mouse:1.21460):0.10; from Bio.Nexus.Trees import Tree tree_str = open(&quot;simple.tree&quot;).read() tree_obj = Tree(tree_str) print tree_obj tree a_tree = (Bovine,(Gibbon,(Orang,(Gorilla, (Chimp,Human)))),Mouse); The 8 th annual Bioinformatics Open Source Conference Biopython Project Update @ BOSC 2007, Vienna, Austria
  • 19. Newick Tree Parsing # taxon prev succ brlen blen (sum) support 0 - None [1,2,11] 0.0 0.0 - 1 Bovine 0 [] 0.69395 0.69395 - 2 - 0 [3,4] 0.54939 0.54939 - 3 Gibbon 2 [] 0.36079 0.91018 - 4 - 2 [5,6] 0.15057 0.69996 - 5 Orang 4 [] 0.33636 1.03632 - 6 - 4 [7,8] 0.06124 0.7612 - 7 Gorilla 6 [] 0.17147 0.93267 - 8 - 6 [9,10] 0.08386 0.84506 - 9 Chimp 8 [] 0.19268 1.03774 - 10 Human 8 [] 0.11927 0.96433 - 11 Mouse 0 [] 1.2146 1.2146 - Root: 0 tree_obj.display() The 8 th annual Bioinformatics Open Source Conference Biopython Project Update @ BOSC 2007, Vienna, Austria
  • 20.
  • 21. Working with 3D Structures http://www.warwick.ac.uk/go/peter_cock/ python/protein_superposition/ This example (online) uses Bio.PDB to align 21 alternative X-Ray crystal structures for PDB structure 1JOY. Before: After: The 8 th annual Bioinformatics Open Source Conference Biopython Project Update @ BOSC 2007, Vienna, Austria
  • 22.
  • 23.
  • 24.
  • 25.
  • 26.
  • 27. Questions? The 8 th annual Bioinformatics Open Source Conference Biopython Project Update @ BOSC 2007, Vienna, Austria