SlideShare a Scribd company logo
1 of 21
Download to read offline
Molecular Representa/on, 
  Similarity and Search 
          Rajarshi Guha 
   NIH Chemical Genomics Center 

         December 3rd, 2009 
Outline 
•  How can we represent molecules on a 
   computer? 
•  How do we decide when molecules are 
   similar? 
•  What can we do using similarity? 
Molecular Representa/ons 
•  Explicit  
   –  Indicate what the atoms are, what atom is connected 
      to what other atom(s) 
   –  Differing levels of explicitness 
       •  Do we need to show hydrogens? 
       •  Do we need to indicate actual bonds? 
•  Implicit 
   –  Usually very compact (e.g., SMILES) 
   –  Need to know the assump/ons involved 
       •  In SMILES, no specific bond symbol implies single bond 
2D Representa/ons ‐ Topological 
•  (Usually) indicates what types of atoms are 
   present 
•  Indicates which atoms are connected to which 
   other atoms 
•  No indica/on of where these atoms are 
   located in space 
•  Very easy to store, manipulate 
                      Cl
3D Representa/ons ‐ Geometric 
•  Similar to 2D, but now has 
   explicit 3D coordinates 
•  More complex – a molecule 
   can have mul/ple sets of 3D 
   coordinates (conforma/ons) 
  –  Which is the correct one? 
•  Takes more space to store, 
   /me consuming to generate 
Molecular Similarity 
       •  Many, many ways to determine how similar 
          two molecules are 
       •  A simple, manual approach is to look at a 2D 
          depic/on 
       •  But what are we looking at?  




Willet, J Chem Inf Comput Sci, 1998, 38, 983-996
Sheridan et al, Drug Discov Today, 2002, 7, 903-911
Molecular Similarity 
•  But 2D can be misleading 
•  Iden/cal in 2D is not necessarily so in 3D 
How Do We Quan/fy Similarity? 
•  1D similarity can be computed just by using 
   SMILES, similar to sequence alignment – 
   LINGO, Holograms 
•  2D similarity is commonly measured using 
   binary fingerprints 
  –  Key based fingerprints 
  –  Hashed fingerprints 
How Do We Quan/fy Similarity? 
•  Given 2 fingerprints we can then calculate a 
   variety of similarity func/ons 
•  Tanimoto is the most commonly used 
  –  Ranges from 0 to 1  
  –  A measure of the number of bits common to both 
     fingerprints 
  –  See Daylight for more details 
•  Can also be extended to 3D similari/es 
How Do We Quan/fy Similarity? 
•  3D similarity  is more complex 
•  Most methods require you to align two 3D 
   structures 
•  Then determine the “volume overlap” 
  –  To what extent do the two structures occupy the 
     same region in space 
•  Most well known tool for this is ROCS 
How Do We Quan/fy Similarity? 
•  Property based similarity will use various 
   physical proper/es or biological ac/vi/es 
  –  If two molecules exhibit similar ac/vity across 
     mul/ple cell lines, they are likely similar 
  –  If two molecules have a set of similar physical 
     proper/es (computed or experimental) they are 
     likely similar 
2D or 3D? 
•  Fast and easy          •  More “accurate” 
•  Not always             •  Computa/onally 
   biological relevant       more expensive 
•  But surprisingly       •  Which 
   useful                    conforma/on is the 
                             correct one? 

  Different representations and similarity
  methods will, in general, lead to different
                results (hits)
What Can We Do With Similarity? 
•  Searching databases – exact substructure 
   searching is not always useful 
•  Using the benzodiazepine substructure would              
   miss midazolam 
•  But, the 2D similarity  
                                           O                N
                                   H
                                   N



   between these two 
                                                        N




   structures is rela/vely 
                                       N

                                               Cl           N


   high                                                         F




                               Query                Midazolam
But 2D Only Goes So Far … 
•  Using the tradi/onal benzodiazepine core won’t 
   let you retrieve atypical benzodiazepines 
•  In this case, the 2D similarity 
   between this and the  
   usual core is low 
•  But in terms of shape they are 
   quite similar                           Ambien
•  (Ambien occupies the same region of the GABA 
   receptor as tradi8onal benzodiazepines)  
Virtual Screening 
                                            Sheridan et al, Drug Discov Today, 2002, 7, 903-911



•  In many cases the ques/on we’re 
   asking is 
   •  Find me other ac2ve molecules 
•  A good star/ng point is to look for 
   structurally similar molecules 
•  We assume that molecules with 
   similar structures will exhibit 
   similar ac/vites 
   –  J. Med. Chem., 2002, 45, 4350‐4358 
   –  The basis of predic/ve modeling 
   –  But lots and lots of excep/ons! 
Virtual Screening 
•  2D similarity is a cheap, easy and fast way to 
   perform this type of task 
•  Can “screen” databases of many millions of 
   molecules extremely rapidly 
•  Usually only consider “very similar” (Tc >= 0.85) 
   hits 
•  It works … 
Virtual Screening 
•  But can be of limited use if used naively 
  –  Similarity is usually supplanted by machine learning 
  –  S/ll, the only way out if there is no receptor and 
     only a few (or a single) known ac/ves 
•  Main drawback is that the hits are structurally 
   similar 
  –  D’oh! 
  –  Not great if you’re trying to find a molecule that 
     someone else hasn’t already developed 
Scaffold Hopping 
•  Ideally, we’d like to find a molecule that is as 
   ac/ve as our query, but with a different core 
   structure 
•  Solving this usually requires us to go to 3D 
   –  Structures can differ in  
      connec/vity 
   –  But exhibit similar shapes 
•  Being able to do this in 2D is 
   an interes/ng research topic 
   (cf reduced graphs)               Bergmann et al, J Chem Inf Model, 2009, 49, 658-669
Dissimilarity & Library Design 
•  Chemical libraries form the basis of high 
   throughput screening and other discovery 
   methods 
•  Sizes can range from a few hundred molecules 
   to millions (or billions for virtual libraries) 
•  In most cases, we want to cover as much of 
   chemical space as possible 
  –  How do we compare coverage? 
  –  So if we want to add new molecules, how do we 
     choose them? 
Dissimilarity & Library Design 
•  Brute force 
   –  Evaluate similarity between 
      new molecules and the 
      library and keep those with 
      low Tc 
•  Sophis/cated 
   –  Use sta/s/cal techniques to 
      effec/vely sample different 
      regions of a chemical space 
   –  Fill in the “holes” 
Summary 
•  Similarity (and dissimilarity) are  
   fundamental concepts 
   –  Simple on the outside, complex on the inside 
•  A wide variety of methods available 
   –  Need to consider pros/cons in terms of 
      computa/onal expense, chemical u/lity, … 
•  Visualizing similarity is useful 
•  Many problems can be recast in terms of 
   similarity or dissimilarity 

More Related Content

What's hot

Conformational analysis
Conformational analysisConformational analysis
Conformational analysis
Pinky Vincent
 

What's hot (20)

Molecular modeling in drug design
Molecular modeling in drug designMolecular modeling in drug design
Molecular modeling in drug design
 
7.local and global minima
7.local and global minima7.local and global minima
7.local and global minima
 
Conformational analysis
Conformational analysisConformational analysis
Conformational analysis
 
Energy minimization
Energy minimizationEnergy minimization
Energy minimization
 
Homology modeling of proteins (ppt)
Homology modeling of proteins (ppt)Homology modeling of proteins (ppt)
Homology modeling of proteins (ppt)
 
Chemo informatics scope and applications
Chemo informatics scope and applicationsChemo informatics scope and applications
Chemo informatics scope and applications
 
Cheminformatics: An overview
Cheminformatics: An overviewCheminformatics: An overview
Cheminformatics: An overview
 
Lecture 9 molecular descriptors
Lecture 9  molecular descriptorsLecture 9  molecular descriptors
Lecture 9 molecular descriptors
 
Molecular modelling
Molecular modelling Molecular modelling
Molecular modelling
 
Homology modeling
Homology modelingHomology modeling
Homology modeling
 
Computational Drug Design
Computational Drug DesignComputational Drug Design
Computational Drug Design
 
Protein function prediction
Protein function predictionProtein function prediction
Protein function prediction
 
Scoring function
Scoring functionScoring function
Scoring function
 
MOLECULAR DOCKING
MOLECULAR DOCKINGMOLECULAR DOCKING
MOLECULAR DOCKING
 
Structure based drug design
Structure based drug designStructure based drug design
Structure based drug design
 
Molecular docking and_virtual_screening
Molecular docking and_virtual_screeningMolecular docking and_virtual_screening
Molecular docking and_virtual_screening
 
Threading modeling methods
Threading modeling methodsThreading modeling methods
Threading modeling methods
 
Molecular docking
Molecular dockingMolecular docking
Molecular docking
 
Cheminformatics in drug design
Cheminformatics in drug designCheminformatics in drug design
Cheminformatics in drug design
 
Docking
DockingDocking
Docking
 

Viewers also liked

Fingerprinting Chemical Structures
Fingerprinting Chemical StructuresFingerprinting Chemical Structures
Fingerprinting Chemical Structures
Rajarshi Guha
 
Fingerprints
FingerprintsFingerprints
Fingerprints
abelts
 
Application of graph theory in drug design
Application of graph theory in drug designApplication of graph theory in drug design
Application of graph theory in drug design
Reihaneh Safavi
 
Fingerprinting
FingerprintingFingerprinting
Fingerprinting
annperry09
 
Chemoinformatics Practical
Chemoinformatics PracticalChemoinformatics Practical
Chemoinformatics Practical
Puneet Kacker
 

Viewers also liked (20)

Chemoinformatics and information management
Chemoinformatics and information managementChemoinformatics and information management
Chemoinformatics and information management
 
Chemoinformatic
Chemoinformatic Chemoinformatic
Chemoinformatic
 
Fingerprinting Chemical Structures
Fingerprinting Chemical StructuresFingerprinting Chemical Structures
Fingerprinting Chemical Structures
 
Detection of novel metabolites and enzyme functions though in silico expansio...
Detection of novel metabolites and enzyme functions though in silico expansio...Detection of novel metabolites and enzyme functions though in silico expansio...
Detection of novel metabolites and enzyme functions though in silico expansio...
 
Cheminformatics
CheminformaticsCheminformatics
Cheminformatics
 
Fingerprints
FingerprintsFingerprints
Fingerprints
 
Code camp 2014 Talk Scientific Thinking
Code camp 2014 Talk Scientific ThinkingCode camp 2014 Talk Scientific Thinking
Code camp 2014 Talk Scientific Thinking
 
Chem spider introduction spring 2011
Chem spider introduction spring 2011Chem spider introduction spring 2011
Chem spider introduction spring 2011
 
Prediction Of Bioactivity From Chemical Structure
Prediction Of Bioactivity From Chemical StructurePrediction Of Bioactivity From Chemical Structure
Prediction Of Bioactivity From Chemical Structure
 
Chemical features: how do we describe a compound to a computer?
Chemical features: how do we describe a compound to a computer?Chemical features: how do we describe a compound to a computer?
Chemical features: how do we describe a compound to a computer?
 
[ICDE 2012] On Top-k Structural Similarity Search
[ICDE 2012] On Top-k Structural Similarity Search[ICDE 2012] On Top-k Structural Similarity Search
[ICDE 2012] On Top-k Structural Similarity Search
 
EUGM 2013 - Björn Windshügel (European ScreeningPort): Chemoinformatic tools ...
EUGM 2013 - Björn Windshügel (European ScreeningPort): Chemoinformatic tools ...EUGM 2013 - Björn Windshügel (European ScreeningPort): Chemoinformatic tools ...
EUGM 2013 - Björn Windshügel (European ScreeningPort): Chemoinformatic tools ...
 
Cheminformatics in R
Cheminformatics in RCheminformatics in R
Cheminformatics in R
 
Interaction fingerprint: 1D representation of 3D protein-ligand complexes
Interaction fingerprint: 1D representation of 3D protein-ligand complexesInteraction fingerprint: 1D representation of 3D protein-ligand complexes
Interaction fingerprint: 1D representation of 3D protein-ligand complexes
 
Application of graph theory in drug design
Application of graph theory in drug designApplication of graph theory in drug design
Application of graph theory in drug design
 
Bioinformatics and Drug Discovery
Bioinformatics and Drug DiscoveryBioinformatics and Drug Discovery
Bioinformatics and Drug Discovery
 
Fingerprinting
FingerprintingFingerprinting
Fingerprinting
 
Chemoinformatics Practical
Chemoinformatics PracticalChemoinformatics Practical
Chemoinformatics Practical
 
Fingerprints
FingerprintsFingerprints
Fingerprints
 
Advanced Blogging Overview
Advanced Blogging OverviewAdvanced Blogging Overview
Advanced Blogging Overview
 

Similar to Molecular Representation, Similarity and Search

So I have an SD File … What do I do next?
So I have an SD File … What do I do next?So I have an SD File … What do I do next?
So I have an SD File … What do I do next?
Rajarshi Guha
 
Bls 303 l1.phylogenetics
Bls 303 l1.phylogeneticsBls 303 l1.phylogenetics
Bls 303 l1.phylogenetics
Bruno Mmassy
 
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
Deependra Ban
 

Similar to Molecular Representation, Similarity and Search (20)

PacMin @ AMPLab All-Hands
PacMin @ AMPLab All-HandsPacMin @ AMPLab All-Hands
PacMin @ AMPLab All-Hands
 
Core Methods In Educational Data Mining
Core Methods In Educational Data MiningCore Methods In Educational Data Mining
Core Methods In Educational Data Mining
 
Zartler chi fbdd_apr2013
Zartler chi fbdd_apr2013Zartler chi fbdd_apr2013
Zartler chi fbdd_apr2013
 
Understanding Deep Learning Requires Rethinking Generalization
Understanding Deep Learning Requires Rethinking GeneralizationUnderstanding Deep Learning Requires Rethinking Generalization
Understanding Deep Learning Requires Rethinking Generalization
 
13 .x ray ppt.2
13 .x ray  ppt.213 .x ray  ppt.2
13 .x ray ppt.2
 
Protein-ligand docking
Protein-ligand dockingProtein-ligand docking
Protein-ligand docking
 
2012 stamps-mbl-1
2012 stamps-mbl-12012 stamps-mbl-1
2012 stamps-mbl-1
 
Introduction to Hamiltonian Neural Networks
Introduction to Hamiltonian Neural NetworksIntroduction to Hamiltonian Neural Networks
Introduction to Hamiltonian Neural Networks
 
Intro to in silico drug discovery 2014
Intro to in silico drug discovery 2014Intro to in silico drug discovery 2014
Intro to in silico drug discovery 2014
 
Biological Foundations for Deep Learning: Towards Decision Networks
 Biological Foundations for Deep Learning: Towards Decision Networks Biological Foundations for Deep Learning: Towards Decision Networks
Biological Foundations for Deep Learning: Towards Decision Networks
 
So I have an SD File … What do I do next?
So I have an SD File … What do I do next?So I have an SD File … What do I do next?
So I have an SD File … What do I do next?
 
Analogical thinking
Analogical thinkingAnalogical thinking
Analogical thinking
 
Analogy, Causality, and Discovery in Science: The engines of human thought
Analogy, Causality, and Discovery in Science: The engines of human thoughtAnalogy, Causality, and Discovery in Science: The engines of human thought
Analogy, Causality, and Discovery in Science: The engines of human thought
 
Computer vision - light
Computer vision - lightComputer vision - light
Computer vision - light
 
Computational Reproducibility vs. Transparency: Is It FAIR Enough?
Computational Reproducibility vs. Transparency: Is It FAIR Enough?Computational Reproducibility vs. Transparency: Is It FAIR Enough?
Computational Reproducibility vs. Transparency: Is It FAIR Enough?
 
Bls 303 l1.phylogenetics
Bls 303 l1.phylogeneticsBls 303 l1.phylogenetics
Bls 303 l1.phylogenetics
 
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
 
Lec 3 knowledge acquisition representation and inference
Lec 3  knowledge acquisition representation and inferenceLec 3  knowledge acquisition representation and inference
Lec 3 knowledge acquisition representation and inference
 
Wither OWL
Wither OWLWither OWL
Wither OWL
 
Overview of cheminformatics
Overview of cheminformaticsOverview of cheminformatics
Overview of cheminformatics
 

More from Rajarshi Guha

Pharos: A Torch to Use in Your Journey in the Dark Genome
Pharos: A Torch to Use in Your Journey in the Dark GenomePharos: A Torch to Use in Your Journey in the Dark Genome
Pharos: A Torch to Use in Your Journey in the Dark Genome
Rajarshi Guha
 
Pharos: Putting targets in context
Pharos: Putting targets in contextPharos: Putting targets in context
Pharos: Putting targets in context
Rajarshi Guha
 
Pharos – A Torch to Use in Your Journey In the Dark Genome
Pharos – A Torch to Use in Your Journey In the Dark GenomePharos – A Torch to Use in Your Journey In the Dark Genome
Pharos – A Torch to Use in Your Journey In the Dark Genome
Rajarshi Guha
 
Pharos - Face of the KMC
Pharos - Face of the KMCPharos - Face of the KMC
Pharos - Face of the KMC
Rajarshi Guha
 
Enhancing Prioritization & Discovery of Novel Combinations using an HTS Platform
Enhancing Prioritization & Discovery of Novel Combinations using an HTS PlatformEnhancing Prioritization & Discovery of Novel Combinations using an HTS Platform
Enhancing Prioritization & Discovery of Novel Combinations using an HTS Platform
Rajarshi Guha
 
What can your library do for you?
What can your library do for you?What can your library do for you?
What can your library do for you?
Rajarshi Guha
 
Characterization of Chemical Libraries Using Scaffolds and Network Models
Characterization of Chemical Libraries Using Scaffolds and Network ModelsCharacterization of Chemical Libraries Using Scaffolds and Network Models
Characterization of Chemical Libraries Using Scaffolds and Network Models
Rajarshi Guha
 
From Data to Action : Bridging Chemistry and Biology with Informatics at NCATS
From Data to Action: Bridging Chemistry and Biology with Informatics at NCATSFrom Data to Action: Bridging Chemistry and Biology with Informatics at NCATS
From Data to Action : Bridging Chemistry and Biology with Informatics at NCATS
Rajarshi Guha
 
Robots, Small Molecules & R
Robots, Small Molecules & RRobots, Small Molecules & R
Robots, Small Molecules & R
Rajarshi Guha
 
Exploring Compound Combinations in High Throughput Settings: Going Beyond 1D...
Exploring Compound Combinations in High Throughput Settings: Going Beyond 1D...Exploring Compound Combinations in High Throughput Settings: Going Beyond 1D...
Exploring Compound Combinations in High Throughput Settings: Going Beyond 1D...
Rajarshi Guha
 
When the whole is better than the parts
When the whole is better than the partsWhen the whole is better than the parts
When the whole is better than the parts
Rajarshi Guha
 
Exploring Compound Combinations in High Throughput Settings: Going Beyond 1D ...
Exploring Compound Combinations in High Throughput Settings: Going Beyond 1D ...Exploring Compound Combinations in High Throughput Settings: Going Beyond 1D ...
Exploring Compound Combinations in High Throughput Settings: Going Beyond 1D ...
Rajarshi Guha
 
Pushing Chemical Biology Through the Pipes
Pushing Chemical Biology Through the PipesPushing Chemical Biology Through the Pipes
Pushing Chemical Biology Through the Pipes
Rajarshi Guha
 
Characterization and visualization of compound combination responses in a hig...
Characterization and visualization of compound combination responses in a hig...Characterization and visualization of compound combination responses in a hig...
Characterization and visualization of compound combination responses in a hig...
Rajarshi Guha
 
The BioAssay Research Database
The BioAssay Research DatabaseThe BioAssay Research Database
The BioAssay Research Database
Rajarshi Guha
 
Cloudy with a Touch of Cheminformatics
Cloudy with a Touch of CheminformaticsCloudy with a Touch of Cheminformatics
Cloudy with a Touch of Cheminformatics
Rajarshi Guha
 
Chemical Data Mining: Open Source & Reproducible
Chemical Data Mining: Open Source & ReproducibleChemical Data Mining: Open Source & Reproducible
Chemical Data Mining: Open Source & Reproducible
Rajarshi Guha
 
Chemogenomics in the cloud: Is the sky the limit?
Chemogenomics in the cloud: Is the sky the limit?Chemogenomics in the cloud: Is the sky the limit?
Chemogenomics in the cloud: Is the sky the limit?
Rajarshi Guha
 
Quantifying Text Sentiment in R
Quantifying Text Sentiment in RQuantifying Text Sentiment in R
Quantifying Text Sentiment in R
Rajarshi Guha
 
PMML for QSAR Model Exchange
PMML for QSAR Model Exchange PMML for QSAR Model Exchange
PMML for QSAR Model Exchange
Rajarshi Guha
 

More from Rajarshi Guha (20)

Pharos: A Torch to Use in Your Journey in the Dark Genome
Pharos: A Torch to Use in Your Journey in the Dark GenomePharos: A Torch to Use in Your Journey in the Dark Genome
Pharos: A Torch to Use in Your Journey in the Dark Genome
 
Pharos: Putting targets in context
Pharos: Putting targets in contextPharos: Putting targets in context
Pharos: Putting targets in context
 
Pharos – A Torch to Use in Your Journey In the Dark Genome
Pharos – A Torch to Use in Your Journey In the Dark GenomePharos – A Torch to Use in Your Journey In the Dark Genome
Pharos – A Torch to Use in Your Journey In the Dark Genome
 
Pharos - Face of the KMC
Pharos - Face of the KMCPharos - Face of the KMC
Pharos - Face of the KMC
 
Enhancing Prioritization & Discovery of Novel Combinations using an HTS Platform
Enhancing Prioritization & Discovery of Novel Combinations using an HTS PlatformEnhancing Prioritization & Discovery of Novel Combinations using an HTS Platform
Enhancing Prioritization & Discovery of Novel Combinations using an HTS Platform
 
What can your library do for you?
What can your library do for you?What can your library do for you?
What can your library do for you?
 
Characterization of Chemical Libraries Using Scaffolds and Network Models
Characterization of Chemical Libraries Using Scaffolds and Network ModelsCharacterization of Chemical Libraries Using Scaffolds and Network Models
Characterization of Chemical Libraries Using Scaffolds and Network Models
 
From Data to Action : Bridging Chemistry and Biology with Informatics at NCATS
From Data to Action: Bridging Chemistry and Biology with Informatics at NCATSFrom Data to Action: Bridging Chemistry and Biology with Informatics at NCATS
From Data to Action : Bridging Chemistry and Biology with Informatics at NCATS
 
Robots, Small Molecules & R
Robots, Small Molecules & RRobots, Small Molecules & R
Robots, Small Molecules & R
 
Exploring Compound Combinations in High Throughput Settings: Going Beyond 1D...
Exploring Compound Combinations in High Throughput Settings: Going Beyond 1D...Exploring Compound Combinations in High Throughput Settings: Going Beyond 1D...
Exploring Compound Combinations in High Throughput Settings: Going Beyond 1D...
 
When the whole is better than the parts
When the whole is better than the partsWhen the whole is better than the parts
When the whole is better than the parts
 
Exploring Compound Combinations in High Throughput Settings: Going Beyond 1D ...
Exploring Compound Combinations in High Throughput Settings: Going Beyond 1D ...Exploring Compound Combinations in High Throughput Settings: Going Beyond 1D ...
Exploring Compound Combinations in High Throughput Settings: Going Beyond 1D ...
 
Pushing Chemical Biology Through the Pipes
Pushing Chemical Biology Through the PipesPushing Chemical Biology Through the Pipes
Pushing Chemical Biology Through the Pipes
 
Characterization and visualization of compound combination responses in a hig...
Characterization and visualization of compound combination responses in a hig...Characterization and visualization of compound combination responses in a hig...
Characterization and visualization of compound combination responses in a hig...
 
The BioAssay Research Database
The BioAssay Research DatabaseThe BioAssay Research Database
The BioAssay Research Database
 
Cloudy with a Touch of Cheminformatics
Cloudy with a Touch of CheminformaticsCloudy with a Touch of Cheminformatics
Cloudy with a Touch of Cheminformatics
 
Chemical Data Mining: Open Source & Reproducible
Chemical Data Mining: Open Source & ReproducibleChemical Data Mining: Open Source & Reproducible
Chemical Data Mining: Open Source & Reproducible
 
Chemogenomics in the cloud: Is the sky the limit?
Chemogenomics in the cloud: Is the sky the limit?Chemogenomics in the cloud: Is the sky the limit?
Chemogenomics in the cloud: Is the sky the limit?
 
Quantifying Text Sentiment in R
Quantifying Text Sentiment in RQuantifying Text Sentiment in R
Quantifying Text Sentiment in R
 
PMML for QSAR Model Exchange
PMML for QSAR Model Exchange PMML for QSAR Model Exchange
PMML for QSAR Model Exchange
 

Recently uploaded

Activity 01 - Artificial Culture (1).pdf
Activity 01 - Artificial Culture (1).pdfActivity 01 - Artificial Culture (1).pdf
Activity 01 - Artificial Culture (1).pdf
ciinovamais
 
An Overview of Mutual Funds Bcom Project.pdf
An Overview of Mutual Funds Bcom Project.pdfAn Overview of Mutual Funds Bcom Project.pdf
An Overview of Mutual Funds Bcom Project.pdf
SanaAli374401
 
1029-Danh muc Sach Giao Khoa khoi 6.pdf
1029-Danh muc Sach Giao Khoa khoi  6.pdf1029-Danh muc Sach Giao Khoa khoi  6.pdf
1029-Danh muc Sach Giao Khoa khoi 6.pdf
QucHHunhnh
 
Russian Escort Service in Delhi 11k Hotel Foreigner Russian Call Girls in Delhi
Russian Escort Service in Delhi 11k Hotel Foreigner Russian Call Girls in DelhiRussian Escort Service in Delhi 11k Hotel Foreigner Russian Call Girls in Delhi
Russian Escort Service in Delhi 11k Hotel Foreigner Russian Call Girls in Delhi
kauryashika82
 
Making and Justifying Mathematical Decisions.pdf
Making and Justifying Mathematical Decisions.pdfMaking and Justifying Mathematical Decisions.pdf
Making and Justifying Mathematical Decisions.pdf
Chris Hunter
 

Recently uploaded (20)

Application orientated numerical on hev.ppt
Application orientated numerical on hev.pptApplication orientated numerical on hev.ppt
Application orientated numerical on hev.ppt
 
Mixin Classes in Odoo 17 How to Extend Models Using Mixin Classes
Mixin Classes in Odoo 17  How to Extend Models Using Mixin ClassesMixin Classes in Odoo 17  How to Extend Models Using Mixin Classes
Mixin Classes in Odoo 17 How to Extend Models Using Mixin Classes
 
Activity 01 - Artificial Culture (1).pdf
Activity 01 - Artificial Culture (1).pdfActivity 01 - Artificial Culture (1).pdf
Activity 01 - Artificial Culture (1).pdf
 
Class 11th Physics NEET formula sheet pdf
Class 11th Physics NEET formula sheet pdfClass 11th Physics NEET formula sheet pdf
Class 11th Physics NEET formula sheet pdf
 
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
 
APM Welcome, APM North West Network Conference, Synergies Across Sectors
APM Welcome, APM North West Network Conference, Synergies Across SectorsAPM Welcome, APM North West Network Conference, Synergies Across Sectors
APM Welcome, APM North West Network Conference, Synergies Across Sectors
 
Nutritional Needs Presentation - HLTH 104
Nutritional Needs Presentation - HLTH 104Nutritional Needs Presentation - HLTH 104
Nutritional Needs Presentation - HLTH 104
 
An Overview of Mutual Funds Bcom Project.pdf
An Overview of Mutual Funds Bcom Project.pdfAn Overview of Mutual Funds Bcom Project.pdf
An Overview of Mutual Funds Bcom Project.pdf
 
How to Give a Domain for a Field in Odoo 17
How to Give a Domain for a Field in Odoo 17How to Give a Domain for a Field in Odoo 17
How to Give a Domain for a Field in Odoo 17
 
1029-Danh muc Sach Giao Khoa khoi 6.pdf
1029-Danh muc Sach Giao Khoa khoi  6.pdf1029-Danh muc Sach Giao Khoa khoi  6.pdf
1029-Danh muc Sach Giao Khoa khoi 6.pdf
 
Russian Escort Service in Delhi 11k Hotel Foreigner Russian Call Girls in Delhi
Russian Escort Service in Delhi 11k Hotel Foreigner Russian Call Girls in DelhiRussian Escort Service in Delhi 11k Hotel Foreigner Russian Call Girls in Delhi
Russian Escort Service in Delhi 11k Hotel Foreigner Russian Call Girls in Delhi
 
Grant Readiness 101 TechSoup and Remy Consulting
Grant Readiness 101 TechSoup and Remy ConsultingGrant Readiness 101 TechSoup and Remy Consulting
Grant Readiness 101 TechSoup and Remy Consulting
 
Making and Justifying Mathematical Decisions.pdf
Making and Justifying Mathematical Decisions.pdfMaking and Justifying Mathematical Decisions.pdf
Making and Justifying Mathematical Decisions.pdf
 
Advance Mobile Application Development class 07
Advance Mobile Application Development class 07Advance Mobile Application Development class 07
Advance Mobile Application Development class 07
 
SOCIAL AND HISTORICAL CONTEXT - LFTVD.pptx
SOCIAL AND HISTORICAL CONTEXT - LFTVD.pptxSOCIAL AND HISTORICAL CONTEXT - LFTVD.pptx
SOCIAL AND HISTORICAL CONTEXT - LFTVD.pptx
 
Mattingly "AI & Prompt Design: Structured Data, Assistants, & RAG"
Mattingly "AI & Prompt Design: Structured Data, Assistants, & RAG"Mattingly "AI & Prompt Design: Structured Data, Assistants, & RAG"
Mattingly "AI & Prompt Design: Structured Data, Assistants, & RAG"
 
SECOND SEMESTER TOPIC COVERAGE SY 2023-2024 Trends, Networks, and Critical Th...
SECOND SEMESTER TOPIC COVERAGE SY 2023-2024 Trends, Networks, and Critical Th...SECOND SEMESTER TOPIC COVERAGE SY 2023-2024 Trends, Networks, and Critical Th...
SECOND SEMESTER TOPIC COVERAGE SY 2023-2024 Trends, Networks, and Critical Th...
 
Paris 2024 Olympic Geographies - an activity
Paris 2024 Olympic Geographies - an activityParis 2024 Olympic Geographies - an activity
Paris 2024 Olympic Geographies - an activity
 
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
 
Key note speaker Neum_Admir Softic_ENG.pdf
Key note speaker Neum_Admir Softic_ENG.pdfKey note speaker Neum_Admir Softic_ENG.pdf
Key note speaker Neum_Admir Softic_ENG.pdf
 

Molecular Representation, Similarity and Search