SlideShare a Scribd company logo
1 of 64
MOLECULAR DOCKING
Saramita De Chakravarti
Computational Biology Laboratory
S V Chembiotech, Bangalore
saramita16@chembiotech.com
1Molecular Docking by Saramita Chakravarti
Introduction
• Drug discovery  take years to decade for
discovering a new drug and very costly
• Effort  to cut down the research timeline and
cost by reducing wet-lab experiment  use
computer modeling
2
Molecular Docking by Saramita
Chakravarti
Drug discovery
Chemical + biological system  desired response?
3
Molecular Docking by Saramita
Chakravarti
TRADITIONAL DRUG DESIGN
Lead generation:
Natural ligand / Screening
Biological Testing
Synthesis of New Compounds
Drug Design CycleDrug Design Cycle
If promising
Pre-Clinical Studies
4Molecular Docking by Saramita Chakravarti
Finding lead compound
• A lead compound is a small molecule that serves as the starting
point for an optimization involving many small molecules that
are closely related in structure to the lead compound
• Many organizations maintain databases of chemical
compounds
• Some of these are publically accessible others are proprietary
• Databases contain an extremely large number of compounds
(ACS data bases contains 10 million compounds)
• 3D databases have information about chemical and geometrical
features
» Hydrogen bond donors
» Hydrogen bond acceptors
» Positive Charge Centers
» Aromatic ring centers
» Hydrophobic centers
5
Molecular Docking by Saramita
Chakravarti
Finding lead compound
• There are two approaches to this problem
–A computer program AutoDock (or similar
version Affinity (accelrys)) can be used to
search a database by generating “fit” between
molecule and the receptor
–Alternatively one can search 3D
pharmacophore
6
Molecular Docking by Saramita
Chakravarti
Structure based drug design
• Drug design and development
• Structure based drug design exploits the 3D
structure of the target or a pharmacophore
–Find a molecule which would be expected to
interact with the receptor. (Searching a data base)
–Design entirely a new molecule from
“SCRATCH” (de novo drug/ligand design)
• In this context bioinformatics and
chemoinformatics play a crucial role
7
Molecular Docking by Saramita
Chakravarti
Structure-based Drug Design (SBDD)
Molecular Biology & Protein Chemistry
3D Structure Determination of Target
and Target-Ligand Complex
Modelling
Structure Analysis
and Compound Design
Biological Testing
Synthesis of New Compounds
If promising
Pre-Clinical
Studies
Drug Design CycleDrug Design Cycle
Natural ligand / Screening
8
Molecular Docking by Saramita Chakravarti
Structure based drug design
• SBDD:
• drug targets (usually proteins)
• binding of ligands to the target (docking)
↓
“rational” drug design
(benefits = saved time and $$)
9
Molecular Docking by Saramita
Chakravarti
Select and Purify the
target protein
Model inhibitor
with
computational
tools
Synthesis, Evaluate
preclinical, clinical,
invitro, invivo, cells,
animals, & humans
Drug
Schematics for structure based drug designSchematics for structure based drug design
Obtain known
inhibitor
X-Ray structural
determination of native
protein
X-Ray structural
determination of
inhibitor complex
Determine IC50
Structure Based Drug Design have the potential to shave off years and millions of dollars
10
Molecular Docking by Saramita
Chakravarti
Working at the intersection
• Structural Biology
• Biochemistry
• Medicinal Chemistry
• Toxicology
• Pharmacology
• Biophysical Chemistry
• Natural Products Chemistry
• Chemical Ecology
• Information Technology
11
Molecular Docking by Saramita
Chakravarti
Molecular docking-definition
• It is a process by which two molecules are
put together in 3 Dimension
• Best ways to put two molecules together
• Using molecular modeling and computational
chemistry tools
12
Molecular Docking by Saramita
Chakravarti
Molecular docking
• Docking used for finding binding modes of
protein with ligands/inhibitors
• In molecular docking, we attempt to predict the
structure of the intermolecular complex formed
between two or more molecules
• Docking algorithms are able to generate a large
number of possible structures
• We use force field based strategy to carry out
docking
13
Molecular Docking by Saramita
Chakravarti
Oxygen transport molecule (101M) with
surface and myoglobin ligand
14
Molecular Docking by Saramita
Chakravarti
Influenza virus b/beijing/1/87 neuraminidase
complexed with zanamivir
15
Molecular Docking by Saramita
Chakravarti
Influenza virus b/beijing/1/87 neuraminidase
complexed with zanamivir
16
Molecular Docking by Saramita
Chakravarti
Plasma alpha antithrombin-iii and pentasaccharide
protein with heparin ligand
17
Molecular Docking by Saramita
Chakravarti
Steps of molecular docking
• Three steps
(1) Definition of the structure of the target
molecule
(2) Location of the binding site
(3) Determination of the binding mode
18
Molecular Docking by Saramita
Chakravarti
Best ways to put two molecules together
–Need to quantify or rank solutions
–Scoring function or force field
–Experimental structure may be amongst one
of several predicted solutions
-Need a Search method
19
Molecular Docking by Saramita
Chakravarti
Questions
• Search
–What is it?
–When/why and which search?
• Scoring
–What is it?
• Dimensionality
–Why is this important?
20
Molecular Docking by Saramita
Chakravarti
Spectrum of search
• Local
– Molecular Mechanics
• Short - Medium
– Monte Carlo Simulated Annealing
– Brownian Dynamics
– Molecular Dynamics
• Global
– Docking
21
Molecular Docking by Saramita
Chakravarti
Details of search
Level-of-Detail
• Atom types
• Terms of force field
– Bond stretching
– Bond-angle bending
– Torsional potentials
– Polarizability terms
– Implicit solvation
22
Molecular Docking by Saramita
Chakravarti
Kinds of search
Systematic
• Exhaustive
• Deterministic
• Dependent on granularity of sampling
• Feasible only for low-dimensional
problems
• DOF, 6D search
23
Molecular Docking by Saramita
Chakravarti
Kinds of search
Stochastic
• Random
• Outcome varies
• Repeat to improve chances of success
• Feasible for higher-dimensional problems
• AutoDock, < ~40D search
24
Molecular Docking by Saramita
Chakravarti
Stochastic search methods
• Simulated Annealing (SA)
• Evolutionary Algorithms (EA)
–Genetic Algorithm (GA)
• Others
–Tabu Search (TS)
• Hybrid Global-Local Search
–Lamarckian GA (LGA)
25
Molecular Docking by Saramita
Chakravarti
Simulated annealing
• One copy of the ligand (Population = 1)
• Starts from a random or specific
postion/orientation/conformation (=state)
• Constant temperature annealing cycle
(Accepted & Rejected Moves)
• Temperature reduced before next cycle
• Stops at maximum cycles
26
Molecular Docking by Saramita
Chakravarti
Search parameters
Simulated Annealing
• Initial temperature (K)
• Temperature reduction factor (K-1
cycle)
• Termination criteria:
– accepted moves
– rejected moves
– cycles
27
Molecular Docking by Saramita
Chakravarti
Genetic function algorithm
• Start with a random population (50-200)
• Perform Crossover (Sex, two parents -> 2
children) and Mutation (Cosmic rays, one
individual gives 1 mutant child)
• Compute fitness of each individual
• Proportional Selection & Elitism
• New Generation begins if total energy
evals or maximum generations reached
28
Molecular Docking by Saramita
Chakravarti
Search parameters
• Population size
• Crossover rate
• Mutation rate
• Local search
–energy evals
• Termination criteria
–energy evals
–generations
29
Molecular Docking by Saramita
Chakravarti
Dimensionality of molecular docking
• Degrees of Freedom (DOF)
• Position or Translation
–(x,y,z) = 3
• Orientation or Quaternion
–(qx, qy, qz, qw) = 4
• Rotatable Bonds or Torsions
–(tor1, tor2, … torn) = n
• Total DOF, or Dimensionality,
D = 3 + 4 + n 30
Molecular Docking by Saramita
Chakravarti
Docking score
DGbinding = DGvdW + DGelec + DGhbond + DGdesolv+ DGtors
DGvdW
12-6 Lennard-Jones potential
• DGelec
Coulombic with Solmajer-dielectric
• DGhbond
12-10 Potential with Goodford Directionality
• DGdesolv
Stouten Pairwise Atomic Solvation Parameters
• DGtors
Number of rotatable bonds
31
Molecular Docking by Saramita
Chakravarti
Molecular mechanics: theory
• Considering the simple harmonic
approximation, the potential
energy of molecules is given by
V= VBond+ VAngle + VTorsion + Vvdw +
Velec+ Vop
• VBond = ∑1/2Kr (rij-r0)2
• Where Kr is the stretching force
constant
• VAngle =∑1/2Kθ (θijk-θ0)2
• Where Kθ is the bending force
constant
• VTorsion =∑V/2 (1+ Cos n(ϕ+ϕ0))
• Where V is the barrier to rotation,
ϕ is torsional angle
32
Molecular Docking by Saramita
Chakravarti
Molecular mechanics: Theory
• Lennard-Jones type of 6-12 potential is used to
describe non-bonded and weak interaction
• Vvdw= ∑(Aij/rij
12
-Bij/rij
6
)
• Simple Columbic potential is used to describe
electrostatic interaction
• Velec=∑(qiqj/εrij)
• Out of plane bending/deformation is described
by the following expression
• Vop= 0.5 Kop δ2
33
Molecular Docking by Saramita
Chakravarti
34
Molecular Docking by Saramita
Chakravarti
The forcefield
• The purpose of a forcefield is to describe the potential
energy surface of entire classes of molecules with
reasonable accuracy
• In a sense, the forcefield extrapolates from the
empirical data of the small set of models used to
parameterize it, a larger set of related models
• Some forcefields aim for high accuracy for a limited set
of elements, thus enabling good predictions of many
molecular properties
• Others aim for the broadest possible coverage of the
periodic table, with necessarily lower accuracy
35
Molecular Docking by Saramita
Chakravarti
Components of a forcefield
• The forcefield contains all the necessary elements for
calculations of energy and force:
– A list of forcefield types
– A list of partial charges
• Forcefield-typing rules
– Functional forms for the components of the energy
expression
• Parameters for the function terms
– For some forcefields, rules for generating parameters that
have not been explicitly defined
– For some forcefields, a way of assigning functional forms
and parameters
36
Molecular Docking by Saramita
Chakravarti
The energy expression
37
Molecular Docking by Saramita
Chakravarti
Valence interactions
• The energy of valence interactions is generally accounted for
by diagonal terms:
– bond stretching (bond)
– valence angle bending (angle)
– dihedral angle torsion (torsion)
– inversion, also called out-of-plane interactions (oop)
terms, which are part of nearly all forcefields for covalent
systems
– A Urey-Bradley (UB) term may be used to account for
interactions between atom pairs involved in 1-3
configurations (i.e., atoms bound to a common atom)
• Evalence=Ebond + Eangle + Etorsion+ Eoop + EUB
38
Molecular Docking by Saramita
Chakravarti
Non-bond interactions
• The energy of interactions between non-bonded
atoms is accounted for by
• van der Waals (vdW)
• electrostatic (Coulomb)
• hydrogen bond (hbond) terms in some older
forcefields
• Enon-bond=EvdW + ECoulomb + Ehbond
39
Molecular Docking by Saramita
Chakravarti
Molecular dynamics (MD)
simulations
• A deterministic method based
on the solution of Newton’s
equation of motion
Fi = miai
for the ith
particle; the
acceleration at each step is
calculated from the negative
gradient of the overall
potential, using
Fi = - grad Vi - = - ∇ Vi
Vi = Sk(energies of
interactions between i and all
other residues k located
within a cutoff distance of Rc
from i) 40
Molecular Docking by Saramita
Chakravarti
Classical molecular dynamics
• Constituent molecules obey
classical laws of motion
• In MD simulation, we have to solve
Newton's equation of motion
• Force calculation is the time
consuming part of the simulation
• MD simulation can be performed in
various ensembles
• NVT, NPT and NVE are the
ensembles widely used in the MD
simulations
• Both quantum and classical
potentials can be used to perform
MD simulation 41
Molecular Docking by Saramita
Chakravarti
Calculation of interaction energy
• MM total energy can be used to get interaction
energy of the ligands with biomolecules
• In order to compute the interaction energy,
calculations have to be performed for the
biomolecule, ligands and the biomolecule-ligand
adduct using the same force field
• Eint= Ecomplex - {Ebiomolecule+Eligand}
42
Molecular Docking by Saramita
Chakravarti
Integration of equation of motion
and time step
• A key parameter in the integration algorithm is the
integration time step
• The time step is related to molecular vibration
• The main limitation imposed by the highest-frequency
motion
• The vibrational period must be split into at least 8-10
segments for models to satisfy the Verlet algorithm that
the velocities and accelerations are constant over time step
used
• In most organic models, the highest vibrational frequency
is that of C-H stretching, whose period is of the order of
10-14
s (10fs). Therefore integration step should be 0.5-1 fs
43
Molecular Docking by Saramita
Chakravarti
Stages and duration in MD
simulation
• Dynamics simulations are usually carried out in two
stages, equilibration and data collection
• The purpose of the equilibration is to prepare the system
so that it comes to the most probable configuration
consistent with the target temperature and pressure
• For large system, the equilibration takes long time
because of the vast conformational space it has to search
• The best way to judge whether a model has equilibrated
is to plot various thermodynamic quantities such as
energy, temperature, pressure versus time
• When equilibrated, the system fluctuate around their
average
44
Molecular Docking by Saramita
Chakravarti
Durations of some real molecular
events
Event Approximate duration
Bond stretching 1-20 fs
Elastic domain modes 100 fs to several ps
Water reorientation 4 ps
Inter-domain bending 10 ps-100 ns
Globular protein tumbling 1-10 ns
Aromatic ring flipping 100 µs to several seconds
Allosteric shifts 2 µs to several seconds
Local denaturation 1 ms to several seconds
45
Molecular Docking by Saramita
Chakravarti
Free energy simulations
• Ability to predict binding energy
• Free energy perturbation and
thermodynamic integration
• Computational demand and issues related
to sampling prevent this technique in
probing structure based drug design
• Free Energy equation
46
Molecular Docking by Saramita
Chakravarti
De nova design of inhibitor for HIV-I protease
• An impressive example of the application
of SBDD is was the design of the HIV-I
protease inhibitor
47
Molecular Docking by Saramita
Chakravarti
De nova design
• It is a member of the aspartyl protease family
with the two active sites
• Structure has tetra coordinated water molecules
tat accepted two hydrogen bond from the
backbone amide hydrogens of isoleucine in the
flaps
• Two hydrogen bonds to the carbonyl oxygens of
the inhibitor
48
Molecular Docking by Saramita
Chakravarti
Application of structure based drug
design: HIV protease inhibitors
• The starting point is the series of X-
ray structures of the enzyme and
enzyme-inhibitor complex
• The enzyme is made up of two equal
halves
• HIV protease is a symmetrical
molecule with two equal halves and
an active site near its center like
butterfly
• For most such symmetrical
molecules, both halves have a
"business area," or active site, that
carries out the enzyme's job
• But HIV protease has only one such
active site in the center of the
molecule where the two halves meet 49
Molecular Docking by Saramita
Chakravarti
Structure based drug design: HIV
protease inhibitors
• The single active site was plugged with a small
molecule so that it is possible shut down the whole
enzyme and theoretically stop the virus' spread in
the body
• Several Inhibitors have been designed based on
–Peptidic inhibitor
–Peptidomemitic compounds
–Non-peptide inhibitors
• Further work has demonstrated the success of this
approach 50
Molecular Docking by Saramita
Chakravarti
Some examples
• Ritonavir (trade name Norvir) is one of a class
of anti-HIV drugs called protease inhibitors
• Saquinavir
• Indinavir is another example of very potent
peptidomimetic compound discovered using the
elements of 3D structure and Structure Activity
Relationship (SAR)
51
Molecular Docking by Saramita
Chakravarti
De nova design…
• The first step was a 3D database search of
a subset of the Cambridge Structural
Database
• The pharmacophore for this search
comprised of two hydrophobic groups and
a hydrogen bond donor or acceptor
• The hydrophobic groups were intented to
bind to the catalytic asp residues
52
Molecular Docking by Saramita
Chakravarti
De nova design…
• The search yielded the hit which contained
desired element of the pharmacophore but it also
had oxygen that could replace the bound water
molecules
• The benzene ring in the original compound was
changed to a cyclohexanone, which was able to
position substituents in a more fitting manner
• The DuPont Merck group had explored a series
of peptide based diols that were potent inhibitors
but with poor oral bioavailability
53
Molecular Docking by Saramita
Chakravarti
De nova design
• They have retained the diol functionality and
expanded the six me member ring to a seven
membered diol
• The ketone was changed to cyclic urea to
enhance the hydrogen bonding to the flaps and
to help synthesis
• The compound chosen further studies including
clinical trails was p-hydroxymethylbenzyl
derivative
54
Molecular Docking by Saramita
Chakravarti
P1
’
P1
H-bond donor or acceptor
3.5-6.5Å 3.5-6.5Å
8.5-12Å
Symmetric diol docked into
HIV active site
3D pharmacophore
3D hit
Initial
idea for
inhibitor
Expand ring to give diol
and incorporate urea
Stereochemistry required
for optimal binding
Final Molecule selected
for clinical Trials
55
Molecular Docking by Saramita
Chakravarti
Host-Guest Interactions with
Collagen: As molecules
Dominated by Geometrical factors and
Solvent Accessible Volumes
56
Molecular Docking by Saramita
Chakravarti
Energy minimized structure of 24-mer
collagen triple helix
57
Molecular Docking by Saramita
Chakravarti
Aspargine of T.Helix
and gallic acid
Aspartic acid of
T.Helix and catechin
Complex Formation of poly phenols at
various collagen sites
Lysine of T.Helix and
epigallocatechingallate
58
Molecular Docking by Saramita
Chakravarti
Binding Sites in
triple helix
Binding Energy (Kcal/mol)
Gallic acid
(Gal)
Catechin (Cat)
Epigallocatechi
ngallate
(EGCG)
Pentagalloyl
glucose (PGG)
9th
residue Ser
of C-chain (α2
) 16.5 22.5 35.2 56.6
6th
residue Hyp
of A-chain (α1
) 14.5 20.8 34.5 48.4
12th
residue Lys
of B-chain (α1
) 19.2 23.8 37.9 41.1
21st
residue Asp
of A-chain (α1
) 18.4 20.0 38.2 59.8
17th
residue Asn
of C-chain (α2
) 14.1 23.7 34.3 52.8
Binding energies different complexesBinding energies different complexes
between polyphenols and triple helixbetween polyphenols and triple helix
59
Molecular Docking by Saramita
Chakravarti
Interfacial interacting volume Vs BindingInterfacial interacting volume Vs Binding
energy of the collagen-poly phenol complexenergy of the collagen-poly phenol complex
Interacting Interfacial Volume (Å3
)
60
Molecular Docking by Saramita
Chakravarti
Effective solvent inaccessible contact volumeEffective solvent inaccessible contact volume
Vs Binding energy of the collagen-poly phenolVs Binding energy of the collagen-poly phenol
complexcomplex
Inset: effective solvent inaccessible contact surface area Vs Binding energy of the complex
61
Molecular Docking by Saramita
Chakravarti
Plot of inverse of interacting interfacial volumePlot of inverse of interacting interfacial volume
(1/Int.Vol.) Vs inverse of binding energy(1/B.E) of the(1/Int.Vol.) Vs inverse of binding energy(1/B.E) of the
complexescomplexes
62
Molecular Docking by Saramita
Chakravarti
Acknowledgement
• Mr. R. Parthasarathi
• Mr. B. Madhan
• Mr. J. Padmanabhan
• Mr. M. Elango
• Mr. S. Sundar Raman
• Mr. R. Vijayraj
• CSIR & DST, GOI
• MD, S V Chembiotech.
63
Molecular Docking by Saramita
Chakravarti
Big Thank You
Others have done the work. Some
have used the work. I have
spoken only on behalf of their
behalf.
64
Molecular Docking by Saramita
Chakravarti

More Related Content

What's hot

Molecular docking by harendra ...power point presentation
Molecular docking by harendra ...power point presentationMolecular docking by harendra ...power point presentation
Molecular docking by harendra ...power point presentationHarendra Bisht
 
energy minimization
energy minimizationenergy minimization
energy minimizationpradeep kore
 
De novo drug design
De novo drug designDe novo drug design
De novo drug designmojdeh y
 
Molecular docking
Molecular dockingMolecular docking
Molecular dockingpalliyath91
 
QSAR statistical methods for drug discovery(pharmacology m.pharm2nd sem)
QSAR statistical methods for drug discovery(pharmacology m.pharm2nd sem)QSAR statistical methods for drug discovery(pharmacology m.pharm2nd sem)
QSAR statistical methods for drug discovery(pharmacology m.pharm2nd sem)Satigayatri
 
Basics Of Molecular Docking
Basics Of Molecular DockingBasics Of Molecular Docking
Basics Of Molecular DockingSatarupa Deb
 
Presentation on insilico drug design and virtual screening
Presentation on insilico drug design and virtual screeningPresentation on insilico drug design and virtual screening
Presentation on insilico drug design and virtual screeningJoon Jyoti Sahariah
 
CoMFA CoMFA Comparative Molecular Field Analysis)
CoMFA CoMFA Comparative Molecular Field Analysis)CoMFA CoMFA Comparative Molecular Field Analysis)
CoMFA CoMFA Comparative Molecular Field Analysis)Pinky Vincent
 
Energy minimization methods - Molecular Modeling
Energy minimization methods - Molecular ModelingEnergy minimization methods - Molecular Modeling
Energy minimization methods - Molecular ModelingChandni Pathak
 
Traditional and Rational Drug Designing
Traditional and Rational Drug DesigningTraditional and Rational Drug Designing
Traditional and Rational Drug DesigningManish Kumar
 
Quantitative Structure Activity Relationship (QSAR)
Quantitative Structure Activity Relationship (QSAR)Quantitative Structure Activity Relationship (QSAR)
Quantitative Structure Activity Relationship (QSAR)Theabhi.in
 
Target identification
Target identificationTarget identification
Target identificationSachin Jangra
 
Pharmacophore modeling
Pharmacophore modelingPharmacophore modeling
Pharmacophore modelingDevika Rana
 

What's hot (20)

Molecular docking by harendra ...power point presentation
Molecular docking by harendra ...power point presentationMolecular docking by harendra ...power point presentation
Molecular docking by harendra ...power point presentation
 
docking
docking docking
docking
 
energy minimization
energy minimizationenergy minimization
energy minimization
 
3d qsar
3d qsar3d qsar
3d qsar
 
Rational drug design
Rational drug designRational drug design
Rational drug design
 
Virtual sreening
Virtual sreeningVirtual sreening
Virtual sreening
 
De novo drug design
De novo drug designDe novo drug design
De novo drug design
 
Molecular docking
Molecular dockingMolecular docking
Molecular docking
 
QSAR statistical methods for drug discovery(pharmacology m.pharm2nd sem)
QSAR statistical methods for drug discovery(pharmacology m.pharm2nd sem)QSAR statistical methods for drug discovery(pharmacology m.pharm2nd sem)
QSAR statistical methods for drug discovery(pharmacology m.pharm2nd sem)
 
Basics Of Molecular Docking
Basics Of Molecular DockingBasics Of Molecular Docking
Basics Of Molecular Docking
 
Presentation on insilico drug design and virtual screening
Presentation on insilico drug design and virtual screeningPresentation on insilico drug design and virtual screening
Presentation on insilico drug design and virtual screening
 
Molecular docking
Molecular dockingMolecular docking
Molecular docking
 
CoMFA CoMFA Comparative Molecular Field Analysis)
CoMFA CoMFA Comparative Molecular Field Analysis)CoMFA CoMFA Comparative Molecular Field Analysis)
CoMFA CoMFA Comparative Molecular Field Analysis)
 
Energy minimization methods - Molecular Modeling
Energy minimization methods - Molecular ModelingEnergy minimization methods - Molecular Modeling
Energy minimization methods - Molecular Modeling
 
Traditional and Rational Drug Designing
Traditional and Rational Drug DesigningTraditional and Rational Drug Designing
Traditional and Rational Drug Designing
 
Quantitative Structure Activity Relationship (QSAR)
Quantitative Structure Activity Relationship (QSAR)Quantitative Structure Activity Relationship (QSAR)
Quantitative Structure Activity Relationship (QSAR)
 
Denovo Drug Design
Denovo Drug DesignDenovo Drug Design
Denovo Drug Design
 
Target identification
Target identificationTarget identification
Target identification
 
Pharmacophore modeling
Pharmacophore modelingPharmacophore modeling
Pharmacophore modeling
 
De novo drug design
De novo drug designDe novo drug design
De novo drug design
 

Viewers also liked

Viewers also liked (10)

Phase rule
Phase rulePhase rule
Phase rule
 
phase rule & phase diagram
phase rule & phase diagramphase rule & phase diagram
phase rule & phase diagram
 
05 k-means clustering
05 k-means clustering05 k-means clustering
05 k-means clustering
 
The phase rule
The phase ruleThe phase rule
The phase rule
 
Coacervation Phase Separation Techniques
Coacervation Phase Separation TechniquesCoacervation Phase Separation Techniques
Coacervation Phase Separation Techniques
 
Phase Diagrams and Phase Rule
Phase Diagrams and Phase RulePhase Diagrams and Phase Rule
Phase Diagrams and Phase Rule
 
K means clustering algorithm
K means clustering algorithmK means clustering algorithm
K means clustering algorithm
 
K mean-clustering algorithm
K mean-clustering algorithmK mean-clustering algorithm
K mean-clustering algorithm
 
K means Clustering
K means ClusteringK means Clustering
K means Clustering
 
K means Clustering Algorithm
K means Clustering AlgorithmK means Clustering Algorithm
K means Clustering Algorithm
 

Similar to MOLECULAR DOCKING

Computer aided drug design
Computer aided drug designComputer aided drug design
Computer aided drug designN K
 
cadd-191129134050 (1).pptx
cadd-191129134050 (1).pptxcadd-191129134050 (1).pptx
cadd-191129134050 (1).pptxNoorelhuda2
 
Quantative Structure-Activity Relationships (QSAR)
Quantative Structure-Activity Relationships (QSAR)Quantative Structure-Activity Relationships (QSAR)
Quantative Structure-Activity Relationships (QSAR)Atai Rabby
 
P. Joshi SBDD and docking.ppt
P. Joshi SBDD and docking.pptP. Joshi SBDD and docking.ppt
P. Joshi SBDD and docking.pptpranalpatilPranal
 
Drug development approaches
Drug development approaches Drug development approaches
Drug development approaches VIOLINA KALITA
 
Cadd and molecular modeling for M.Pharm
Cadd and molecular modeling for M.PharmCadd and molecular modeling for M.Pharm
Cadd and molecular modeling for M.PharmShikha Popali
 
1 -val_gillet_-_ligand-based_and_structure-based_virtual_screening
1  -val_gillet_-_ligand-based_and_structure-based_virtual_screening1  -val_gillet_-_ligand-based_and_structure-based_virtual_screening
1 -val_gillet_-_ligand-based_and_structure-based_virtual_screeningDeependra Ban
 
Molecular modelling for in silico drug discovery
Molecular modelling for in silico drug discoveryMolecular modelling for in silico drug discovery
Molecular modelling for in silico drug discoveryLee Larcombe
 
Structure based drug design- kiranmayi
Structure based drug design- kiranmayiStructure based drug design- kiranmayi
Structure based drug design- kiranmayiKiranmayiKnv
 
Virtual screening of chemicals for endocrine disrupting activity: Case studie...
Virtual screening of chemicals for endocrine disrupting activity: Case studie...Virtual screening of chemicals for endocrine disrupting activity: Case studie...
Virtual screening of chemicals for endocrine disrupting activity: Case studie...Kamel Mansouri
 
molecular docking screnning. pptx
molecular docking screnning. pptxmolecular docking screnning. pptx
molecular docking screnning. pptxPraveen kumar S
 
Fragments for drug discovery and chemical biology
Fragments for drug discovery and chemical biologyFragments for drug discovery and chemical biology
Fragments for drug discovery and chemical biologywarwick_amr
 
Conformational analysis
Conformational analysisConformational analysis
Conformational analysisPinky Vincent
 
Using open bioactivity data for developing machine-learning prediction models...
Using open bioactivity data for developing machine-learning prediction models...Using open bioactivity data for developing machine-learning prediction models...
Using open bioactivity data for developing machine-learning prediction models...Sunghwan Kim
 
Structure based computer aided drug design
Structure based computer aided drug designStructure based computer aided drug design
Structure based computer aided drug designThanh Truong
 

Similar to MOLECULAR DOCKING (20)

Computer aided drug design
Computer aided drug designComputer aided drug design
Computer aided drug design
 
Computer aided Drug designing (CADD)
Computer aided Drug designing (CADD)Computer aided Drug designing (CADD)
Computer aided Drug designing (CADD)
 
cadd-191129134050 (1).pptx
cadd-191129134050 (1).pptxcadd-191129134050 (1).pptx
cadd-191129134050 (1).pptx
 
Quantative Structure-Activity Relationships (QSAR)
Quantative Structure-Activity Relationships (QSAR)Quantative Structure-Activity Relationships (QSAR)
Quantative Structure-Activity Relationships (QSAR)
 
Computer aided drug design
Computer aided drug designComputer aided drug design
Computer aided drug design
 
CADD
CADDCADD
CADD
 
Drug design
Drug designDrug design
Drug design
 
P. Joshi SBDD and docking.ppt
P. Joshi SBDD and docking.pptP. Joshi SBDD and docking.ppt
P. Joshi SBDD and docking.ppt
 
Drug development approaches
Drug development approaches Drug development approaches
Drug development approaches
 
Cadd and molecular modeling for M.Pharm
Cadd and molecular modeling for M.PharmCadd and molecular modeling for M.Pharm
Cadd and molecular modeling for M.Pharm
 
1 -val_gillet_-_ligand-based_and_structure-based_virtual_screening
1  -val_gillet_-_ligand-based_and_structure-based_virtual_screening1  -val_gillet_-_ligand-based_and_structure-based_virtual_screening
1 -val_gillet_-_ligand-based_and_structure-based_virtual_screening
 
Molecular modelling for in silico drug discovery
Molecular modelling for in silico drug discoveryMolecular modelling for in silico drug discovery
Molecular modelling for in silico drug discovery
 
Structure based drug design- kiranmayi
Structure based drug design- kiranmayiStructure based drug design- kiranmayi
Structure based drug design- kiranmayi
 
Qsar
QsarQsar
Qsar
 
Virtual screening of chemicals for endocrine disrupting activity: Case studie...
Virtual screening of chemicals for endocrine disrupting activity: Case studie...Virtual screening of chemicals for endocrine disrupting activity: Case studie...
Virtual screening of chemicals for endocrine disrupting activity: Case studie...
 
molecular docking screnning. pptx
molecular docking screnning. pptxmolecular docking screnning. pptx
molecular docking screnning. pptx
 
Fragments for drug discovery and chemical biology
Fragments for drug discovery and chemical biologyFragments for drug discovery and chemical biology
Fragments for drug discovery and chemical biology
 
Conformational analysis
Conformational analysisConformational analysis
Conformational analysis
 
Using open bioactivity data for developing machine-learning prediction models...
Using open bioactivity data for developing machine-learning prediction models...Using open bioactivity data for developing machine-learning prediction models...
Using open bioactivity data for developing machine-learning prediction models...
 
Structure based computer aided drug design
Structure based computer aided drug designStructure based computer aided drug design
Structure based computer aided drug design
 

More from Saramita De Chakravarti

More from Saramita De Chakravarti (7)

Data Retrieval Systems
Data Retrieval SystemsData Retrieval Systems
Data Retrieval Systems
 
Protein Structure, Databases and Structural Alignment
Protein Structure, Databases and Structural AlignmentProtein Structure, Databases and Structural Alignment
Protein Structure, Databases and Structural Alignment
 
Protein docking
Protein dockingProtein docking
Protein docking
 
QSAR : Activity Relationships Quantitative Structure
QSAR : Activity Relationships Quantitative StructureQSAR : Activity Relationships Quantitative Structure
QSAR : Activity Relationships Quantitative Structure
 
Molecular Markers: Major Applications in Insects
Molecular Markers: Major Applications in InsectsMolecular Markers: Major Applications in Insects
Molecular Markers: Major Applications in Insects
 
OLFACTION
OLFACTIONOLFACTION
OLFACTION
 
Synthesis and Actions of Juvenile Hormones In Insect Development (MS Power…
Synthesis and Actions of Juvenile Hormones In Insect Development (MS Power…Synthesis and Actions of Juvenile Hormones In Insect Development (MS Power…
Synthesis and Actions of Juvenile Hormones In Insect Development (MS Power…
 

Recently uploaded

31 ĐỀ THI THỬ VÀO LỚP 10 - TIẾNG ANH - FORM MỚI 2025 - 40 CÂU HỎI - BÙI VĂN V...
31 ĐỀ THI THỬ VÀO LỚP 10 - TIẾNG ANH - FORM MỚI 2025 - 40 CÂU HỎI - BÙI VĂN V...31 ĐỀ THI THỬ VÀO LỚP 10 - TIẾNG ANH - FORM MỚI 2025 - 40 CÂU HỎI - BÙI VĂN V...
31 ĐỀ THI THỬ VÀO LỚP 10 - TIẾNG ANH - FORM MỚI 2025 - 40 CÂU HỎI - BÙI VĂN V...Nguyen Thanh Tu Collection
 
Q4-PPT-Music9_Lesson-1-Romantic-Opera.pptx
Q4-PPT-Music9_Lesson-1-Romantic-Opera.pptxQ4-PPT-Music9_Lesson-1-Romantic-Opera.pptx
Q4-PPT-Music9_Lesson-1-Romantic-Opera.pptxlancelewisportillo
 
BIOCHEMISTRY-CARBOHYDRATE METABOLISM CHAPTER 2.pptx
BIOCHEMISTRY-CARBOHYDRATE METABOLISM CHAPTER 2.pptxBIOCHEMISTRY-CARBOHYDRATE METABOLISM CHAPTER 2.pptx
BIOCHEMISTRY-CARBOHYDRATE METABOLISM CHAPTER 2.pptxSayali Powar
 
4.16.24 21st Century Movements for Black Lives.pptx
4.16.24 21st Century Movements for Black Lives.pptx4.16.24 21st Century Movements for Black Lives.pptx
4.16.24 21st Century Movements for Black Lives.pptxmary850239
 
ICS2208 Lecture6 Notes for SL spaces.pdf
ICS2208 Lecture6 Notes for SL spaces.pdfICS2208 Lecture6 Notes for SL spaces.pdf
ICS2208 Lecture6 Notes for SL spaces.pdfVanessa Camilleri
 
ESP 4-EDITED.pdfmmcncncncmcmmnmnmncnmncmnnjvnnv
ESP 4-EDITED.pdfmmcncncncmcmmnmnmncnmncmnnjvnnvESP 4-EDITED.pdfmmcncncncmcmmnmnmncnmncmnnjvnnv
ESP 4-EDITED.pdfmmcncncncmcmmnmnmncnmncmnnjvnnvRicaMaeCastro1
 
How to Make a Duplicate of Your Odoo 17 Database
How to Make a Duplicate of Your Odoo 17 DatabaseHow to Make a Duplicate of Your Odoo 17 Database
How to Make a Duplicate of Your Odoo 17 DatabaseCeline George
 
Beauty Amidst the Bytes_ Unearthing Unexpected Advantages of the Digital Wast...
Beauty Amidst the Bytes_ Unearthing Unexpected Advantages of the Digital Wast...Beauty Amidst the Bytes_ Unearthing Unexpected Advantages of the Digital Wast...
Beauty Amidst the Bytes_ Unearthing Unexpected Advantages of the Digital Wast...DhatriParmar
 
Team Lead Succeed – Helping you and your team achieve high-performance teamwo...
Team Lead Succeed – Helping you and your team achieve high-performance teamwo...Team Lead Succeed – Helping you and your team achieve high-performance teamwo...
Team Lead Succeed – Helping you and your team achieve high-performance teamwo...Association for Project Management
 
Mental Health Awareness - a toolkit for supporting young minds
Mental Health Awareness - a toolkit for supporting young mindsMental Health Awareness - a toolkit for supporting young minds
Mental Health Awareness - a toolkit for supporting young mindsPooky Knightsmith
 
week 1 cookery 8 fourth - quarter .pptx
week 1 cookery 8  fourth  -  quarter .pptxweek 1 cookery 8  fourth  -  quarter .pptx
week 1 cookery 8 fourth - quarter .pptxJonalynLegaspi2
 
ROLES IN A STAGE PRODUCTION in arts.pptx
ROLES IN A STAGE PRODUCTION in arts.pptxROLES IN A STAGE PRODUCTION in arts.pptx
ROLES IN A STAGE PRODUCTION in arts.pptxVanesaIglesias10
 
Narcotic and Non Narcotic Analgesic..pdf
Narcotic and Non Narcotic Analgesic..pdfNarcotic and Non Narcotic Analgesic..pdf
Narcotic and Non Narcotic Analgesic..pdfPrerana Jadhav
 
Reading and Writing Skills 11 quarter 4 melc 1
Reading and Writing Skills 11 quarter 4 melc 1Reading and Writing Skills 11 quarter 4 melc 1
Reading and Writing Skills 11 quarter 4 melc 1GloryAnnCastre1
 
Unraveling Hypertext_ Analyzing Postmodern Elements in Literature.pptx
Unraveling Hypertext_ Analyzing  Postmodern Elements in  Literature.pptxUnraveling Hypertext_ Analyzing  Postmodern Elements in  Literature.pptx
Unraveling Hypertext_ Analyzing Postmodern Elements in Literature.pptxDhatriParmar
 
Grade Three -ELLNA-REVIEWER-ENGLISH.pptx
Grade Three -ELLNA-REVIEWER-ENGLISH.pptxGrade Three -ELLNA-REVIEWER-ENGLISH.pptx
Grade Three -ELLNA-REVIEWER-ENGLISH.pptxkarenfajardo43
 

Recently uploaded (20)

31 ĐỀ THI THỬ VÀO LỚP 10 - TIẾNG ANH - FORM MỚI 2025 - 40 CÂU HỎI - BÙI VĂN V...
31 ĐỀ THI THỬ VÀO LỚP 10 - TIẾNG ANH - FORM MỚI 2025 - 40 CÂU HỎI - BÙI VĂN V...31 ĐỀ THI THỬ VÀO LỚP 10 - TIẾNG ANH - FORM MỚI 2025 - 40 CÂU HỎI - BÙI VĂN V...
31 ĐỀ THI THỬ VÀO LỚP 10 - TIẾNG ANH - FORM MỚI 2025 - 40 CÂU HỎI - BÙI VĂN V...
 
Q4-PPT-Music9_Lesson-1-Romantic-Opera.pptx
Q4-PPT-Music9_Lesson-1-Romantic-Opera.pptxQ4-PPT-Music9_Lesson-1-Romantic-Opera.pptx
Q4-PPT-Music9_Lesson-1-Romantic-Opera.pptx
 
BIOCHEMISTRY-CARBOHYDRATE METABOLISM CHAPTER 2.pptx
BIOCHEMISTRY-CARBOHYDRATE METABOLISM CHAPTER 2.pptxBIOCHEMISTRY-CARBOHYDRATE METABOLISM CHAPTER 2.pptx
BIOCHEMISTRY-CARBOHYDRATE METABOLISM CHAPTER 2.pptx
 
4.16.24 21st Century Movements for Black Lives.pptx
4.16.24 21st Century Movements for Black Lives.pptx4.16.24 21st Century Movements for Black Lives.pptx
4.16.24 21st Century Movements for Black Lives.pptx
 
Mattingly "AI & Prompt Design: Large Language Models"
Mattingly "AI & Prompt Design: Large Language Models"Mattingly "AI & Prompt Design: Large Language Models"
Mattingly "AI & Prompt Design: Large Language Models"
 
ICS2208 Lecture6 Notes for SL spaces.pdf
ICS2208 Lecture6 Notes for SL spaces.pdfICS2208 Lecture6 Notes for SL spaces.pdf
ICS2208 Lecture6 Notes for SL spaces.pdf
 
ESP 4-EDITED.pdfmmcncncncmcmmnmnmncnmncmnnjvnnv
ESP 4-EDITED.pdfmmcncncncmcmmnmnmncnmncmnnjvnnvESP 4-EDITED.pdfmmcncncncmcmmnmnmncnmncmnnjvnnv
ESP 4-EDITED.pdfmmcncncncmcmmnmnmncnmncmnnjvnnv
 
Faculty Profile prashantha K EEE dept Sri Sairam college of Engineering
Faculty Profile prashantha K EEE dept Sri Sairam college of EngineeringFaculty Profile prashantha K EEE dept Sri Sairam college of Engineering
Faculty Profile prashantha K EEE dept Sri Sairam college of Engineering
 
How to Make a Duplicate of Your Odoo 17 Database
How to Make a Duplicate of Your Odoo 17 DatabaseHow to Make a Duplicate of Your Odoo 17 Database
How to Make a Duplicate of Your Odoo 17 Database
 
Beauty Amidst the Bytes_ Unearthing Unexpected Advantages of the Digital Wast...
Beauty Amidst the Bytes_ Unearthing Unexpected Advantages of the Digital Wast...Beauty Amidst the Bytes_ Unearthing Unexpected Advantages of the Digital Wast...
Beauty Amidst the Bytes_ Unearthing Unexpected Advantages of the Digital Wast...
 
Team Lead Succeed – Helping you and your team achieve high-performance teamwo...
Team Lead Succeed – Helping you and your team achieve high-performance teamwo...Team Lead Succeed – Helping you and your team achieve high-performance teamwo...
Team Lead Succeed – Helping you and your team achieve high-performance teamwo...
 
Mental Health Awareness - a toolkit for supporting young minds
Mental Health Awareness - a toolkit for supporting young mindsMental Health Awareness - a toolkit for supporting young minds
Mental Health Awareness - a toolkit for supporting young minds
 
INCLUSIVE EDUCATION PRACTICES FOR TEACHERS AND TRAINERS.pptx
INCLUSIVE EDUCATION PRACTICES FOR TEACHERS AND TRAINERS.pptxINCLUSIVE EDUCATION PRACTICES FOR TEACHERS AND TRAINERS.pptx
INCLUSIVE EDUCATION PRACTICES FOR TEACHERS AND TRAINERS.pptx
 
week 1 cookery 8 fourth - quarter .pptx
week 1 cookery 8  fourth  -  quarter .pptxweek 1 cookery 8  fourth  -  quarter .pptx
week 1 cookery 8 fourth - quarter .pptx
 
prashanth updated resume 2024 for Teaching Profession
prashanth updated resume 2024 for Teaching Professionprashanth updated resume 2024 for Teaching Profession
prashanth updated resume 2024 for Teaching Profession
 
ROLES IN A STAGE PRODUCTION in arts.pptx
ROLES IN A STAGE PRODUCTION in arts.pptxROLES IN A STAGE PRODUCTION in arts.pptx
ROLES IN A STAGE PRODUCTION in arts.pptx
 
Narcotic and Non Narcotic Analgesic..pdf
Narcotic and Non Narcotic Analgesic..pdfNarcotic and Non Narcotic Analgesic..pdf
Narcotic and Non Narcotic Analgesic..pdf
 
Reading and Writing Skills 11 quarter 4 melc 1
Reading and Writing Skills 11 quarter 4 melc 1Reading and Writing Skills 11 quarter 4 melc 1
Reading and Writing Skills 11 quarter 4 melc 1
 
Unraveling Hypertext_ Analyzing Postmodern Elements in Literature.pptx
Unraveling Hypertext_ Analyzing  Postmodern Elements in  Literature.pptxUnraveling Hypertext_ Analyzing  Postmodern Elements in  Literature.pptx
Unraveling Hypertext_ Analyzing Postmodern Elements in Literature.pptx
 
Grade Three -ELLNA-REVIEWER-ENGLISH.pptx
Grade Three -ELLNA-REVIEWER-ENGLISH.pptxGrade Three -ELLNA-REVIEWER-ENGLISH.pptx
Grade Three -ELLNA-REVIEWER-ENGLISH.pptx
 

MOLECULAR DOCKING

  • 1. MOLECULAR DOCKING Saramita De Chakravarti Computational Biology Laboratory S V Chembiotech, Bangalore saramita16@chembiotech.com 1Molecular Docking by Saramita Chakravarti
  • 2. Introduction • Drug discovery  take years to decade for discovering a new drug and very costly • Effort  to cut down the research timeline and cost by reducing wet-lab experiment  use computer modeling 2 Molecular Docking by Saramita Chakravarti
  • 3. Drug discovery Chemical + biological system  desired response? 3 Molecular Docking by Saramita Chakravarti
  • 4. TRADITIONAL DRUG DESIGN Lead generation: Natural ligand / Screening Biological Testing Synthesis of New Compounds Drug Design CycleDrug Design Cycle If promising Pre-Clinical Studies 4Molecular Docking by Saramita Chakravarti
  • 5. Finding lead compound • A lead compound is a small molecule that serves as the starting point for an optimization involving many small molecules that are closely related in structure to the lead compound • Many organizations maintain databases of chemical compounds • Some of these are publically accessible others are proprietary • Databases contain an extremely large number of compounds (ACS data bases contains 10 million compounds) • 3D databases have information about chemical and geometrical features » Hydrogen bond donors » Hydrogen bond acceptors » Positive Charge Centers » Aromatic ring centers » Hydrophobic centers 5 Molecular Docking by Saramita Chakravarti
  • 6. Finding lead compound • There are two approaches to this problem –A computer program AutoDock (or similar version Affinity (accelrys)) can be used to search a database by generating “fit” between molecule and the receptor –Alternatively one can search 3D pharmacophore 6 Molecular Docking by Saramita Chakravarti
  • 7. Structure based drug design • Drug design and development • Structure based drug design exploits the 3D structure of the target or a pharmacophore –Find a molecule which would be expected to interact with the receptor. (Searching a data base) –Design entirely a new molecule from “SCRATCH” (de novo drug/ligand design) • In this context bioinformatics and chemoinformatics play a crucial role 7 Molecular Docking by Saramita Chakravarti
  • 8. Structure-based Drug Design (SBDD) Molecular Biology & Protein Chemistry 3D Structure Determination of Target and Target-Ligand Complex Modelling Structure Analysis and Compound Design Biological Testing Synthesis of New Compounds If promising Pre-Clinical Studies Drug Design CycleDrug Design Cycle Natural ligand / Screening 8 Molecular Docking by Saramita Chakravarti
  • 9. Structure based drug design • SBDD: • drug targets (usually proteins) • binding of ligands to the target (docking) ↓ “rational” drug design (benefits = saved time and $$) 9 Molecular Docking by Saramita Chakravarti
  • 10. Select and Purify the target protein Model inhibitor with computational tools Synthesis, Evaluate preclinical, clinical, invitro, invivo, cells, animals, & humans Drug Schematics for structure based drug designSchematics for structure based drug design Obtain known inhibitor X-Ray structural determination of native protein X-Ray structural determination of inhibitor complex Determine IC50 Structure Based Drug Design have the potential to shave off years and millions of dollars 10 Molecular Docking by Saramita Chakravarti
  • 11. Working at the intersection • Structural Biology • Biochemistry • Medicinal Chemistry • Toxicology • Pharmacology • Biophysical Chemistry • Natural Products Chemistry • Chemical Ecology • Information Technology 11 Molecular Docking by Saramita Chakravarti
  • 12. Molecular docking-definition • It is a process by which two molecules are put together in 3 Dimension • Best ways to put two molecules together • Using molecular modeling and computational chemistry tools 12 Molecular Docking by Saramita Chakravarti
  • 13. Molecular docking • Docking used for finding binding modes of protein with ligands/inhibitors • In molecular docking, we attempt to predict the structure of the intermolecular complex formed between two or more molecules • Docking algorithms are able to generate a large number of possible structures • We use force field based strategy to carry out docking 13 Molecular Docking by Saramita Chakravarti
  • 14. Oxygen transport molecule (101M) with surface and myoglobin ligand 14 Molecular Docking by Saramita Chakravarti
  • 15. Influenza virus b/beijing/1/87 neuraminidase complexed with zanamivir 15 Molecular Docking by Saramita Chakravarti
  • 16. Influenza virus b/beijing/1/87 neuraminidase complexed with zanamivir 16 Molecular Docking by Saramita Chakravarti
  • 17. Plasma alpha antithrombin-iii and pentasaccharide protein with heparin ligand 17 Molecular Docking by Saramita Chakravarti
  • 18. Steps of molecular docking • Three steps (1) Definition of the structure of the target molecule (2) Location of the binding site (3) Determination of the binding mode 18 Molecular Docking by Saramita Chakravarti
  • 19. Best ways to put two molecules together –Need to quantify or rank solutions –Scoring function or force field –Experimental structure may be amongst one of several predicted solutions -Need a Search method 19 Molecular Docking by Saramita Chakravarti
  • 20. Questions • Search –What is it? –When/why and which search? • Scoring –What is it? • Dimensionality –Why is this important? 20 Molecular Docking by Saramita Chakravarti
  • 21. Spectrum of search • Local – Molecular Mechanics • Short - Medium – Monte Carlo Simulated Annealing – Brownian Dynamics – Molecular Dynamics • Global – Docking 21 Molecular Docking by Saramita Chakravarti
  • 22. Details of search Level-of-Detail • Atom types • Terms of force field – Bond stretching – Bond-angle bending – Torsional potentials – Polarizability terms – Implicit solvation 22 Molecular Docking by Saramita Chakravarti
  • 23. Kinds of search Systematic • Exhaustive • Deterministic • Dependent on granularity of sampling • Feasible only for low-dimensional problems • DOF, 6D search 23 Molecular Docking by Saramita Chakravarti
  • 24. Kinds of search Stochastic • Random • Outcome varies • Repeat to improve chances of success • Feasible for higher-dimensional problems • AutoDock, < ~40D search 24 Molecular Docking by Saramita Chakravarti
  • 25. Stochastic search methods • Simulated Annealing (SA) • Evolutionary Algorithms (EA) –Genetic Algorithm (GA) • Others –Tabu Search (TS) • Hybrid Global-Local Search –Lamarckian GA (LGA) 25 Molecular Docking by Saramita Chakravarti
  • 26. Simulated annealing • One copy of the ligand (Population = 1) • Starts from a random or specific postion/orientation/conformation (=state) • Constant temperature annealing cycle (Accepted & Rejected Moves) • Temperature reduced before next cycle • Stops at maximum cycles 26 Molecular Docking by Saramita Chakravarti
  • 27. Search parameters Simulated Annealing • Initial temperature (K) • Temperature reduction factor (K-1 cycle) • Termination criteria: – accepted moves – rejected moves – cycles 27 Molecular Docking by Saramita Chakravarti
  • 28. Genetic function algorithm • Start with a random population (50-200) • Perform Crossover (Sex, two parents -> 2 children) and Mutation (Cosmic rays, one individual gives 1 mutant child) • Compute fitness of each individual • Proportional Selection & Elitism • New Generation begins if total energy evals or maximum generations reached 28 Molecular Docking by Saramita Chakravarti
  • 29. Search parameters • Population size • Crossover rate • Mutation rate • Local search –energy evals • Termination criteria –energy evals –generations 29 Molecular Docking by Saramita Chakravarti
  • 30. Dimensionality of molecular docking • Degrees of Freedom (DOF) • Position or Translation –(x,y,z) = 3 • Orientation or Quaternion –(qx, qy, qz, qw) = 4 • Rotatable Bonds or Torsions –(tor1, tor2, … torn) = n • Total DOF, or Dimensionality, D = 3 + 4 + n 30 Molecular Docking by Saramita Chakravarti
  • 31. Docking score DGbinding = DGvdW + DGelec + DGhbond + DGdesolv+ DGtors DGvdW 12-6 Lennard-Jones potential • DGelec Coulombic with Solmajer-dielectric • DGhbond 12-10 Potential with Goodford Directionality • DGdesolv Stouten Pairwise Atomic Solvation Parameters • DGtors Number of rotatable bonds 31 Molecular Docking by Saramita Chakravarti
  • 32. Molecular mechanics: theory • Considering the simple harmonic approximation, the potential energy of molecules is given by V= VBond+ VAngle + VTorsion + Vvdw + Velec+ Vop • VBond = ∑1/2Kr (rij-r0)2 • Where Kr is the stretching force constant • VAngle =∑1/2Kθ (θijk-θ0)2 • Where Kθ is the bending force constant • VTorsion =∑V/2 (1+ Cos n(ϕ+ϕ0)) • Where V is the barrier to rotation, ϕ is torsional angle 32 Molecular Docking by Saramita Chakravarti
  • 33. Molecular mechanics: Theory • Lennard-Jones type of 6-12 potential is used to describe non-bonded and weak interaction • Vvdw= ∑(Aij/rij 12 -Bij/rij 6 ) • Simple Columbic potential is used to describe electrostatic interaction • Velec=∑(qiqj/εrij) • Out of plane bending/deformation is described by the following expression • Vop= 0.5 Kop δ2 33 Molecular Docking by Saramita Chakravarti
  • 34. 34 Molecular Docking by Saramita Chakravarti
  • 35. The forcefield • The purpose of a forcefield is to describe the potential energy surface of entire classes of molecules with reasonable accuracy • In a sense, the forcefield extrapolates from the empirical data of the small set of models used to parameterize it, a larger set of related models • Some forcefields aim for high accuracy for a limited set of elements, thus enabling good predictions of many molecular properties • Others aim for the broadest possible coverage of the periodic table, with necessarily lower accuracy 35 Molecular Docking by Saramita Chakravarti
  • 36. Components of a forcefield • The forcefield contains all the necessary elements for calculations of energy and force: – A list of forcefield types – A list of partial charges • Forcefield-typing rules – Functional forms for the components of the energy expression • Parameters for the function terms – For some forcefields, rules for generating parameters that have not been explicitly defined – For some forcefields, a way of assigning functional forms and parameters 36 Molecular Docking by Saramita Chakravarti
  • 37. The energy expression 37 Molecular Docking by Saramita Chakravarti
  • 38. Valence interactions • The energy of valence interactions is generally accounted for by diagonal terms: – bond stretching (bond) – valence angle bending (angle) – dihedral angle torsion (torsion) – inversion, also called out-of-plane interactions (oop) terms, which are part of nearly all forcefields for covalent systems – A Urey-Bradley (UB) term may be used to account for interactions between atom pairs involved in 1-3 configurations (i.e., atoms bound to a common atom) • Evalence=Ebond + Eangle + Etorsion+ Eoop + EUB 38 Molecular Docking by Saramita Chakravarti
  • 39. Non-bond interactions • The energy of interactions between non-bonded atoms is accounted for by • van der Waals (vdW) • electrostatic (Coulomb) • hydrogen bond (hbond) terms in some older forcefields • Enon-bond=EvdW + ECoulomb + Ehbond 39 Molecular Docking by Saramita Chakravarti
  • 40. Molecular dynamics (MD) simulations • A deterministic method based on the solution of Newton’s equation of motion Fi = miai for the ith particle; the acceleration at each step is calculated from the negative gradient of the overall potential, using Fi = - grad Vi - = - ∇ Vi Vi = Sk(energies of interactions between i and all other residues k located within a cutoff distance of Rc from i) 40 Molecular Docking by Saramita Chakravarti
  • 41. Classical molecular dynamics • Constituent molecules obey classical laws of motion • In MD simulation, we have to solve Newton's equation of motion • Force calculation is the time consuming part of the simulation • MD simulation can be performed in various ensembles • NVT, NPT and NVE are the ensembles widely used in the MD simulations • Both quantum and classical potentials can be used to perform MD simulation 41 Molecular Docking by Saramita Chakravarti
  • 42. Calculation of interaction energy • MM total energy can be used to get interaction energy of the ligands with biomolecules • In order to compute the interaction energy, calculations have to be performed for the biomolecule, ligands and the biomolecule-ligand adduct using the same force field • Eint= Ecomplex - {Ebiomolecule+Eligand} 42 Molecular Docking by Saramita Chakravarti
  • 43. Integration of equation of motion and time step • A key parameter in the integration algorithm is the integration time step • The time step is related to molecular vibration • The main limitation imposed by the highest-frequency motion • The vibrational period must be split into at least 8-10 segments for models to satisfy the Verlet algorithm that the velocities and accelerations are constant over time step used • In most organic models, the highest vibrational frequency is that of C-H stretching, whose period is of the order of 10-14 s (10fs). Therefore integration step should be 0.5-1 fs 43 Molecular Docking by Saramita Chakravarti
  • 44. Stages and duration in MD simulation • Dynamics simulations are usually carried out in two stages, equilibration and data collection • The purpose of the equilibration is to prepare the system so that it comes to the most probable configuration consistent with the target temperature and pressure • For large system, the equilibration takes long time because of the vast conformational space it has to search • The best way to judge whether a model has equilibrated is to plot various thermodynamic quantities such as energy, temperature, pressure versus time • When equilibrated, the system fluctuate around their average 44 Molecular Docking by Saramita Chakravarti
  • 45. Durations of some real molecular events Event Approximate duration Bond stretching 1-20 fs Elastic domain modes 100 fs to several ps Water reorientation 4 ps Inter-domain bending 10 ps-100 ns Globular protein tumbling 1-10 ns Aromatic ring flipping 100 µs to several seconds Allosteric shifts 2 µs to several seconds Local denaturation 1 ms to several seconds 45 Molecular Docking by Saramita Chakravarti
  • 46. Free energy simulations • Ability to predict binding energy • Free energy perturbation and thermodynamic integration • Computational demand and issues related to sampling prevent this technique in probing structure based drug design • Free Energy equation 46 Molecular Docking by Saramita Chakravarti
  • 47. De nova design of inhibitor for HIV-I protease • An impressive example of the application of SBDD is was the design of the HIV-I protease inhibitor 47 Molecular Docking by Saramita Chakravarti
  • 48. De nova design • It is a member of the aspartyl protease family with the two active sites • Structure has tetra coordinated water molecules tat accepted two hydrogen bond from the backbone amide hydrogens of isoleucine in the flaps • Two hydrogen bonds to the carbonyl oxygens of the inhibitor 48 Molecular Docking by Saramita Chakravarti
  • 49. Application of structure based drug design: HIV protease inhibitors • The starting point is the series of X- ray structures of the enzyme and enzyme-inhibitor complex • The enzyme is made up of two equal halves • HIV protease is a symmetrical molecule with two equal halves and an active site near its center like butterfly • For most such symmetrical molecules, both halves have a "business area," or active site, that carries out the enzyme's job • But HIV protease has only one such active site in the center of the molecule where the two halves meet 49 Molecular Docking by Saramita Chakravarti
  • 50. Structure based drug design: HIV protease inhibitors • The single active site was plugged with a small molecule so that it is possible shut down the whole enzyme and theoretically stop the virus' spread in the body • Several Inhibitors have been designed based on –Peptidic inhibitor –Peptidomemitic compounds –Non-peptide inhibitors • Further work has demonstrated the success of this approach 50 Molecular Docking by Saramita Chakravarti
  • 51. Some examples • Ritonavir (trade name Norvir) is one of a class of anti-HIV drugs called protease inhibitors • Saquinavir • Indinavir is another example of very potent peptidomimetic compound discovered using the elements of 3D structure and Structure Activity Relationship (SAR) 51 Molecular Docking by Saramita Chakravarti
  • 52. De nova design… • The first step was a 3D database search of a subset of the Cambridge Structural Database • The pharmacophore for this search comprised of two hydrophobic groups and a hydrogen bond donor or acceptor • The hydrophobic groups were intented to bind to the catalytic asp residues 52 Molecular Docking by Saramita Chakravarti
  • 53. De nova design… • The search yielded the hit which contained desired element of the pharmacophore but it also had oxygen that could replace the bound water molecules • The benzene ring in the original compound was changed to a cyclohexanone, which was able to position substituents in a more fitting manner • The DuPont Merck group had explored a series of peptide based diols that were potent inhibitors but with poor oral bioavailability 53 Molecular Docking by Saramita Chakravarti
  • 54. De nova design • They have retained the diol functionality and expanded the six me member ring to a seven membered diol • The ketone was changed to cyclic urea to enhance the hydrogen bonding to the flaps and to help synthesis • The compound chosen further studies including clinical trails was p-hydroxymethylbenzyl derivative 54 Molecular Docking by Saramita Chakravarti
  • 55. P1 ’ P1 H-bond donor or acceptor 3.5-6.5Å 3.5-6.5Å 8.5-12Å Symmetric diol docked into HIV active site 3D pharmacophore 3D hit Initial idea for inhibitor Expand ring to give diol and incorporate urea Stereochemistry required for optimal binding Final Molecule selected for clinical Trials 55 Molecular Docking by Saramita Chakravarti
  • 56. Host-Guest Interactions with Collagen: As molecules Dominated by Geometrical factors and Solvent Accessible Volumes 56 Molecular Docking by Saramita Chakravarti
  • 57. Energy minimized structure of 24-mer collagen triple helix 57 Molecular Docking by Saramita Chakravarti
  • 58. Aspargine of T.Helix and gallic acid Aspartic acid of T.Helix and catechin Complex Formation of poly phenols at various collagen sites Lysine of T.Helix and epigallocatechingallate 58 Molecular Docking by Saramita Chakravarti
  • 59. Binding Sites in triple helix Binding Energy (Kcal/mol) Gallic acid (Gal) Catechin (Cat) Epigallocatechi ngallate (EGCG) Pentagalloyl glucose (PGG) 9th residue Ser of C-chain (α2 ) 16.5 22.5 35.2 56.6 6th residue Hyp of A-chain (α1 ) 14.5 20.8 34.5 48.4 12th residue Lys of B-chain (α1 ) 19.2 23.8 37.9 41.1 21st residue Asp of A-chain (α1 ) 18.4 20.0 38.2 59.8 17th residue Asn of C-chain (α2 ) 14.1 23.7 34.3 52.8 Binding energies different complexesBinding energies different complexes between polyphenols and triple helixbetween polyphenols and triple helix 59 Molecular Docking by Saramita Chakravarti
  • 60. Interfacial interacting volume Vs BindingInterfacial interacting volume Vs Binding energy of the collagen-poly phenol complexenergy of the collagen-poly phenol complex Interacting Interfacial Volume (Å3 ) 60 Molecular Docking by Saramita Chakravarti
  • 61. Effective solvent inaccessible contact volumeEffective solvent inaccessible contact volume Vs Binding energy of the collagen-poly phenolVs Binding energy of the collagen-poly phenol complexcomplex Inset: effective solvent inaccessible contact surface area Vs Binding energy of the complex 61 Molecular Docking by Saramita Chakravarti
  • 62. Plot of inverse of interacting interfacial volumePlot of inverse of interacting interfacial volume (1/Int.Vol.) Vs inverse of binding energy(1/B.E) of the(1/Int.Vol.) Vs inverse of binding energy(1/B.E) of the complexescomplexes 62 Molecular Docking by Saramita Chakravarti
  • 63. Acknowledgement • Mr. R. Parthasarathi • Mr. B. Madhan • Mr. J. Padmanabhan • Mr. M. Elango • Mr. S. Sundar Raman • Mr. R. Vijayraj • CSIR & DST, GOI • MD, S V Chembiotech. 63 Molecular Docking by Saramita Chakravarti
  • 64. Big Thank You Others have done the work. Some have used the work. I have spoken only on behalf of their behalf. 64 Molecular Docking by Saramita Chakravarti