/usr/include/rdkit/GraphMol/ReducedGraphs/ReducedGraphs.h is in librdkit-dev 201603.5-2.
This file is owned by root:root, with mode 0o644.
The actual contents of the file can be viewed below.
1 2 3 4 5 6 7 8 9 10 11 12 13 14 15 16 17 18 19 20 21 22 23 24 25 26 27 28 29 30 31 32 33 34 35 36 37 38 39 40 41 42 43 44 45 46 47 48 49 50 51 52 53 54 55 56 57 58 59 60 61 62 63 64 65 66 67 68 69 70 71 72 73 74 75 76 77 78 79 80 81 82 | //
// Copyright (C) 2013 Greg Landrum
//
// @@ All Rights Reserved @@
// This file is part of the RDKit.
// The contents are covered by the terms of the BSD license
// which is included in the file license.txt, found at the root
// of the RDKit source tree.
//
#ifndef _RD_REDUCEDGRAPHS_H_
#define _RD_REDUCEDGRAPHS_H_
#include <vector>
#include <boost/cstdint.hpp>
#include <boost/dynamic_bitset.hpp>
#include <Numerics/Vector.h>
namespace RDKit {
class ROMol;
namespace ReducedGraphs {
//! \brief Generates a reduced graph representation of a molecule
/*!
\param mol: the molecule to be fingerprinted
\return a new molecule
<b>Notes:</b>
- the caller is responsible for <tt>delete</tt>ing the result
*/
ROMol *generateMolExtendedReducedGraph(
const ROMol &mol, std::vector<boost::dynamic_bitset<> > *atomTypes = 0);
//! \brief Generates a ErG fingerprint vector for a molecule that's already a
// reduced graph
/*!
\param mol: the molecule to be fingerprinted
\param atomTypes: [optional] contains bit vectors indicating whether each
atom in
the molecule matches each type.
\param fuzzIncrement: amount to be added to neighboring bins
\param minPath: minimum distance (in bonds) to be considered
\param maxPath: maximum distance (in bonds) to be considered
\return the fingerprint, as a DoubleVector
<b>Notes:</b>
- the caller is responsible for <tt>delete</tt>ing the result
*/
RDNumeric::DoubleVector *generateErGFingerprintForReducedGraph(
const ROMol &mol, std::vector<boost::dynamic_bitset<> > *atomTypes = 0,
double fuzzIncrement = 0.3, unsigned int minPath = 1,
unsigned int maxPath = 15);
//! \brief Generates a ErG fingerprint vector for a molecule
/*!
\param mol: the molecule to be fingerprinted
\param atomTypes: [optional] contains bit vectors indicating whether each
atom in
the molecule matches each type.
\param fuzzIncrement: amount to be added to neighboring bins
\param minPath: minimum distance (in bonds) to be considered
\param maxPath: maximum distance (in bonds) to be considered
\return the fingerprint, as a DoubleVector
<b>Notes:</b>
- the caller is responsible for <tt>delete</tt>ing the result
*/
RDNumeric::DoubleVector *getErGFingerprint(
const ROMol &mol, std::vector<boost::dynamic_bitset<> > *atomTypes = 0,
double fuzzIncrement = 0.3, unsigned int minPath = 1,
unsigned int maxPath = 15);
} // end of ReducedGraphs namespace
} // end of RDKit namespace
#endif
|