Ontological background

Established biomedical ontologies define most terms for entity classes and predicates used in MolMeDB RDF. Other terms have been newly defined in MolMeDB Vocabulary as subclasses of terms from BioAssay Ontology or Units of Measurement Ontology. All ontologies and terms used in MolMeDB RDF dataset are named by IRI identifiers (listed below in Table 1). Each term has a unique identifier, but it is expected that terms from the same ontology share the same prefix. Large or more complex ontologies and datasets sometimes use collections of multiple prefixes for different domains.

Example

- Terms from MolMeDB Vocabulary use the prefix https://rdf.molmedb.upol.cz/vocabulary#.
- The full IRI for a membrane model is https://rdf.molmedb.upol.cz/vocabulary#MembraneModel, and for a penetration barrier it is https://rdf.molmedb.upol.cz/vocabulary#PenetrationBarrier.

Full IRI identifiers can be quite long and too cumbersome to use in texts and SPARQL queries, so it is common to use CURIE compact syntax, which allows for definition of namespace names as shorthands for prefixes. Compact IRI then consists of a namespace name in the place of a prefix, colon (:) separator and a local part. This documentation uses compact IRIs in most examples.

Example

For MolMeDB vocabulary namespace the name mmdbvoc is used in this text. Compact IRI for membrane model is mmdbvoc:MembraneModel, where mmdbvoc stands for the full prefix of the ontology (https://rdf.molmedb.upol.cz/vocabulary#) and MembraneModel is the local part identifying this particular term.

Note that compact IRIs alone are NOT valid IRIs. Any RDF document or SPARQL query using compact syntax needs to define namespace names and their corresponding prefixes. Example of mmdbvoc namespace name definition for MolMeDB Vocabulary in a SPARQL query :

...
PREFIX mmdbvoc: <https://rdf.molmedb.upol.cz/vocabulary#>
...
...
PREFIX
mmdbvoc: <https://rdf.molmedb.upol.cz/vocabulary#>
.
..

Table 1: Ontologies, their namespaces and terms used in MolMeDB RDF.

Ontology Namespace name Prefix
RDF Schema 1.1 rdf:
rdfs:
http://www.w3.org/2000/01/rdf-schema#
http://www.w3.org/1999/02/22-rdf-syntax-ns
rdf:HTML
rdf:type

rdfs:comment
rdfs:label
rdfs:seeAlso
XML Schema Definition Language xsd: http://www.w3.org/2001/XMLSchema#
xsd:int
xsd:float
xsd:string
Simple Knowledge Organization System skos: http://www.w3.org/2004/02/skos/core#
skos:exactMatch
Semanticscience Integrated ontology
Chemical Information Ontology
sio: http://semanticscience.org/resource/
sio:SIO_000008 has attribute
sio:SIO_000089 dataset
sio:SIO_000221 has unit
sio:SIO_000300 has value

sio:CHEMINF_000018 SMILES descriptor
sio:CHEMINF_000059 InChIKey
sio:CHEMINF_000120 charge
s
io:CHEMINF_000140 PubChem compound identifier (CID)
sio:CHEMINF_000216 average molecular weight descriptor
sio:CHEMINF_000251 logP descriptor
sio:CHEMINF_000406 DrugBank identifier
soi:CHEMINF_000407 ChEBI identifier
sio:CHEMINF_000412 ChEMBL identifier
sio:CHEMINF_000571 MolMeDB identifier
sio:CHEMINF_000572 PDB ligand identifier
BioAssay Ontology bao: http://www.bioassayontology.org/bao#
bao:BAO_0000040 measure group
bao:BAO_0000076 screened entity
bao:BAO_0000199 pIC50
bao:BAO_0000208 has endpoint
bao:BAO_0000209 has measure group
bao:BAO_0000212 has assay method
bao:BAO_0000283 transporter
bao:BAO_0000426 is measure group of
bao:BAO_0000559 is endpoint of
bao:BAO_0002182 pharmacokinetic assay
bao:BAO_0002583 pEC50
bao:BAO_0002753 assay method component
bao:BAO_0003008 transporter assay
bao:BAO_0090004 has part
bao:BAO_0090012 has participant
REPRODUCE-ME repr: https://w3id.org/reproduceme#
repr:hasExperimentalCondition
repr:NegativeResult
repr:PositiveResult
Information Artifact Ontology
Units of Measurement Ontology
obo: http://purl.obolibrary.org/obo/
obo:IAO_0000227 terms merged
obo:IAO_0000231 has obsolescence reason
obo:IAO_0100001 term replaced by

obo:UO_0000018 nanometer
obo:UO_0000027 degree Celsius
obo:UO_0000062 molar
obo:UO_0000150 nanosecond
obo:UO_0000185 degree
obo:UO_0000221 dalton
EDAM - The ontology of data analysis and management edam: http://edamontology.org/
edam:data_2291 UniProt ID
Experimental Factor Ontology efo: http://www.ebi.ac.uk/efo/
efo:EFO_0001702
Dublin Core (DC) ontology dc:
dcterms:
http://purl.org/dc/elements/1.1/
http://purl.org/dc/terms/
dc:description

dcterms:bibliographicCitation
dcterms:BibliographicResource
dcterms:isReferencedBy
dcterms:references
dcterms:source
dcterms:subject
Bibliographic Ontology bibo: http://purl.org/ontology/bibo/
bibo:doi
bibo:pmid
PubChem RDF
ChEMBL RDF
ChEBI RDF
wwPDB RDF
UniProt RDF
pubchem:
chembl:
chebi:
*
uniprot:
http://rdf.ncbi.nlm.nih.gov/pubchem/compound/
http://rdf.ebi.ac.uk/resource/chembl/molecule/
http://purl.obolibrary.org/obo/
http://rdf.wwpdb.org/cc/{pdb_ligand_id}/chem_comp/{pdb_ligand_id}
http://purl.uniprot.org/uniprot/
Terms from RDF versions of PubChem, ChEMBL, ChEBI, and wwPDB correspond with molecules and terms from UniProt RDF correspond with transporter proteins. The IRI form for ligands in wwPDB does not support the CURIE syntax for compact IRIs. Therefore no namespace name and IRI pattern are shown for wwPDB.

MolMeDB Vocabulary

MolMeDB vocabulary has been constructed for needs of MolMeDB RDF where needed terms have not been found in already existing ontologies. Terms in the vocabulary can be divided into 4 categories - membrane model types, method types, assay endpoint (result) types and units. First three categories are defined as extensions of BioAssay Ontology (BAO) with relevant BAO terms as root classes and units as extension of Units of Measurement ontology (UO), with “unit” (obo:UO_0000000). This dictionary is not meant to be used in other projects and its terms are intended to be replaced later with relevant terms from BAO and UO (or different estabilished ontology) when they will be introduced.

Membranes and Methods

Both membrane model and method categories have more specific subclasses which are defined in MolMeDB vocabulary for greater ease of querying of assays using similar, but not same methods or membranes. Terms for these types are listed in Table 2 and Table 3. The hierarchy of these terms is designed to represent membrane and method typology used in MolMeDB website (membranes and methods). In the case of membranes we are developing a more robust Membrane Ontology (MEMON) to be used in future versions of MolMeDB dataset.

Table 2.  Membrane subtypes.

Term Name Definition Parent term
mmdbvoc:MembraneModel membrane model Model of biological membrane used in experimental and computational assays of interactions of molecular entities with membranes. Contains biological membranes, lipid membrane models, nonlipid membrane models (eg. octanol) etc. bao:BAO_0003114 (assay biology component) - root term
mmdbvoc:BiologyBasedMembraneModel biology based membrane model Model of a membrane based on biological entities. (note - can be piece of tissue, cell line etc.) mmdbvoc:MembraneModel
mmdbvoc:GenericMembraneModel generic membrane model Model of a membrane without specified anatomical location. mmdbvoc:MembraneModel
mmdbvoc:MembraneModelByLocation membrane model by location Category of membrane model according to where are approximated membranes located anatomically. It can be bound to tissue or cells. mmdbvoc:MembraneModel
mmdbvoc:BrainMembraneModel brain membrane model Model of a membrane located in brain tissue. mmdbvoc:MembraneModelByLocation
mmdbvoc:CellMembraneModel cell membrane model Model of a cell membrane. mmdbvoc:MembraneModelByLocation
mmdbvoc:EyeMembraneModel eye membrane model Model of a membrane located in eye tissue. mmdbvoc:MembraneModelByLocation
mmdbvoc:IntenstineMembraneModel intenstine membrane model Model of a membrane located in intestine tissue. mmdbvoc:MembraneModelByLocation
mmdbvoc:OralMembraneModel oral membrane model Model of a membrane located in mouth tissue. mmdbvoc:MembraneModelByLocation
mmdbvoc:SkinMembraneModel skin membrane model Model of a membrane located in skin tissue. mmdbvoc:MembraneModelByLocation
mmdbvoc:SubstanceBasedMembraneModel substance based membrane model Model of a membrane based on chemical substances mimic biological membranes. (note - Typically octanol, toluene or chloroform or lipid mixture.) mmdbvoc:MembraneModel

Table 3. Method subtypes.

Term Name Definition Parent term
bao:BAO_0002753 assay method component root term
bao:BAO_0002202 assay design method The assay design method describes how a biological or physical process screened / investigated in the model system is translated into a detectable signal. This relates to the technology / technologies used to make the assay system work, i.e. enable that the screened process can be detected. It typically involves some manipulation of the (biological) model system to detect the process of interest. bao:BAO_0002753 (assay method component)
mmdbvoc:MembraneInteractionAssessmentMethod membrane interaction assessment method Experimental method for quantification of interaction between molecule and membrane (e.g. peremability, partition etc.). bao:BAO_0002202 (assay design method)
mmdbvoc:MembranePermeabilityMethod membrae permeability measurement method Method measuring permeability of a molecule across a membrane. mmdbvoc:MembraneInteractionAssessmentMethod
mmdbvoc:MembranePositionMethod position measuring method Method measuring distance of stable position of molecule from the centre of a membrane. mmdbvoc:MembraneInteractionAssessmentMethod
mmdbvoc:WaterMembranePartitioningMethod water/membrane partition measuring method Method measuring partitioning of molecules between water and membrane. mmdbvoc:MembraneInteractionAssessmentMethod
bao:BAO_0002094 computational method Method based on the application of information technology to chemistry and biology. bao:BAO_0002753 (assay method component)
bao:BAO_0002248 cheminformatics method Methods using of computer and informational techniques for problems in the field of chemistry bao:BAO_0002094 (computational metod)
bao:BAO_0002282 computer simulation method bao:BAO_0002094 (computational metod)
bao:BAO_0002301 molecular dynamics simulation A simulation procedure consisting of the computation of the motion of atoms in a molecule or of individual atoms or molecules in solids, liquids and gases, according to Newton's laws of motion. The forces acting on the atoms, required to simulate their motions, are generally calculated using molecular mechanics force fields. bao:BAO_0002282 (computer simulation method)
mmdbvoc:SimulationByResolution computer simulation method by resolution Granularity level at which is simulated system modelled (e.g. atomistic, coarse grained etc.). bao:BAO_0002301 (molecular dynamics simulation)
mmdbvoc:AtomisticSimulation atomistic simulation Simulation where every atom of the simulated system is explicitly represented. mmdbvoc:SimulationByResolution
mmdbvoc:CoarseGrainedSimulation coarse grained simulation Simulation where groups of multiple atoms of the simulated system are represented as one entity. mmdbvoc:SimulationByResolution
mmdbvoc:HybridResolutionSimulation hybrid resolution simulation Simulation using multiple levels of granularity for representation of atoms in the simulated system. mmdbvoc:SimulationByResolution
mmdbvoc:UnitedAtomsSimulation united atoms simulation Simulation where every atom of the simulated system, except hydrogen, is represented. mmdbvoc:SimulationByResolution
bao:BAO_0002305 quantitative structure activity relationship analysis Mathematical relationships linking chemical structure and pharmacological activity in a quantitative manner for a series of compounds. Methods which can be used in QSAR include various regression and pattern recognition techniques. bao:BAO_0002094 (computational metod)
bao:BAO_0002317 quantum chemistry computational method bao:BAO_0002094 (computational metod)

Results (assay endpoints)

Results of assays are in BAO represented as endpoints and this ontology defines great number of them, however we needed to define most of endpoint terms for representation of MolMeDB dataset ourself. Endpoint terms defined in MolMeDB vocabulary and imported into it are in Table 4.

Table 4. Assay endpoint (result) classes.

Term Name Definition Parent term
bao:BAO_0000179 result The endpoint is a quantitive or qualitative interpretable standardized representation of a perturbation (a change from a defined reference state of a "closed" model system) that is measured by the bioassay. An endpoint consists of a series of data points, one for each perturbing agent (screened entity) tested the assay. root term
bao:BAO_0080024 binary endpoint Any result reported as a simple binary assessment, such as 'active/ inactive', 'true/ false', etc. bao:BAO_0000179 (result)
mmdbvoc:InhibitionAssay inhibtion assay Result of the assay whether the measured entity acts as inhibitor of the target enzyme. bao:BAO_0080024 (binary endpoint)
mmdbvoc:SubstrateBindingAssay susbtrate assay Result of the assay whether the measured entity acts as substrate of the target enzyme. bao:BAO_0080024 (binary endpoint)
bao:BAO_0002118 graphical calculation endpoint An endpoint derived from calculus-based analysis of graphical measures. bao:BAO_0000179 (result)
mmdbvoc:DepthOfMinima depth of minima Affinity towards the membrane. (note - Can be computed as the difference between the free energy state of a particle in water and in distance from the membrane centre where it reaches minimal free energy.) bao:BAO_0002118 (graphical calculation endpoint)
mmdbvoc:AbsorptionWavelength peak absorption wavelength Wavelength of light which has highest absorbance in the measured system. bao:BAO_0002118 (graphical calculation endpoint)
mmdbvoc:FluorescenceWavelength peak fluorescence wavelength Wavelength of the light where the signal reaches its highest intensity. bao:BAO_0002118 (graphical calculation endpoint)
mmdbvoc:PenetrationBarrier penetration barrier Energy needed for the particle to pass the barrier. (note - Computed as integral of free energy curve in relation to the position in the membrane.) bao:BAO_0002118 (graphical calculation endpoint)
mmdbvoc:PositionOfMinima position of minima Distance from the centre of the membrane where the measured particle reaches minimal free energy state. bao:BAO_0002118 (graphical calculation endpoint)
bao:BAO_0000192 Ki Ki is the equilibrium inhibitor dissociation constant, the concentration of the competing inhibitor that results in binding to half the enzymes sites at equilibrium in the absence of substrate or other competitors. The Cheng and Prusoff equation: Ki - (IC50) / ( 1+ ([L]/Kd)) relates IC50 to Ki under conditions of competitive binding; Kd equilibrium dissociation constant of the (labeled) ligand, [L] ligand concentration. The Cheng and Prusoff equation: Ki - (IC50) / ( 1+ ([S]/Km)) relates IC50 to Ki under conditions of competitive inhibition; Ki equilibrium enzyme inhibitor dissociation constant; Km Michaelis-Menton constant, [S] substrate concentration. bao:BAO_0000179 (result)
mmdbvoc:pKi pKi pKi is -log Ki, where Kmi is the equilibrium inhibitor dissociation constant, the concentration of the competing inhibitor that results in binding to half the enzyme sites at equilibrium in the absence of substrate or other competitors. bao:BAO_0000192 (Ki)
bao:BAO_0000477 km The concentration of substrate at ½ Vmax, according to the Henri-Michaelis-Menten kinetic model. bao:BAO_0000179 (result)
mmdbvoc:pKm pKm pKm is -log Km, where Km is the concentration of substrate at ½ Vmax, according to the Henri-Michaelis-Menten kinetic model. bao:BAO_0000477 (km)
bao:BAO_0002128 physical property endpoint A measurement of an intrinsic property of a molecular entity. bao:BAO_0000179 (result)
mmdbvoc:LogK LogK Logarithm of partition coefficient membrane/water. bao:BAO_0002128 (physical property endpoint)
bao:BAO_0002808 permeability bao:BAO_0002128 (physical property endpoint)
mmdbvoc:LogPerm LogPerm Logarithm of membrane permeability. bao:BAO_0002808 (permeability)
bao:BAO_0080028 quantified endpoint bao:BAO_0000179 (result)
mmdbvoc:ContactAngle contact angle Angle of measured entity relative to the membrane at the point of contact. bao:BAO_0080028 (quantified endpoint)
mmdbvoc:QuantumYield quantum yield Number of times a specific event occurs per photon absorbed by the system. bao:BAO_0000179 (result)
bao:BAO_0002114 time endpoint An endpoint defined by a length in time at which a desired effect or observation occurs. bao:BAO_0000179 (result)
mmdbvoc:FluorescenceLifetime fluorescence lifetime The time a fluorophore spends in the excited state before emitting a photon and returning to the ground state. bao:BAO_0002114 (time endpoint)

Units

New units have been defined for use with some of assay endpoints. Hierarchy of defined units is listed in Table 5

Table 5. Units of measurement

Term Name Definition Parent term
obo:UO_0000000 unit A unit of measurement is a standardized quantity of a physical quality. root term
obo:UO_0000111 energy unit A unit which is a standard measure of the work done by a certain force (gravitational, electric, magnetic, force of inertia, etc). obo:UO_0000000 (unit)
mmdbvoc:KcalMol kcal/mol A derived unit of molar thermodynamic energy defined as the energy equal to 1000 calories in one mole of substance. obo:UO_0000111 (energy unit)
obo:UO_0000060 speed/velocity unit A unit which is a standard measure of the rate of movement. Speed is measured in the same physical units of measurement as velocity, but does not contain the element of direction that velocity has. Speed is thus the magnitude component of velocity. obo:UO_0000000 (unit)
mmdbvoc:CmS cm/s Centimeter per second. A derived unit of speed/velocity equivalent to 0.01 meter of distance traveled per 1 second. obo:UO_0000060 (speed/velocity unit)