SlideShare une entreprise Scribd logo
1  sur  21
Télécharger pour lire hors ligne
Project Update
Bioinformatics Open Source Conference (BOSC)
                 July 14, 2012
         Long Beach, California, USA

          Eric Talevich, Peter Cock,
       Brad Chapman, João Rodrigues,
          and Biopython contributors
Hello, BOSC
Biopython is a freely available Python library for biological
computation, and a long-running, distributed collaboration
to produce and maintain it [1].
 ● Supported by the Open Bioinformatics Foundation
    (OBF)
 ● "This is Python's Bio* library. There are several Bio*
    libraries like it, but this one is ours."
 ● http://biopython.org/
_____
[1] Cock, P.J.A., Antao, T., Chang, J.T., Chapman, B.A., Cox, C.J., Dalke, A.,
Friedberg, I., Hamelryck, T., Kauff, F., Wilczynski, B., de Hoon, M.J. (2009)
Biopython: freely available Python tools for computational molecular biology
and bioinformatics. Bioinformatics 25(11) 1422-3. doi:10.1093
/bioinformatics/btp163
Bio.Graphics (Biopython 1.59, February 2012)
New features in...
BasicChromosome:
 ● Draw simple sub-features on chromosome segments
 ● Show the position of genes, SNPs or other loci

GenomeDiagram [2]:
 ● Cross-links between tracks
 ● Track-specific start/end positions for showing regions

_____
[2] Pritchard, L., White, J.A., Birch, P.R., Toth, I. (2010) GenomeDiagram: a
python package for the visualization of large-scale genomic data.
Bioinformatics 2(5) 616-7.
doi:10.1093/bioinformatics/btk021
BasicChromosome: Potato NB-LRRs




Jupe et al. (2012) BMC Genomics
GenomeDiagram:
     A tale of three phages




Swanson et al. (2012) PLoS One (to appear)
GenomeDiagram imitates
Artemis Comparison Tool (ACT)
SeqIO and AlignIO
(Biopython 1.58, August 2011)

● SeqXML format [3]

● Read support for ABI chromatogram files (Wibowo A.)

● "phylip-relaxed" format (Connor McCoy, Brandon I.)
     ○ Relaxes the 10-character limit on taxon names
     ○ Space-delimited instead
     ○ Used in RAxML, PhyML, PAML, etc.

_____
[3] Schmitt et al. (2011) SeqXML and OrthoXML: standards for sequence and
orthology information. Briefings in Bioinformatics 12(5): 485-488. doi:10.1093
/bib/bbr025
Bio.Phylo & pypaml

● PAML interop: wrappers, I/O, glue
  ○ Merged Brandon Invergo’s pypaml as
    Bio.Phylo.PAML (Biopython 1.58, August 2011)

● Phylo.draw improvements

● RAxML wrapper (Biopython 1.60, June 2012)

● Paper in review [4]

_____
[4] Talevich, E., Invergo, B.M., Cock, P.J.A., Chapman, B.A. (2012) Bio.Phylo:
a unified toolkit for processing, analysis and visualization of phylogenetic data
in Biopython. BMC Bioinformatics 13:209. doi:10.1186/1471-2105-13-209
Phylo.draw and matplotlib
Bio.bgzf (Blocked GNU Zip Format)
● BGZF is a GZIP variant that compresses
  blocks of a fixed, known size
● Used in Next Generation Sequencing for
  efficient random access to compressed files
  ○ SAM + BGZF = BAM


Bio.SeqIO can now index BGZF compressed
sequence files. (Biopython 1.60, June 2012)
TogoWS
(Biopython 1.59, February 2012)

● TogoWS is an integrated web resource for
    bioinformatics databases and services
●   Provided by the Database Center for Life Science in
    Japan
●   Usage is similar to NCBI Entrez

_____
http://togows.dbcls.jp/
PyPy and Python 3
Biopython:
● works well on PyPy 1.9
    (excluding NumPy & C extensions)
●   works on Python 3 (excluding some C
    extensions), but concerns remain about
    performance in default unicode mode.
    ○ Currently 'beta' level support.
Bio.PDB
● mmCIF parser restored (Biopython 1.60, June 2012)
  ○ Lenna Peterson fixed a 4-year-old lex/yacc-related
    compilation issue
  ○ That was awesome
  ○ Now she's a GSoC student
  ○ Py3/PyPy/Jython compatibility in progress

● Merging GSoC results incrementally
  ○ Atom element names & weights (João Rodrigues,
    GSoC 2010)
  ○ Lots of feature branches remaining...
Bio.PDB feature branches

                                                 PDBParser


                                          Bio.Struct
               Mocapy++
 Generic
 Features     InterfaceAnalysis   mmCIF Parser


            GSOC



  '10              '11              '12                 ...
Google Summer of Code (GSoC)
In 2011, Biopython had three projects funded via the OBF:
●   Mikael Trellet (Bio.PDB)
●   Michele Silva (Bio.PDB, Mocapy++)
●   Justinas Daugmaudis (Mocapy++)

In 2012, we have two projects via the OBF:
●   Wibowo Arindrarto: (SearchIO)
●   Lenna Peterson: (Variants)

_____
http://biopython.org/wiki/Google_Summer_of_Code
http://www.open-bio.org/wiki/Google_Summer_of_Code
https://www.google-melange.com/
GSoC 2011: Mikael Trellet
Biomolecular interfaces in Bio.PDB
Mentor: João Rodrigues

● Representation of protein-protein
    interfaces: SM(I)CRA
●   Determining interfaces from PDB coordinates
●   Analyses of these objects

_____
http://biopython.org/wiki/GSoC2011_mtrellet
GSoC 2011: Michele Silva
Python/Biopython bindings for Mocapy++
Mentor: Thomas Hamelryck

Michele Silva wrote a Python bridge for Mocapy++ and
linked it to Bio.PDB to enable statistical analysis of protein
structures.

More-or-less ready to merge after the next Mocapy++
release.
_____
http://biopython.org/wiki/GSOC2011_Mocapy
GSoC 2011: Justinas Daugmaudis
Mocapy extensions in Python
Mentor: Thomas Hamelryck

Enhance Mocapy++ in a complementary way, developing a
plugin system for Mocapy++ allowing users to easily write
new nodes (probability distribution functions) in Python.

He's finishing this as part of his master's thesis project with
Thomas Hamelryck.
_____
http://biopython.org/wiki/GSOC2011_MocapyExt
GSoC 2012: Lenna Peterson
Diff My DNA: Development of a
Genomic Variant Toolkit for Biopython
Mentors: Brad Chapman, James Casbon

● I/O for VCF, GVF formats
● internal schema for variant data


_____
http://arklenna.tumblr.com/tagged/gsoc2012
GSoC 2012: Wibowo Arindrarto
SearchIO implementation in
Biopython
Mentor: Peter Cock

Unified, BioPerl-like API for
search results from BLAST,
HMMer, FASTA, etc.


_____
http://biopython.org/wiki/SearchIO
http://bow.web.id/blog/tag/gsoc/
Thanks
●   OBF
●   BOSC organizers
●   Biopython contributors
●   Scientists like you

Check us out:
● Website: http://biopython.org
● Code: https://github.com/biopython/biopython

Contenu connexe

Similaire à Biopython Project Update (BOSC 2012)

Collaboratively Creating the Knowledge Graph of Life
Collaboratively Creating the Knowledge Graph of LifeCollaboratively Creating the Knowledge Graph of Life
Collaboratively Creating the Knowledge Graph of LifeChris Mungall
 
Genome annotation with open source software: Apollo, Jbrowse and the GO in Ga...
Genome annotation with open source software: Apollo, Jbrowse and the GO in Ga...Genome annotation with open source software: Apollo, Jbrowse and the GO in Ga...
Genome annotation with open source software: Apollo, Jbrowse and the GO in Ga...Nathan Dunn
 
BioRuby -- Bioinformatics Library
BioRuby -- Bioinformatics LibraryBioRuby -- Bioinformatics Library
BioRuby -- Bioinformatics Libraryngotogenome
 
Antao Biopython Bosc2008
Antao Biopython Bosc2008Antao Biopython Bosc2008
Antao Biopython Bosc2008bosc_2008
 
UKSG Meeting April 4, 2011
UKSG Meeting April 4, 2011UKSG Meeting April 4, 2011
UKSG Meeting April 4, 2011Philip Bourne
 
Venkatesan bosc2010 onto-toolkit
Venkatesan bosc2010 onto-toolkitVenkatesan bosc2010 onto-toolkit
Venkatesan bosc2010 onto-toolkitBOSC 2010
 
BioCuration 2019 - Evidence and Conclusion Ontology 2019 Update
BioCuration 2019 - Evidence and Conclusion Ontology 2019 UpdateBioCuration 2019 - Evidence and Conclusion Ontology 2019 Update
BioCuration 2019 - Evidence and Conclusion Ontology 2019 Updatedolleyj
 
Data compression with Python: application of different algorithms with the us...
Data compression with Python: application of different algorithms with the us...Data compression with Python: application of different algorithms with the us...
Data compression with Python: application of different algorithms with the us...Alex Camargo
 
Introduction to Ontologies for Environmental Biology
Introduction to Ontologies for Environmental BiologyIntroduction to Ontologies for Environmental Biology
Introduction to Ontologies for Environmental BiologyBarry Smith
 
BOSC 2008 Biopython
BOSC 2008 BiopythonBOSC 2008 Biopython
BOSC 2008 Biopythontiago
 
Python training centre in adyar
Python training centre in adyarPython training centre in adyar
Python training centre in adyarsasikalaD3
 
Python training centre in adyar
Python training centre in adyarPython training centre in adyar
Python training centre in adyarsasikalaD3
 
Python training centre in adyar
Python training centre in adyarPython training centre in adyar
Python training centre in adyarsasikalaD3
 
Python training centre in adyar
Python training centre in adyarPython training centre in adyar
Python training centre in adyarsasikalaD3
 
Python training centre in adyar
Python training centre in adyarPython training centre in adyar
Python training centre in adyarsasikalaD3
 
Prins Bio Lib Bosc2008
Prins Bio Lib Bosc2008Prins Bio Lib Bosc2008
Prins Bio Lib Bosc2008bosc_2008
 

Similaire à Biopython Project Update (BOSC 2012) (20)

Collaboratively Creating the Knowledge Graph of Life
Collaboratively Creating the Knowledge Graph of LifeCollaboratively Creating the Knowledge Graph of Life
Collaboratively Creating the Knowledge Graph of Life
 
Genome annotation with open source software: Apollo, Jbrowse and the GO in Ga...
Genome annotation with open source software: Apollo, Jbrowse and the GO in Ga...Genome annotation with open source software: Apollo, Jbrowse and the GO in Ga...
Genome annotation with open source software: Apollo, Jbrowse and the GO in Ga...
 
BioRuby -- Bioinformatics Library
BioRuby -- Bioinformatics LibraryBioRuby -- Bioinformatics Library
BioRuby -- Bioinformatics Library
 
Antao Biopython Bosc2008
Antao Biopython Bosc2008Antao Biopython Bosc2008
Antao Biopython Bosc2008
 
UKSG Meeting April 4, 2011
UKSG Meeting April 4, 2011UKSG Meeting April 4, 2011
UKSG Meeting April 4, 2011
 
Venkatesan bosc2010 onto-toolkit
Venkatesan bosc2010 onto-toolkitVenkatesan bosc2010 onto-toolkit
Venkatesan bosc2010 onto-toolkit
 
BioPortal: ontologies and integrated data resources at the click of a mouse
BioPortal: ontologies and integrated data resourcesat the click of a mouseBioPortal: ontologies and integrated data resourcesat the click of a mouse
BioPortal: ontologies and integrated data resources at the click of a mouse
 
BioCuration 2019 - Evidence and Conclusion Ontology 2019 Update
BioCuration 2019 - Evidence and Conclusion Ontology 2019 UpdateBioCuration 2019 - Evidence and Conclusion Ontology 2019 Update
BioCuration 2019 - Evidence and Conclusion Ontology 2019 Update
 
Stoltzfus_EvoIO_2010
Stoltzfus_EvoIO_2010Stoltzfus_EvoIO_2010
Stoltzfus_EvoIO_2010
 
Stoltzfus_EvoIO_2010
Stoltzfus_EvoIO_2010Stoltzfus_EvoIO_2010
Stoltzfus_EvoIO_2010
 
Data compression with Python: application of different algorithms with the us...
Data compression with Python: application of different algorithms with the us...Data compression with Python: application of different algorithms with the us...
Data compression with Python: application of different algorithms with the us...
 
Introduction to Ontologies for Environmental Biology
Introduction to Ontologies for Environmental BiologyIntroduction to Ontologies for Environmental Biology
Introduction to Ontologies for Environmental Biology
 
BOSC 2008 Biopython
BOSC 2008 BiopythonBOSC 2008 Biopython
BOSC 2008 Biopython
 
Python training centre in adyar
Python training centre in adyarPython training centre in adyar
Python training centre in adyar
 
Python training centre in adyar
Python training centre in adyarPython training centre in adyar
Python training centre in adyar
 
Python training centre in adyar
Python training centre in adyarPython training centre in adyar
Python training centre in adyar
 
Python training centre in adyar
Python training centre in adyarPython training centre in adyar
Python training centre in adyar
 
Python training centre in adyar
Python training centre in adyarPython training centre in adyar
Python training centre in adyar
 
Proteomics data standards
Proteomics data standardsProteomics data standards
Proteomics data standards
 
Prins Bio Lib Bosc2008
Prins Bio Lib Bosc2008Prins Bio Lib Bosc2008
Prins Bio Lib Bosc2008
 

Dernier

Artificial Intelligence Chap.5 : Uncertainty
Artificial Intelligence Chap.5 : UncertaintyArtificial Intelligence Chap.5 : Uncertainty
Artificial Intelligence Chap.5 : UncertaintyKhushali Kathiriya
 
Strategize a Smooth Tenant-to-tenant Migration and Copilot Takeoff
Strategize a Smooth Tenant-to-tenant Migration and Copilot TakeoffStrategize a Smooth Tenant-to-tenant Migration and Copilot Takeoff
Strategize a Smooth Tenant-to-tenant Migration and Copilot Takeoffsammart93
 
Tata AIG General Insurance Company - Insurer Innovation Award 2024
Tata AIG General Insurance Company - Insurer Innovation Award 2024Tata AIG General Insurance Company - Insurer Innovation Award 2024
Tata AIG General Insurance Company - Insurer Innovation Award 2024The Digital Insurer
 
Connector Corner: Accelerate revenue generation using UiPath API-centric busi...
Connector Corner: Accelerate revenue generation using UiPath API-centric busi...Connector Corner: Accelerate revenue generation using UiPath API-centric busi...
Connector Corner: Accelerate revenue generation using UiPath API-centric busi...DianaGray10
 
Axa Assurance Maroc - Insurer Innovation Award 2024
Axa Assurance Maroc - Insurer Innovation Award 2024Axa Assurance Maroc - Insurer Innovation Award 2024
Axa Assurance Maroc - Insurer Innovation Award 2024The Digital Insurer
 
TrustArc Webinar - Unlock the Power of AI-Driven Data Discovery
TrustArc Webinar - Unlock the Power of AI-Driven Data DiscoveryTrustArc Webinar - Unlock the Power of AI-Driven Data Discovery
TrustArc Webinar - Unlock the Power of AI-Driven Data DiscoveryTrustArc
 
Boost Fertility New Invention Ups Success Rates.pdf
Boost Fertility New Invention Ups Success Rates.pdfBoost Fertility New Invention Ups Success Rates.pdf
Boost Fertility New Invention Ups Success Rates.pdfsudhanshuwaghmare1
 
MINDCTI Revenue Release Quarter One 2024
MINDCTI Revenue Release Quarter One 2024MINDCTI Revenue Release Quarter One 2024
MINDCTI Revenue Release Quarter One 2024MIND CTI
 
Workshop - Best of Both Worlds_ Combine KG and Vector search for enhanced R...
Workshop - Best of Both Worlds_ Combine  KG and Vector search for  enhanced R...Workshop - Best of Both Worlds_ Combine  KG and Vector search for  enhanced R...
Workshop - Best of Both Worlds_ Combine KG and Vector search for enhanced R...Neo4j
 
The 7 Things I Know About Cyber Security After 25 Years | April 2024
The 7 Things I Know About Cyber Security After 25 Years | April 2024The 7 Things I Know About Cyber Security After 25 Years | April 2024
The 7 Things I Know About Cyber Security After 25 Years | April 2024Rafal Los
 
Partners Life - Insurer Innovation Award 2024
Partners Life - Insurer Innovation Award 2024Partners Life - Insurer Innovation Award 2024
Partners Life - Insurer Innovation Award 2024The Digital Insurer
 
presentation ICT roal in 21st century education
presentation ICT roal in 21st century educationpresentation ICT roal in 21st century education
presentation ICT roal in 21st century educationjfdjdjcjdnsjd
 
TrustArc Webinar - Stay Ahead of US State Data Privacy Law Developments
TrustArc Webinar - Stay Ahead of US State Data Privacy Law DevelopmentsTrustArc Webinar - Stay Ahead of US State Data Privacy Law Developments
TrustArc Webinar - Stay Ahead of US State Data Privacy Law DevelopmentsTrustArc
 
From Event to Action: Accelerate Your Decision Making with Real-Time Automation
From Event to Action: Accelerate Your Decision Making with Real-Time AutomationFrom Event to Action: Accelerate Your Decision Making with Real-Time Automation
From Event to Action: Accelerate Your Decision Making with Real-Time AutomationSafe Software
 
AWS Community Day CPH - Three problems of Terraform
AWS Community Day CPH - Three problems of TerraformAWS Community Day CPH - Three problems of Terraform
AWS Community Day CPH - Three problems of TerraformAndrey Devyatkin
 
Top 5 Benefits OF Using Muvi Live Paywall For Live Streams
Top 5 Benefits OF Using Muvi Live Paywall For Live StreamsTop 5 Benefits OF Using Muvi Live Paywall For Live Streams
Top 5 Benefits OF Using Muvi Live Paywall For Live StreamsRoshan Dwivedi
 
Top 10 Most Downloaded Games on Play Store in 2024
Top 10 Most Downloaded Games on Play Store in 2024Top 10 Most Downloaded Games on Play Store in 2024
Top 10 Most Downloaded Games on Play Store in 2024SynarionITSolutions
 
2024: Domino Containers - The Next Step. News from the Domino Container commu...
2024: Domino Containers - The Next Step. News from the Domino Container commu...2024: Domino Containers - The Next Step. News from the Domino Container commu...
2024: Domino Containers - The Next Step. News from the Domino Container commu...Martijn de Jong
 
Manulife - Insurer Innovation Award 2024
Manulife - Insurer Innovation Award 2024Manulife - Insurer Innovation Award 2024
Manulife - Insurer Innovation Award 2024The Digital Insurer
 

Dernier (20)

Artificial Intelligence Chap.5 : Uncertainty
Artificial Intelligence Chap.5 : UncertaintyArtificial Intelligence Chap.5 : Uncertainty
Artificial Intelligence Chap.5 : Uncertainty
 
Strategize a Smooth Tenant-to-tenant Migration and Copilot Takeoff
Strategize a Smooth Tenant-to-tenant Migration and Copilot TakeoffStrategize a Smooth Tenant-to-tenant Migration and Copilot Takeoff
Strategize a Smooth Tenant-to-tenant Migration and Copilot Takeoff
 
Tata AIG General Insurance Company - Insurer Innovation Award 2024
Tata AIG General Insurance Company - Insurer Innovation Award 2024Tata AIG General Insurance Company - Insurer Innovation Award 2024
Tata AIG General Insurance Company - Insurer Innovation Award 2024
 
Connector Corner: Accelerate revenue generation using UiPath API-centric busi...
Connector Corner: Accelerate revenue generation using UiPath API-centric busi...Connector Corner: Accelerate revenue generation using UiPath API-centric busi...
Connector Corner: Accelerate revenue generation using UiPath API-centric busi...
 
Axa Assurance Maroc - Insurer Innovation Award 2024
Axa Assurance Maroc - Insurer Innovation Award 2024Axa Assurance Maroc - Insurer Innovation Award 2024
Axa Assurance Maroc - Insurer Innovation Award 2024
 
TrustArc Webinar - Unlock the Power of AI-Driven Data Discovery
TrustArc Webinar - Unlock the Power of AI-Driven Data DiscoveryTrustArc Webinar - Unlock the Power of AI-Driven Data Discovery
TrustArc Webinar - Unlock the Power of AI-Driven Data Discovery
 
Boost Fertility New Invention Ups Success Rates.pdf
Boost Fertility New Invention Ups Success Rates.pdfBoost Fertility New Invention Ups Success Rates.pdf
Boost Fertility New Invention Ups Success Rates.pdf
 
MINDCTI Revenue Release Quarter One 2024
MINDCTI Revenue Release Quarter One 2024MINDCTI Revenue Release Quarter One 2024
MINDCTI Revenue Release Quarter One 2024
 
Workshop - Best of Both Worlds_ Combine KG and Vector search for enhanced R...
Workshop - Best of Both Worlds_ Combine  KG and Vector search for  enhanced R...Workshop - Best of Both Worlds_ Combine  KG and Vector search for  enhanced R...
Workshop - Best of Both Worlds_ Combine KG and Vector search for enhanced R...
 
The 7 Things I Know About Cyber Security After 25 Years | April 2024
The 7 Things I Know About Cyber Security After 25 Years | April 2024The 7 Things I Know About Cyber Security After 25 Years | April 2024
The 7 Things I Know About Cyber Security After 25 Years | April 2024
 
Partners Life - Insurer Innovation Award 2024
Partners Life - Insurer Innovation Award 2024Partners Life - Insurer Innovation Award 2024
Partners Life - Insurer Innovation Award 2024
 
presentation ICT roal in 21st century education
presentation ICT roal in 21st century educationpresentation ICT roal in 21st century education
presentation ICT roal in 21st century education
 
+971581248768>> SAFE AND ORIGINAL ABORTION PILLS FOR SALE IN DUBAI AND ABUDHA...
+971581248768>> SAFE AND ORIGINAL ABORTION PILLS FOR SALE IN DUBAI AND ABUDHA...+971581248768>> SAFE AND ORIGINAL ABORTION PILLS FOR SALE IN DUBAI AND ABUDHA...
+971581248768>> SAFE AND ORIGINAL ABORTION PILLS FOR SALE IN DUBAI AND ABUDHA...
 
TrustArc Webinar - Stay Ahead of US State Data Privacy Law Developments
TrustArc Webinar - Stay Ahead of US State Data Privacy Law DevelopmentsTrustArc Webinar - Stay Ahead of US State Data Privacy Law Developments
TrustArc Webinar - Stay Ahead of US State Data Privacy Law Developments
 
From Event to Action: Accelerate Your Decision Making with Real-Time Automation
From Event to Action: Accelerate Your Decision Making with Real-Time AutomationFrom Event to Action: Accelerate Your Decision Making with Real-Time Automation
From Event to Action: Accelerate Your Decision Making with Real-Time Automation
 
AWS Community Day CPH - Three problems of Terraform
AWS Community Day CPH - Three problems of TerraformAWS Community Day CPH - Three problems of Terraform
AWS Community Day CPH - Three problems of Terraform
 
Top 5 Benefits OF Using Muvi Live Paywall For Live Streams
Top 5 Benefits OF Using Muvi Live Paywall For Live StreamsTop 5 Benefits OF Using Muvi Live Paywall For Live Streams
Top 5 Benefits OF Using Muvi Live Paywall For Live Streams
 
Top 10 Most Downloaded Games on Play Store in 2024
Top 10 Most Downloaded Games on Play Store in 2024Top 10 Most Downloaded Games on Play Store in 2024
Top 10 Most Downloaded Games on Play Store in 2024
 
2024: Domino Containers - The Next Step. News from the Domino Container commu...
2024: Domino Containers - The Next Step. News from the Domino Container commu...2024: Domino Containers - The Next Step. News from the Domino Container commu...
2024: Domino Containers - The Next Step. News from the Domino Container commu...
 
Manulife - Insurer Innovation Award 2024
Manulife - Insurer Innovation Award 2024Manulife - Insurer Innovation Award 2024
Manulife - Insurer Innovation Award 2024
 

Biopython Project Update (BOSC 2012)

  • 1. Project Update Bioinformatics Open Source Conference (BOSC) July 14, 2012 Long Beach, California, USA Eric Talevich, Peter Cock, Brad Chapman, João Rodrigues, and Biopython contributors
  • 2. Hello, BOSC Biopython is a freely available Python library for biological computation, and a long-running, distributed collaboration to produce and maintain it [1]. ● Supported by the Open Bioinformatics Foundation (OBF) ● "This is Python's Bio* library. There are several Bio* libraries like it, but this one is ours." ● http://biopython.org/ _____ [1] Cock, P.J.A., Antao, T., Chang, J.T., Chapman, B.A., Cox, C.J., Dalke, A., Friedberg, I., Hamelryck, T., Kauff, F., Wilczynski, B., de Hoon, M.J. (2009) Biopython: freely available Python tools for computational molecular biology and bioinformatics. Bioinformatics 25(11) 1422-3. doi:10.1093 /bioinformatics/btp163
  • 3. Bio.Graphics (Biopython 1.59, February 2012) New features in... BasicChromosome: ● Draw simple sub-features on chromosome segments ● Show the position of genes, SNPs or other loci GenomeDiagram [2]: ● Cross-links between tracks ● Track-specific start/end positions for showing regions _____ [2] Pritchard, L., White, J.A., Birch, P.R., Toth, I. (2010) GenomeDiagram: a python package for the visualization of large-scale genomic data. Bioinformatics 2(5) 616-7. doi:10.1093/bioinformatics/btk021
  • 4. BasicChromosome: Potato NB-LRRs Jupe et al. (2012) BMC Genomics
  • 5. GenomeDiagram: A tale of three phages Swanson et al. (2012) PLoS One (to appear)
  • 7. SeqIO and AlignIO (Biopython 1.58, August 2011) ● SeqXML format [3] ● Read support for ABI chromatogram files (Wibowo A.) ● "phylip-relaxed" format (Connor McCoy, Brandon I.) ○ Relaxes the 10-character limit on taxon names ○ Space-delimited instead ○ Used in RAxML, PhyML, PAML, etc. _____ [3] Schmitt et al. (2011) SeqXML and OrthoXML: standards for sequence and orthology information. Briefings in Bioinformatics 12(5): 485-488. doi:10.1093 /bib/bbr025
  • 8. Bio.Phylo & pypaml ● PAML interop: wrappers, I/O, glue ○ Merged Brandon Invergo’s pypaml as Bio.Phylo.PAML (Biopython 1.58, August 2011) ● Phylo.draw improvements ● RAxML wrapper (Biopython 1.60, June 2012) ● Paper in review [4] _____ [4] Talevich, E., Invergo, B.M., Cock, P.J.A., Chapman, B.A. (2012) Bio.Phylo: a unified toolkit for processing, analysis and visualization of phylogenetic data in Biopython. BMC Bioinformatics 13:209. doi:10.1186/1471-2105-13-209
  • 10. Bio.bgzf (Blocked GNU Zip Format) ● BGZF is a GZIP variant that compresses blocks of a fixed, known size ● Used in Next Generation Sequencing for efficient random access to compressed files ○ SAM + BGZF = BAM Bio.SeqIO can now index BGZF compressed sequence files. (Biopython 1.60, June 2012)
  • 11. TogoWS (Biopython 1.59, February 2012) ● TogoWS is an integrated web resource for bioinformatics databases and services ● Provided by the Database Center for Life Science in Japan ● Usage is similar to NCBI Entrez _____ http://togows.dbcls.jp/
  • 12. PyPy and Python 3 Biopython: ● works well on PyPy 1.9 (excluding NumPy & C extensions) ● works on Python 3 (excluding some C extensions), but concerns remain about performance in default unicode mode. ○ Currently 'beta' level support.
  • 13. Bio.PDB ● mmCIF parser restored (Biopython 1.60, June 2012) ○ Lenna Peterson fixed a 4-year-old lex/yacc-related compilation issue ○ That was awesome ○ Now she's a GSoC student ○ Py3/PyPy/Jython compatibility in progress ● Merging GSoC results incrementally ○ Atom element names & weights (João Rodrigues, GSoC 2010) ○ Lots of feature branches remaining...
  • 14. Bio.PDB feature branches PDBParser Bio.Struct Mocapy++ Generic Features InterfaceAnalysis mmCIF Parser GSOC '10 '11 '12 ...
  • 15. Google Summer of Code (GSoC) In 2011, Biopython had three projects funded via the OBF: ● Mikael Trellet (Bio.PDB) ● Michele Silva (Bio.PDB, Mocapy++) ● Justinas Daugmaudis (Mocapy++) In 2012, we have two projects via the OBF: ● Wibowo Arindrarto: (SearchIO) ● Lenna Peterson: (Variants) _____ http://biopython.org/wiki/Google_Summer_of_Code http://www.open-bio.org/wiki/Google_Summer_of_Code https://www.google-melange.com/
  • 16. GSoC 2011: Mikael Trellet Biomolecular interfaces in Bio.PDB Mentor: João Rodrigues ● Representation of protein-protein interfaces: SM(I)CRA ● Determining interfaces from PDB coordinates ● Analyses of these objects _____ http://biopython.org/wiki/GSoC2011_mtrellet
  • 17. GSoC 2011: Michele Silva Python/Biopython bindings for Mocapy++ Mentor: Thomas Hamelryck Michele Silva wrote a Python bridge for Mocapy++ and linked it to Bio.PDB to enable statistical analysis of protein structures. More-or-less ready to merge after the next Mocapy++ release. _____ http://biopython.org/wiki/GSOC2011_Mocapy
  • 18. GSoC 2011: Justinas Daugmaudis Mocapy extensions in Python Mentor: Thomas Hamelryck Enhance Mocapy++ in a complementary way, developing a plugin system for Mocapy++ allowing users to easily write new nodes (probability distribution functions) in Python. He's finishing this as part of his master's thesis project with Thomas Hamelryck. _____ http://biopython.org/wiki/GSOC2011_MocapyExt
  • 19. GSoC 2012: Lenna Peterson Diff My DNA: Development of a Genomic Variant Toolkit for Biopython Mentors: Brad Chapman, James Casbon ● I/O for VCF, GVF formats ● internal schema for variant data _____ http://arklenna.tumblr.com/tagged/gsoc2012
  • 20. GSoC 2012: Wibowo Arindrarto SearchIO implementation in Biopython Mentor: Peter Cock Unified, BioPerl-like API for search results from BLAST, HMMer, FASTA, etc. _____ http://biopython.org/wiki/SearchIO http://bow.web.id/blog/tag/gsoc/
  • 21. Thanks ● OBF ● BOSC organizers ● Biopython contributors ● Scientists like you Check us out: ● Website: http://biopython.org ● Code: https://github.com/biopython/biopython