SlideShare ist ein Scribd-Unternehmen logo
1 von 40
Downloaden Sie, um offline zu lesen
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)

Weitere ähnliche Inhalte

Andere mochten auch

Siete tips para conquistar mujeres
Siete tips para conquistar mujeresSiete tips para conquistar mujeres
Siete tips para conquistar mujeresHector Lopez
 
Updated Resume 2016 general revised
Updated Resume 2016 general revisedUpdated Resume 2016 general revised
Updated Resume 2016 general revisedWilliam 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 Dinhguest824eb
 
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 seduccionHector Lopez
 
Como enamorar a una mujer
Como enamorar a una mujerComo enamorar a una mujer
Como enamorar a una mujerHector Lopez
 
ученик года 11а
ученик года 11аученик года 11а
ученик года 11аserg32
 
Tipos de graficas karen reyes.
Tipos de graficas karen reyes.Tipos de graficas karen reyes.
Tipos de graficas karen reyes.Karen_Reyes
 
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
 
SPACE RESTAURANT
SPACE RESTAURANTSPACE RESTAURANT
SPACE RESTAURANTcprgraus
 

Andere mochten auch (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
 

Ähnlich wie p3d @EuroSciPy2010 by C. Fufezan

2009 CSBB LAB 新生訓練
2009 CSBB LAB 新生訓練 2009 CSBB LAB 新生訓練
2009 CSBB LAB 新生訓練 Abner Huang
 
Mass Spectrometry: Protein Identification Strategies
Mass Spectrometry: Protein Identification StrategiesMass Spectrometry: Protein Identification Strategies
Mass Spectrometry: Protein Identification StrategiesMichel Dumontier
 
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 Christopher Mason
 
09 CeoMeeting- Final Talk_Jay Keasling
09 CeoMeeting- Final Talk_Jay Keasling09 CeoMeeting- Final Talk_Jay Keasling
09 CeoMeeting- Final Talk_Jay KeaslingMLSCF
 
Partial thesis defence presentation
Partial thesis defence presentationPartial thesis defence presentation
Partial thesis defence presentationSanjeewaRupasinghe
 
Bioinformatics introduction
Bioinformatics introductionBioinformatics introduction
Bioinformatics introductionDrGopaSarma
 
Cytoscape: Integrating biological networks
Cytoscape: Integrating biological networksCytoscape: Integrating biological networks
Cytoscape: Integrating biological networksBITS
 
Hepatitis C
Hepatitis CHepatitis C
Hepatitis Cmafsana
 
Pepfold 3 peptide structure prediction
Pepfold 3 peptide structure predictionPepfold 3 peptide structure prediction
Pepfold 3 peptide structure predictionBioCode Ltd
 
Gabibov Alexander mechanisms of antigen degradation
Gabibov Alexander mechanisms of antigen degradationGabibov Alexander mechanisms of antigen degradation
Gabibov Alexander mechanisms of antigen degradationigorod
 
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 BioinformaticsAustin Publishing Group
 
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-issuesDongyan Zhao
 
Protein structure
Protein structureProtein structure
Protein structurePooja Pawar
 
How can you access PubChem programmatically?
How can you access PubChem programmatically?How can you access PubChem programmatically?
How can you access PubChem programmatically?Sunghwan Kim
 
SureChEMBL and Open PHACTS
SureChEMBL and Open PHACTSSureChEMBL and Open PHACTS
SureChEMBL and Open PHACTSGeorge Papadatos
 

Ähnlich wie 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
 

Kürzlich hochgeladen

Introduction to Nonprofit Accounting: The Basics
Introduction to Nonprofit Accounting: The BasicsIntroduction to Nonprofit Accounting: The Basics
Introduction to Nonprofit Accounting: The BasicsTechSoup
 
Sanyam Choudhary Chemistry practical.pdf
Sanyam Choudhary Chemistry practical.pdfSanyam Choudhary Chemistry practical.pdf
Sanyam Choudhary Chemistry practical.pdfsanyamsingh5019
 
CARE OF CHILD IN INCUBATOR..........pptx
CARE OF CHILD IN INCUBATOR..........pptxCARE OF CHILD IN INCUBATOR..........pptx
CARE OF CHILD IN INCUBATOR..........pptxGaneshChakor2
 
Accessible design: Minimum effort, maximum impact
Accessible design: Minimum effort, maximum impactAccessible design: Minimum effort, maximum impact
Accessible design: Minimum effort, maximum impactdawncurless
 
Kisan Call Centre - To harness potential of ICT in Agriculture by answer farm...
Kisan Call Centre - To harness potential of ICT in Agriculture by answer farm...Kisan Call Centre - To harness potential of ICT in Agriculture by answer farm...
Kisan Call Centre - To harness potential of ICT in Agriculture by answer farm...Krashi Coaching
 
Measures of Central Tendency: Mean, Median and Mode
Measures of Central Tendency: Mean, Median and ModeMeasures of Central Tendency: Mean, Median and Mode
Measures of Central Tendency: Mean, Median and ModeThiyagu K
 
9548086042 for call girls in Indira Nagar with room service
9548086042  for call girls in Indira Nagar  with room service9548086042  for call girls in Indira Nagar  with room service
9548086042 for call girls in Indira Nagar with room servicediscovermytutordmt
 
Sports & Fitness Value Added Course FY..
Sports & Fitness Value Added Course FY..Sports & Fitness Value Added Course FY..
Sports & Fitness Value Added Course FY..Disha Kariya
 
Student login on Anyboli platform.helpin
Student login on Anyboli platform.helpinStudent login on Anyboli platform.helpin
Student login on Anyboli platform.helpinRaunakKeshri1
 
Call Girls in Dwarka Mor Delhi Contact Us 9654467111
Call Girls in Dwarka Mor Delhi Contact Us 9654467111Call Girls in Dwarka Mor Delhi Contact Us 9654467111
Call Girls in Dwarka Mor Delhi Contact Us 9654467111Sapana Sha
 
Organic Name Reactions for the students and aspirants of Chemistry12th.pptx
Organic Name Reactions  for the students and aspirants of Chemistry12th.pptxOrganic Name Reactions  for the students and aspirants of Chemistry12th.pptx
Organic Name Reactions for the students and aspirants of Chemistry12th.pptxVS Mahajan Coaching Centre
 
Nutritional Needs Presentation - HLTH 104
Nutritional Needs Presentation - HLTH 104Nutritional Needs Presentation - HLTH 104
Nutritional Needs Presentation - HLTH 104misteraugie
 
Separation of Lanthanides/ Lanthanides and Actinides
Separation of Lanthanides/ Lanthanides and ActinidesSeparation of Lanthanides/ Lanthanides and Actinides
Separation of Lanthanides/ Lanthanides and ActinidesFatimaKhan178732
 
A Critique of the Proposed National Education Policy Reform
A Critique of the Proposed National Education Policy ReformA Critique of the Proposed National Education Policy Reform
A Critique of the Proposed National Education Policy ReformChameera Dedduwage
 
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 ...EduSkills OECD
 
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 GraphThiyagu K
 
microwave assisted reaction. General introduction
microwave assisted reaction. General introductionmicrowave assisted reaction. General introduction
microwave assisted reaction. General introductionMaksud Ahmed
 
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.pdfJayanti Pande
 

Kürzlich hochgeladen (20)

Introduction to Nonprofit Accounting: The Basics
Introduction to Nonprofit Accounting: The BasicsIntroduction to Nonprofit Accounting: The Basics
Introduction to Nonprofit Accounting: The Basics
 
Sanyam Choudhary Chemistry practical.pdf
Sanyam Choudhary Chemistry practical.pdfSanyam Choudhary Chemistry practical.pdf
Sanyam Choudhary Chemistry practical.pdf
 
CARE OF CHILD IN INCUBATOR..........pptx
CARE OF CHILD IN INCUBATOR..........pptxCARE OF CHILD IN INCUBATOR..........pptx
CARE OF CHILD IN INCUBATOR..........pptx
 
Accessible design: Minimum effort, maximum impact
Accessible design: Minimum effort, maximum impactAccessible design: Minimum effort, maximum impact
Accessible design: Minimum effort, maximum impact
 
Kisan Call Centre - To harness potential of ICT in Agriculture by answer farm...
Kisan Call Centre - To harness potential of ICT in Agriculture by answer farm...Kisan Call Centre - To harness potential of ICT in Agriculture by answer farm...
Kisan Call Centre - To harness potential of ICT in Agriculture by answer farm...
 
Measures of Central Tendency: Mean, Median and Mode
Measures of Central Tendency: Mean, Median and ModeMeasures of Central Tendency: Mean, Median and Mode
Measures of Central Tendency: Mean, Median and Mode
 
9548086042 for call girls in Indira Nagar with room service
9548086042  for call girls in Indira Nagar  with room service9548086042  for call girls in Indira Nagar  with room service
9548086042 for call girls in Indira Nagar with room service
 
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
 
Sports & Fitness Value Added Course FY..
Sports & Fitness Value Added Course FY..Sports & Fitness Value Added Course FY..
Sports & Fitness Value Added Course FY..
 
Student login on Anyboli platform.helpin
Student login on Anyboli platform.helpinStudent login on Anyboli platform.helpin
Student login on Anyboli platform.helpin
 
Call Girls in Dwarka Mor Delhi Contact Us 9654467111
Call Girls in Dwarka Mor Delhi Contact Us 9654467111Call Girls in Dwarka Mor Delhi Contact Us 9654467111
Call Girls in Dwarka Mor Delhi Contact Us 9654467111
 
Código Creativo y Arte de Software | Unidad 1
Código Creativo y Arte de Software | Unidad 1Código Creativo y Arte de Software | Unidad 1
Código Creativo y Arte de Software | Unidad 1
 
Organic Name Reactions for the students and aspirants of Chemistry12th.pptx
Organic Name Reactions  for the students and aspirants of Chemistry12th.pptxOrganic Name Reactions  for the students and aspirants of Chemistry12th.pptx
Organic Name Reactions for the students and aspirants of Chemistry12th.pptx
 
Nutritional Needs Presentation - HLTH 104
Nutritional Needs Presentation - HLTH 104Nutritional Needs Presentation - HLTH 104
Nutritional Needs Presentation - HLTH 104
 
Separation of Lanthanides/ Lanthanides and Actinides
Separation of Lanthanides/ Lanthanides and ActinidesSeparation of Lanthanides/ Lanthanides and Actinides
Separation of Lanthanides/ Lanthanides and Actinides
 
A Critique of the Proposed National Education Policy Reform
A Critique of the Proposed National Education Policy ReformA Critique of the Proposed National Education Policy Reform
A Critique of the Proposed National Education Policy Reform
 
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 ...
 
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
 
microwave assisted reaction. General introduction
microwave assisted reaction. General introductionmicrowave assisted reaction. General introduction
microwave assisted reaction. General introduction
 
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
 

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)