SlideShare a Scribd company logo
1 of 40
Download to read offline
High-throughput
structural bioinformatics
using
Python & p3d
Dr. C. Fufezan
Institute for Biochemistry and Biotechnology of Plants (IBBP)
Overview
Background
p3d overview
example ATP binding site
Fufezan, C. and Specht M. (2009) BMC Bioinformatics 10, 258
http://p3d.fufezan.net
http://github.com/fu/p3d
Dr. C. Fufezan
Institute for Biochemistry and Biotechnology of Plants (IBBP)

clone us - fork us!
Background

Dr. C. Fufezan
Institute for Biochemistry and Biotechnology of Plants (IBBP)
Background
carbon
nitrogen

oxygen

chain(s) of amino acids ...
N D R P A

I

M K

... form proteins

Dr. C. Fufezan
Institute for Biochemistry and Biotechnology of Plants (IBBP)
Background
carbon
nitrogen

oxygen

chain(s) of amino acids ...
N D R P A

I

M K

... form proteins

Dr. C. Fufezan
Institute for Biochemistry and Biotechnology of Plants (IBBP)
Background
carbon
nitrogen

oxygen

chain(s) of amino acids ...
N D R P A

I

M K

... form proteins
and some bind cofactors
e.g. ATP
Adenosin-tri-phosphate
Dr. C. Fufezan
Institute for Biochemistry and Biotechnology of Plants (IBBP)
Background
knowledge based approaches to elucidate
structural factors that are essential for co-factor
binding
- protein engineering
proteins
- protein folding
- co-factor tuning
Proteins_c1_sp_Ob.qxp

9/11/08

4:14 PM

Page 1

proteins

STRUCTURE O FUNCTION O BIOINFORMATICS
V O LU M E

7 3 ,

N U M B E R

3 ,

N OV E M B E R

1 5 ,

V O LU M E
7 3 ,
N U M B E R
3 ,
N OV E M B E R
1 5 ,
2 0 0 8

PAG E S

Morozov et al. (2004) PNAS, 101, 6946Huang et al.(2004) PNAS, 101, 5536Fufezan et al. (2008) Proteins, 73, 690Negron et al. (2009) Proteins, 74, 400Fufezan (2010) Proteins, in press

5 2 7 – 7 9 4

Dr. C. Fufezan
Institute for Biochemistry and Biotechnology of Plants (IBBP)

A PDB Survey of Heme Ligands in Proteins

2 0 0 8
p3d

Dr. C. Fufezan
Institute for Biochemistry and Biotechnology of Plants (IBBP)
p3d overview

Fufezan, C. and Specht M. (2009) BMC Bioinformatics 10, 258
http://p3d.fufezan.net

Python module that allows
to access and manipulate protein structure files
rapid development of new screening tools
easily incorporate complex queries

Dr. C. Fufezan
Institute for Biochemistry and Biotechnology of Plants (IBBP)
chain
atom
AA
resid
type
x y z user
idx

ATOM Object
idx
atype
aa
chain
x
y
z
user
beta
protein-object
Dr. C. Fufezan
Institute for Biochemistry and Biotechnology of Plants (IBBP)

beta
or
temperature
factor
O

C

N

CA
CB
CG1

CG2
Protein Object

ATOM Object
idx
atype
aa
chain
x
y
z
user
beta
protein-object
Dr. C. Fufezan
Institute for Biochemistry and Biotechnology of Plants (IBBP)

protein
... not-proteinogenic
hash
chain['A']
...
oxygen
nitrogen
backbone
atype['CA']
...

oxygen

backbone
alpha
residues
protein

not protein
Protein Object

ATOM Object
idx
atype
aa
chain
x
y
z
user
beta
protein-object
Dr. C. Fufezan
Institute for Biochemistry and Biotechnology of Plants (IBBP)

protein
... not-proteinogenic
hash
chain['A']
...
oxygen
nitrogen
backbone
atype['CA']
...

oxygen

backbone
alpha
residues
protein

not protein
Protein Object

ATOM Object
idx
atype
aa
chain
x
y
z
user
beta
protein-object
Dr. C. Fufezan
Institute for Biochemistry and Biotechnology of Plants (IBBP)

protein
... not-proteinogenic
hash
chain['A']
...
oxygen
nitrogen
backbone
atype['CA']
...

oxygen

backbone
alpha
residues
protein

not protein
Protein Object

ATOM Object
idx
atype
aa
chain
x
y
z
user
beta
protein-object
Dr. C. Fufezan
Institute for Biochemistry and Biotechnology of Plants (IBBP)

protein
... not-proteinogenic
hash
chain['A']
...
oxygen
nitrogen
backbone
atype['CA']
...

oxygen

backbone
alpha
residues
protein

not protein
Protein Object

ATOM Object
idx
atype
aa
chain
x
y
z
user
beta
protein-object
Dr. C. Fufezan
Institute for Biochemistry and Biotechnology of Plants (IBBP)

protein
... not-proteinogenic
hash
chain['A']
...
oxygen
nitrogen
backbone
atype['CA']
...

oxygen

backbone
alpha
residues
protein

not protein
Tree Object

ATOM Object
idx
atype
aa
chain
x
y
z
user
beta
protein-object
Dr. C. Fufezan
Institute for Biochemistry and Biotechnology of Plants (IBBP)
Tree Object

ATOM Object
idx
atype
aa
chain
x
y
z
user
beta
protein-object
Dr. C. Fufezan
Institute for Biochemistry and Biotechnology of Plants (IBBP)
Tree Object
query( Vector1, radius )

ATOM Object
idx
atype
aa
chain
x
y
z
user
beta
protein-object
Dr. C. Fufezan
Institute for Biochemistry and Biotechnology of Plants (IBBP)
Tree Object
query( Vector1, radius )

ATOM Object
idx
atype
aa
chain
x
y
z
user
beta
protein-object
Dr. C. Fufezan
Institute for Biochemistry and Biotechnology of Plants (IBBP)

Vectors
do not have to
be atoms!!
Protein class

List of atom
objects (vectors)

sets (hashes)
oxygen

BSP Tree
O1

FME A

1

CA

PHE A

2

backbone
alpha
residues
protein

not protein
Protein class

List of atom
objects (vectors)

sets (hashes)
oxygen

BSP Tree
O1

FME A

1

CA

PHE A

2

backbone
alpha
residues
protein

not protein

Query function using human readable syntax
e.g.: pdb.query(‘backbone and resid 5..12 and within 5 of resname FME’)
Protein class

List of atom
objects (vectors)

sets (hashes)
oxygen

BSP Tree
O1

FME A

1

CA

PHE A

2

backbone

Query function using human readable syntax
alpha
e.g.: pdb.query(‘backbone and resid 5..12 and within 5 of resname FME’)
residues
protein

not protein
Protein class

List of atom
objects (vectors)

sets (hashes)
oxygen

BSP Tree
O1

FME A

1

CA

PHE A

2

backbone

Query function using human readable syntax
alpha
e.g.: pdb.query(‘backbone and resid 5..12 and within 5 of resname FME’)
pdb.query(‘resname HOH and within 4 of resname ASP’)

residues
protein

not protein
Protein class

List of atom
objects (vectors)

sets (hashes)
oxygen

BSP Tree
O1

FME A

1

CA

PHE A

2

backbone

Query function using human readable syntax
alpha
e.g.: pdb.query(‘backbone and resid 5..12 and within 5 of resname FME’)
pdb.query(‘resname HOH and within 4 of resname ASP’)
pdb.query(‘oxygen and not protein’)

residues

protein

not protein
Protein class

List of atom
objects (vectors)

sets (hashes)
oxygen

BSP Tree
O1

FME A

1

CA

PHE A

2

backbone

Query function using human readable syntax
alpha
e.g.: pdb.query(‘backbone and resid 5..12 and within 5 of resname FME’)
pdb.query(‘resname HOH and within 4 of resname ASP’)
pdb.query(‘oxygen and not protein’)

residues

pdb.query(‘ protein and within 4 of ’, p3d.vector.Vector(x,y,z) )

protein

not protein
Protein class

List of atom
objects (vectors)

sets (hashes)
oxygen

BSP Tree
O1

FME A

1

CA

PHE A

2

backbone

Query function using human readable syntax
alpha
e.g.: pdb.query(‘backbone and resid 5..12 and within 5 of resname FME’)
pdb.query(‘resname HOH and within 4 of resname ASP’)
pdb.query(‘oxygen and not protein’)

residues

pdb.query(‘ protein and within 4 of ’, p3d.vector.Vector(x,y,z) )

protein

not protein

for residueName in pdb.hash[non-aa-resname]:
Protein class

List of atom
objects (vectors)

sets (hashes)
oxygen

BSP Tree
O1

FME A

1

CA

PHE A

2

backbone

Query function using human readable syntax
alpha
e.g.: pdb.query(‘backbone and resid 5..12 and within 5 of resname FME’)
pdb.query(‘resname HOH and within 4 of resname ASP’)
pdb.query(‘oxygen and not protein’)

residues

pdb.query(‘ protein and within 4 of ’, p3d.vector.Vector(x,y,z) )

protein

not protein

for residueName in pdb.hash[non-aa-resname]:
targets = pdb.query(' protein and within 4 of
Protein class

List of atom
objects (vectors)

sets (hashes)
oxygen

BSP Tree
O1

FME A

1

CA

PHE A

2

backbone

Query function using human readable syntax
alpha
e.g.: pdb.query(‘backbone and resid 5..12 and within 5 of resname FME’)
pdb.query(‘resname HOH and within 4 of resname ASP’)
pdb.query(‘oxygen and not protein’)

residues

pdb.query(‘ protein and within 4 of ’, p3d.vector.Vector(x,y,z) )

protein

not protein

for residueName in pdb.hash[non-aa-resname]:
targets = pdb.query(' protein and within 4 of 
( resname 'residueName' and oxygen )' )
Example ATP binding

Dr. C. Fufezan
Institute for Biochemistry and Biotechnology of Plants (IBBP)
The ATP binding sites
Adenosine-tri-phosphate

ΔG˚' = -30 kJ mol-1
40 kg / day
Dr. C. Fufezan
Institute for Biochemistry and Biotechnology of Plants (IBBP)
The ATP binding sites

non. redundant set of proteins
24 binding sites
Dr. C. Fufezan
Institute for Biochemistry and Biotechnology of Plants (IBBP)
The ATP binding sites

non. redundant set of proteins
24 binding sites
Dr. C. Fufezan
Institute for Biochemistry and Biotechnology of Plants (IBBP)
The ATP binding sites

non. redundant set of proteins
24 binding sites
Dr. C. Fufezan
Institute for Biochemistry and Biotechnology of Plants (IBBP)
The ATP binding sites

non. redundant set of proteins
24 binding sites
Dr. C. Fufezan
Institute for Biochemistry and Biotechnology of Plants (IBBP)
Dr. C. Fufezan
Institute for Biochemistry and Biotechnology of Plants (IBBP)
The ATP binding site

Dr. C. Fufezan
Institute for Biochemistry and Biotechnology of Plants (IBBP)
The ATP binding site

Dr. C. Fufezan
Institute for Biochemistry and Biotechnology of Plants (IBBP)
The ATP binding site
+4.5

hydropathy
index

Observations

10

0

1

-4.5

Dr. C. Fufezan
Institute for Biochemistry and Biotechnology of Plants (IBBP)

non. redundant set of proteins
24 binding sites
Summary
p3d allows to develop quickly Python
scripts to screen Protein structures
combines Vectors, sets and BSPTree
p3d allows flexible and complex queries
using human readable language

Dr. C. Fufezan
Institute for Biochemistry and Biotechnology of Plants (IBBP)
Acknowledgements

M. Specht
Prof. Dr. M. Hippler

founding by the DFG and
Alexander von Humboldt Stiftung
Dr. C. Fufezan
Institute for Biochemistry and Biotechnology of Plants (IBBP)

More Related Content

Viewers also liked

Updated Resume 2016 general revised
Updated Resume 2016 general revisedUpdated Resume 2016 general revised
Updated Resume 2016 general revised
William Fisher
 
El Libro De Consejos de Daniel Dinh
El Libro De Consejos de Daniel DinhEl Libro De Consejos de Daniel Dinh
El Libro De Consejos de Daniel Dinh
guest824eb
 
ученик года 11а
ученик года 11аученик года 11а
ученик года 11а
serg32
 
Lugares historicos de p.r.
Lugares historicos de p.r.Lugares historicos de p.r.
Lugares historicos de p.r.
bianca1990
 
итоги конкурса букетов 11а
итоги конкурса букетов 11аитоги конкурса букетов 11а
итоги конкурса букетов 11а
serg32
 

Viewers also liked (13)

Siete tips para conquistar mujeres
Siete tips para conquistar mujeresSiete tips para conquistar mujeres
Siete tips para conquistar mujeres
 
Updated Resume 2016 general revised
Updated Resume 2016 general revisedUpdated Resume 2016 general revised
Updated Resume 2016 general revised
 
El Libro De Consejos de Daniel Dinh
El Libro De Consejos de Daniel DinhEl Libro De Consejos de Daniel Dinh
El Libro De Consejos de Daniel Dinh
 
Aprende esta rara técnica de seduccion
Aprende esta rara técnica de seduccionAprende esta rara técnica de seduccion
Aprende esta rara técnica de seduccion
 
Como enamorar a una mujer
Como enamorar a una mujerComo enamorar a una mujer
Como enamorar a una mujer
 
Nicolas_LuarteCV
Nicolas_LuarteCVNicolas_LuarteCV
Nicolas_LuarteCV
 
PTTLS 4
PTTLS 4PTTLS 4
PTTLS 4
 
ученик года 11а
ученик года 11аученик года 11а
ученик года 11а
 
Tipos de graficas karen reyes.
Tipos de graficas karen reyes.Tipos de graficas karen reyes.
Tipos de graficas karen reyes.
 
Lugares historicos de p.r.
Lugares historicos de p.r.Lugares historicos de p.r.
Lugares historicos de p.r.
 
итоги конкурса букетов 11а
итоги конкурса букетов 11аитоги конкурса букетов 11а
итоги конкурса букетов 11а
 
SPACE RESTAURANT
SPACE RESTAURANTSPACE RESTAURANT
SPACE RESTAURANT
 
Vehicle
VehicleVehicle
Vehicle
 

Similar to p3d @EuroSciPy2010 by C. Fufezan

Partial thesis defence presentation
Partial thesis defence presentationPartial thesis defence presentation
Partial thesis defence presentation
SanjeewaRupasinghe
 
Gabibov Alexander mechanisms of antigen degradation
Gabibov Alexander mechanisms of antigen degradationGabibov Alexander mechanisms of antigen degradation
Gabibov Alexander mechanisms of antigen degradation
igorod
 
2015.04.08-Next-generation-sequencing-issues
2015.04.08-Next-generation-sequencing-issues2015.04.08-Next-generation-sequencing-issues
2015.04.08-Next-generation-sequencing-issues
Dongyan Zhao
 
Protein structure
Protein structureProtein structure
Protein structure
Pooja Pawar
 

Similar to p3d @EuroSciPy2010 by C. Fufezan (20)

Introduction to Proteogenomics
Introduction to Proteogenomics Introduction to Proteogenomics
Introduction to Proteogenomics
 
2009 CSBB LAB 新生訓練
2009 CSBB LAB 新生訓練 2009 CSBB LAB 新生訓練
2009 CSBB LAB 新生訓練
 
Mass Spectrometry: Protein Identification Strategies
Mass Spectrometry: Protein Identification StrategiesMass Spectrometry: Protein Identification Strategies
Mass Spectrometry: Protein Identification Strategies
 
Cross-Kingdom Standards in Genomics, Epigenomics and Metagenomics
Cross-Kingdom Standards in Genomics, Epigenomics and MetagenomicsCross-Kingdom Standards in Genomics, Epigenomics and Metagenomics
Cross-Kingdom Standards in Genomics, Epigenomics and Metagenomics
 
09 CeoMeeting- Final Talk_Jay Keasling
09 CeoMeeting- Final Talk_Jay Keasling09 CeoMeeting- Final Talk_Jay Keasling
09 CeoMeeting- Final Talk_Jay Keasling
 
Protein database
Protein databaseProtein database
Protein database
 
Partial thesis defence presentation
Partial thesis defence presentationPartial thesis defence presentation
Partial thesis defence presentation
 
Bioinformatics introduction
Bioinformatics introductionBioinformatics introduction
Bioinformatics introduction
 
Cytoscape: Integrating biological networks
Cytoscape: Integrating biological networksCytoscape: Integrating biological networks
Cytoscape: Integrating biological networks
 
Hepatitis C
Hepatitis CHepatitis C
Hepatitis C
 
Bioinformatica 01-12-2011-t7-protein
Bioinformatica 01-12-2011-t7-proteinBioinformatica 01-12-2011-t7-protein
Bioinformatica 01-12-2011-t7-protein
 
Pepfold 3 peptide structure prediction
Pepfold 3 peptide structure predictionPepfold 3 peptide structure prediction
Pepfold 3 peptide structure prediction
 
Overview of SureChEMBL
Overview of SureChEMBLOverview of SureChEMBL
Overview of SureChEMBL
 
Gabibov Alexander mechanisms of antigen degradation
Gabibov Alexander mechanisms of antigen degradationGabibov Alexander mechanisms of antigen degradation
Gabibov Alexander mechanisms of antigen degradation
 
Austin Journal of Computational Biology and Bioinformatics
Austin Journal of Computational Biology and BioinformaticsAustin Journal of Computational Biology and Bioinformatics
Austin Journal of Computational Biology and Bioinformatics
 
2015.04.08-Next-generation-sequencing-issues
2015.04.08-Next-generation-sequencing-issues2015.04.08-Next-generation-sequencing-issues
2015.04.08-Next-generation-sequencing-issues
 
Protein structure
Protein structureProtein structure
Protein structure
 
Databases
DatabasesDatabases
Databases
 
How can you access PubChem programmatically?
How can you access PubChem programmatically?How can you access PubChem programmatically?
How can you access PubChem programmatically?
 
SureChEMBL and Open PHACTS
SureChEMBL and Open PHACTSSureChEMBL and Open PHACTS
SureChEMBL and Open PHACTS
 

Recently uploaded

Russian Escort Service in Delhi 11k Hotel Foreigner Russian Call Girls in Delhi
Russian Escort Service in Delhi 11k Hotel Foreigner Russian Call Girls in DelhiRussian Escort Service in Delhi 11k Hotel Foreigner Russian Call Girls in Delhi
Russian Escort Service in Delhi 11k Hotel Foreigner Russian Call Girls in Delhi
kauryashika82
 
Activity 01 - Artificial Culture (1).pdf
Activity 01 - Artificial Culture (1).pdfActivity 01 - Artificial Culture (1).pdf
Activity 01 - Artificial Culture (1).pdf
ciinovamais
 
Seal of Good Local Governance (SGLG) 2024Final.pptx
Seal of Good Local Governance (SGLG) 2024Final.pptxSeal of Good Local Governance (SGLG) 2024Final.pptx
Seal of Good Local Governance (SGLG) 2024Final.pptx
negromaestrong
 

Recently uploaded (20)

PROCESS RECORDING FORMAT.docx
PROCESS      RECORDING        FORMAT.docxPROCESS      RECORDING        FORMAT.docx
PROCESS RECORDING FORMAT.docx
 
Presentation by Andreas Schleicher Tackling the School Absenteeism Crisis 30 ...
Presentation by Andreas Schleicher Tackling the School Absenteeism Crisis 30 ...Presentation by Andreas Schleicher Tackling the School Absenteeism Crisis 30 ...
Presentation by Andreas Schleicher Tackling the School Absenteeism Crisis 30 ...
 
Unit-V; Pricing (Pharma Marketing Management).pptx
Unit-V; Pricing (Pharma Marketing Management).pptxUnit-V; Pricing (Pharma Marketing Management).pptx
Unit-V; Pricing (Pharma Marketing Management).pptx
 
Russian Escort Service in Delhi 11k Hotel Foreigner Russian Call Girls in Delhi
Russian Escort Service in Delhi 11k Hotel Foreigner Russian Call Girls in DelhiRussian Escort Service in Delhi 11k Hotel Foreigner Russian Call Girls in Delhi
Russian Escort Service in Delhi 11k Hotel Foreigner Russian Call Girls in Delhi
 
Web & Social Media Analytics Previous Year Question Paper.pdf
Web & Social Media Analytics Previous Year Question Paper.pdfWeb & Social Media Analytics Previous Year Question Paper.pdf
Web & Social Media Analytics Previous Year Question Paper.pdf
 
Sociology 101 Demonstration of Learning Exhibit
Sociology 101 Demonstration of Learning ExhibitSociology 101 Demonstration of Learning Exhibit
Sociology 101 Demonstration of Learning Exhibit
 
Application orientated numerical on hev.ppt
Application orientated numerical on hev.pptApplication orientated numerical on hev.ppt
Application orientated numerical on hev.ppt
 
INDIA QUIZ 2024 RLAC DELHI UNIVERSITY.pptx
INDIA QUIZ 2024 RLAC DELHI UNIVERSITY.pptxINDIA QUIZ 2024 RLAC DELHI UNIVERSITY.pptx
INDIA QUIZ 2024 RLAC DELHI UNIVERSITY.pptx
 
Ecological Succession. ( ECOSYSTEM, B. Pharmacy, 1st Year, Sem-II, Environmen...
Ecological Succession. ( ECOSYSTEM, B. Pharmacy, 1st Year, Sem-II, Environmen...Ecological Succession. ( ECOSYSTEM, B. Pharmacy, 1st Year, Sem-II, Environmen...
Ecological Succession. ( ECOSYSTEM, B. Pharmacy, 1st Year, Sem-II, Environmen...
 
Key note speaker Neum_Admir Softic_ENG.pdf
Key note speaker Neum_Admir Softic_ENG.pdfKey note speaker Neum_Admir Softic_ENG.pdf
Key note speaker Neum_Admir Softic_ENG.pdf
 
Asian American Pacific Islander Month DDSD 2024.pptx
Asian American Pacific Islander Month DDSD 2024.pptxAsian American Pacific Islander Month DDSD 2024.pptx
Asian American Pacific Islander Month DDSD 2024.pptx
 
Activity 01 - Artificial Culture (1).pdf
Activity 01 - Artificial Culture (1).pdfActivity 01 - Artificial Culture (1).pdf
Activity 01 - Artificial Culture (1).pdf
 
Role Of Transgenic Animal In Target Validation-1.pptx
Role Of Transgenic Animal In Target Validation-1.pptxRole Of Transgenic Animal In Target Validation-1.pptx
Role Of Transgenic Animal In Target Validation-1.pptx
 
Food Chain and Food Web (Ecosystem) EVS, B. Pharmacy 1st Year, Sem-II
Food Chain and Food Web (Ecosystem) EVS, B. Pharmacy 1st Year, Sem-IIFood Chain and Food Web (Ecosystem) EVS, B. Pharmacy 1st Year, Sem-II
Food Chain and Food Web (Ecosystem) EVS, B. Pharmacy 1st Year, Sem-II
 
Z Score,T Score, Percential Rank and Box Plot Graph
Z Score,T Score, Percential Rank and Box Plot GraphZ Score,T Score, Percential Rank and Box Plot Graph
Z Score,T Score, Percential Rank and Box Plot Graph
 
Seal of Good Local Governance (SGLG) 2024Final.pptx
Seal of Good Local Governance (SGLG) 2024Final.pptxSeal of Good Local Governance (SGLG) 2024Final.pptx
Seal of Good Local Governance (SGLG) 2024Final.pptx
 
Basic Civil Engineering first year Notes- Chapter 4 Building.pptx
Basic Civil Engineering first year Notes- Chapter 4 Building.pptxBasic Civil Engineering first year Notes- Chapter 4 Building.pptx
Basic Civil Engineering first year Notes- Chapter 4 Building.pptx
 
This PowerPoint helps students to consider the concept of infinity.
This PowerPoint helps students to consider the concept of infinity.This PowerPoint helps students to consider the concept of infinity.
This PowerPoint helps students to consider the concept of infinity.
 
ComPTIA Overview | Comptia Security+ Book SY0-701
ComPTIA Overview | Comptia Security+ Book SY0-701ComPTIA Overview | Comptia Security+ Book SY0-701
ComPTIA Overview | Comptia Security+ Book SY0-701
 
Introduction to Nonprofit Accounting: The Basics
Introduction to Nonprofit Accounting: The BasicsIntroduction to Nonprofit Accounting: The Basics
Introduction to Nonprofit Accounting: The Basics
 

p3d @EuroSciPy2010 by C. Fufezan

  • 1. High-throughput structural bioinformatics using Python & p3d Dr. C. Fufezan Institute for Biochemistry and Biotechnology of Plants (IBBP)
  • 2. Overview Background p3d overview example ATP binding site Fufezan, C. and Specht M. (2009) BMC Bioinformatics 10, 258 http://p3d.fufezan.net http://github.com/fu/p3d Dr. C. Fufezan Institute for Biochemistry and Biotechnology of Plants (IBBP) clone us - fork us!
  • 3. Background Dr. C. Fufezan Institute for Biochemistry and Biotechnology of Plants (IBBP)
  • 4. Background carbon nitrogen oxygen chain(s) of amino acids ... N D R P A I M K ... form proteins Dr. C. Fufezan Institute for Biochemistry and Biotechnology of Plants (IBBP)
  • 5. Background carbon nitrogen oxygen chain(s) of amino acids ... N D R P A I M K ... form proteins Dr. C. Fufezan Institute for Biochemistry and Biotechnology of Plants (IBBP)
  • 6. Background carbon nitrogen oxygen chain(s) of amino acids ... N D R P A I M K ... form proteins and some bind cofactors e.g. ATP Adenosin-tri-phosphate Dr. C. Fufezan Institute for Biochemistry and Biotechnology of Plants (IBBP)
  • 7. Background knowledge based approaches to elucidate structural factors that are essential for co-factor binding - protein engineering proteins - protein folding - co-factor tuning Proteins_c1_sp_Ob.qxp 9/11/08 4:14 PM Page 1 proteins STRUCTURE O FUNCTION O BIOINFORMATICS V O LU M E 7 3 , N U M B E R 3 , N OV E M B E R 1 5 , V O LU M E 7 3 , N U M B E R 3 , N OV E M B E R 1 5 , 2 0 0 8 PAG E S Morozov et al. (2004) PNAS, 101, 6946Huang et al.(2004) PNAS, 101, 5536Fufezan et al. (2008) Proteins, 73, 690Negron et al. (2009) Proteins, 74, 400Fufezan (2010) Proteins, in press 5 2 7 – 7 9 4 Dr. C. Fufezan Institute for Biochemistry and Biotechnology of Plants (IBBP) A PDB Survey of Heme Ligands in Proteins 2 0 0 8
  • 8. p3d Dr. C. Fufezan Institute for Biochemistry and Biotechnology of Plants (IBBP)
  • 9. p3d overview Fufezan, C. and Specht M. (2009) BMC Bioinformatics 10, 258 http://p3d.fufezan.net Python module that allows to access and manipulate protein structure files rapid development of new screening tools easily incorporate complex queries Dr. C. Fufezan Institute for Biochemistry and Biotechnology of Plants (IBBP)
  • 10. chain atom AA resid type x y z user idx ATOM Object idx atype aa chain x y z user beta protein-object Dr. C. Fufezan Institute for Biochemistry and Biotechnology of Plants (IBBP) beta or temperature factor O C N CA CB CG1 CG2
  • 11. Protein Object ATOM Object idx atype aa chain x y z user beta protein-object Dr. C. Fufezan Institute for Biochemistry and Biotechnology of Plants (IBBP) protein ... not-proteinogenic hash chain['A'] ... oxygen nitrogen backbone atype['CA'] ... oxygen backbone alpha residues protein not protein
  • 12. Protein Object ATOM Object idx atype aa chain x y z user beta protein-object Dr. C. Fufezan Institute for Biochemistry and Biotechnology of Plants (IBBP) protein ... not-proteinogenic hash chain['A'] ... oxygen nitrogen backbone atype['CA'] ... oxygen backbone alpha residues protein not protein
  • 13. Protein Object ATOM Object idx atype aa chain x y z user beta protein-object Dr. C. Fufezan Institute for Biochemistry and Biotechnology of Plants (IBBP) protein ... not-proteinogenic hash chain['A'] ... oxygen nitrogen backbone atype['CA'] ... oxygen backbone alpha residues protein not protein
  • 14. Protein Object ATOM Object idx atype aa chain x y z user beta protein-object Dr. C. Fufezan Institute for Biochemistry and Biotechnology of Plants (IBBP) protein ... not-proteinogenic hash chain['A'] ... oxygen nitrogen backbone atype['CA'] ... oxygen backbone alpha residues protein not protein
  • 15. Protein Object ATOM Object idx atype aa chain x y z user beta protein-object Dr. C. Fufezan Institute for Biochemistry and Biotechnology of Plants (IBBP) protein ... not-proteinogenic hash chain['A'] ... oxygen nitrogen backbone atype['CA'] ... oxygen backbone alpha residues protein not protein
  • 16. Tree Object ATOM Object idx atype aa chain x y z user beta protein-object Dr. C. Fufezan Institute for Biochemistry and Biotechnology of Plants (IBBP)
  • 17. Tree Object ATOM Object idx atype aa chain x y z user beta protein-object Dr. C. Fufezan Institute for Biochemistry and Biotechnology of Plants (IBBP)
  • 18. Tree Object query( Vector1, radius ) ATOM Object idx atype aa chain x y z user beta protein-object Dr. C. Fufezan Institute for Biochemistry and Biotechnology of Plants (IBBP)
  • 19. Tree Object query( Vector1, radius ) ATOM Object idx atype aa chain x y z user beta protein-object Dr. C. Fufezan Institute for Biochemistry and Biotechnology of Plants (IBBP) Vectors do not have to be atoms!!
  • 20. Protein class List of atom objects (vectors) sets (hashes) oxygen BSP Tree O1 FME A 1 CA PHE A 2 backbone alpha residues protein not protein
  • 21. Protein class List of atom objects (vectors) sets (hashes) oxygen BSP Tree O1 FME A 1 CA PHE A 2 backbone alpha residues protein not protein Query function using human readable syntax e.g.: pdb.query(‘backbone and resid 5..12 and within 5 of resname FME’)
  • 22. Protein class List of atom objects (vectors) sets (hashes) oxygen BSP Tree O1 FME A 1 CA PHE A 2 backbone Query function using human readable syntax alpha e.g.: pdb.query(‘backbone and resid 5..12 and within 5 of resname FME’) residues protein not protein
  • 23. Protein class List of atom objects (vectors) sets (hashes) oxygen BSP Tree O1 FME A 1 CA PHE A 2 backbone Query function using human readable syntax alpha e.g.: pdb.query(‘backbone and resid 5..12 and within 5 of resname FME’) pdb.query(‘resname HOH and within 4 of resname ASP’) residues protein not protein
  • 24. Protein class List of atom objects (vectors) sets (hashes) oxygen BSP Tree O1 FME A 1 CA PHE A 2 backbone Query function using human readable syntax alpha e.g.: pdb.query(‘backbone and resid 5..12 and within 5 of resname FME’) pdb.query(‘resname HOH and within 4 of resname ASP’) pdb.query(‘oxygen and not protein’) residues protein not protein
  • 25. Protein class List of atom objects (vectors) sets (hashes) oxygen BSP Tree O1 FME A 1 CA PHE A 2 backbone Query function using human readable syntax alpha e.g.: pdb.query(‘backbone and resid 5..12 and within 5 of resname FME’) pdb.query(‘resname HOH and within 4 of resname ASP’) pdb.query(‘oxygen and not protein’) residues pdb.query(‘ protein and within 4 of ’, p3d.vector.Vector(x,y,z) ) protein not protein
  • 26. Protein class List of atom objects (vectors) sets (hashes) oxygen BSP Tree O1 FME A 1 CA PHE A 2 backbone Query function using human readable syntax alpha e.g.: pdb.query(‘backbone and resid 5..12 and within 5 of resname FME’) pdb.query(‘resname HOH and within 4 of resname ASP’) pdb.query(‘oxygen and not protein’) residues pdb.query(‘ protein and within 4 of ’, p3d.vector.Vector(x,y,z) ) protein not protein for residueName in pdb.hash[non-aa-resname]:
  • 27. Protein class List of atom objects (vectors) sets (hashes) oxygen BSP Tree O1 FME A 1 CA PHE A 2 backbone Query function using human readable syntax alpha e.g.: pdb.query(‘backbone and resid 5..12 and within 5 of resname FME’) pdb.query(‘resname HOH and within 4 of resname ASP’) pdb.query(‘oxygen and not protein’) residues pdb.query(‘ protein and within 4 of ’, p3d.vector.Vector(x,y,z) ) protein not protein for residueName in pdb.hash[non-aa-resname]: targets = pdb.query(' protein and within 4 of
  • 28. Protein class List of atom objects (vectors) sets (hashes) oxygen BSP Tree O1 FME A 1 CA PHE A 2 backbone Query function using human readable syntax alpha e.g.: pdb.query(‘backbone and resid 5..12 and within 5 of resname FME’) pdb.query(‘resname HOH and within 4 of resname ASP’) pdb.query(‘oxygen and not protein’) residues pdb.query(‘ protein and within 4 of ’, p3d.vector.Vector(x,y,z) ) protein not protein for residueName in pdb.hash[non-aa-resname]: targets = pdb.query(' protein and within 4 of ( resname 'residueName' and oxygen )' )
  • 29. Example ATP binding Dr. C. Fufezan Institute for Biochemistry and Biotechnology of Plants (IBBP)
  • 30. The ATP binding sites Adenosine-tri-phosphate ΔG˚' = -30 kJ mol-1 40 kg / day Dr. C. Fufezan Institute for Biochemistry and Biotechnology of Plants (IBBP)
  • 31. The ATP binding sites non. redundant set of proteins 24 binding sites Dr. C. Fufezan Institute for Biochemistry and Biotechnology of Plants (IBBP)
  • 32. The ATP binding sites non. redundant set of proteins 24 binding sites Dr. C. Fufezan Institute for Biochemistry and Biotechnology of Plants (IBBP)
  • 33. The ATP binding sites non. redundant set of proteins 24 binding sites Dr. C. Fufezan Institute for Biochemistry and Biotechnology of Plants (IBBP)
  • 34. The ATP binding sites non. redundant set of proteins 24 binding sites Dr. C. Fufezan Institute for Biochemistry and Biotechnology of Plants (IBBP)
  • 35. Dr. C. Fufezan Institute for Biochemistry and Biotechnology of Plants (IBBP)
  • 36. The ATP binding site Dr. C. Fufezan Institute for Biochemistry and Biotechnology of Plants (IBBP)
  • 37. The ATP binding site Dr. C. Fufezan Institute for Biochemistry and Biotechnology of Plants (IBBP)
  • 38. The ATP binding site +4.5 hydropathy index Observations 10 0 1 -4.5 Dr. C. Fufezan Institute for Biochemistry and Biotechnology of Plants (IBBP) non. redundant set of proteins 24 binding sites
  • 39. Summary p3d allows to develop quickly Python scripts to screen Protein structures combines Vectors, sets and BSPTree p3d allows flexible and complex queries using human readable language Dr. C. Fufezan Institute for Biochemistry and Biotechnology of Plants (IBBP)
  • 40. Acknowledgements M. Specht Prof. Dr. M. Hippler founding by the DFG and Alexander von Humboldt Stiftung Dr. C. Fufezan Institute for Biochemistry and Biotechnology of Plants (IBBP)