/usr/include/rdkit/MolDraw2D.h is in librdkit-dev 201603.5+dfsg-1ubuntu1.
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 83 84 85 86 87 88 89 90 91 92 93 94 95 96 97 98 99 100 101 102 103 104 105 106 107 108 109 110 111 112 113 114 115 116 117 118 119 120 121 122 123 124 125 126 127 128 129 130 131 132 133 134 135 136 137 138 139 140 141 142 143 144 145 146 147 148 149 150 151 152 153 154 155 156 157 158 159 160 161 162 163 164 165 166 167 168 169 170 171 172 173 174 175 176 177 178 179 180 181 182 183 184 185 186 187 188 189 190 191 192 193 194 195 196 197 198 199 200 201 202 203 204 205 206 207 208 209 210 211 212 213 214 215 216 217 218 219 220 221 222 223 224 225 226 227 228 229 230 231 232 233 234 235 236 237 238 239 240 241 242 243 244 245 246 247 248 249 250 251 252 253 254 255 256 257 258 259 260 261 262 263 264 265 266 267 268 269 270 271 272 273 274 275 276 | //
// @@ 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.
//
// Original author: David Cosgrove (AstraZeneca)
// 27th May 2014
//
// This class makes a 2D drawing of an RDKit molecule.
// It draws heavily on $RDBASE/GraphMol/MolDrawing/MolDrawing.h.
// One purpose of this is to make it easier to overlay annotations on top of
// the molecule drawing, which is difficult to do from the output of
// MolDrawing.h
// The class design philosophy echoes a standard one:
// a virtual base class defines the interface and does all
// the heavy lifting and concrete derived classes implement
// library-specific drawing code such as drawing lines, writing strings
// etc.
#ifndef RDKITMOLDRAW2D_H
#define RDKITMOLDRAW2D_H
#include <vector>
#include <Geometry/point.h>
#include <GraphMol/RDKitBase.h>
#include <boost/tuple/tuple.hpp>
// ****************************************************************************
using RDGeom::Point2D;
namespace RDKit {
typedef boost::tuple<float, float, float> DrawColour;
typedef std::vector<unsigned int> DashPattern;
struct MolDrawOptions {
bool dummiesAreAttachments; // draws "breaks" at dummy atoms
bool circleAtoms; // draws circles under highlighted atoms
DrawColour highlightColour; // default highlight color
bool continuousHighlight; // highlight by drawing an outline *underneath* the
// molecule
int flagCloseContactsDist; // if positive, this will be used as a cutoff (in
// pixels) for highlighting close contacts
bool includeAtomTags; // toggles inclusion of atom tags in the output. does
// not make sense for all renderers.
bool clearBackground; // toggles clearing the background before drawing a
// molecule
DrawColour
backgroundColour; // color to be used while clearing the background
int legendFontSize; // font size (in pixels) to be used for the legend (if
// present)
DrawColour legendColour; // color to be used for the legend (if present)
double multipleBondOffset; // offset (in Angstroms) for the extra lines in a
// multiple bond
std::map<int, std::string> atomLabels; // replacement labels for atoms
std::vector<std::vector<int> > atomRegions; // regions
MolDrawOptions()
: dummiesAreAttachments(false),
circleAtoms(true),
highlightColour(1, .5, .5),
continuousHighlight(true),
flagCloseContactsDist(3),
includeAtomTags(false),
clearBackground(true),
backgroundColour(1, 1, 1),
legendFontSize(12),
legendColour(0, 0, 0),
multipleBondOffset(0.15){};
};
class MolDraw2D {
public:
typedef enum { C = 0, N, E, S, W } OrientType;
typedef enum {
TextDrawNormal = 0,
TextDrawSuperscript,
TextDrawSubscript
} TextDrawType;
MolDraw2D(int width, int height);
virtual ~MolDraw2D() {}
virtual void drawMolecule(
const ROMol &mol, const std::vector<int> *highlight_atoms = NULL,
const std::map<int, DrawColour> *highlight_map = NULL,
const std::map<int, double> *highlight_radii = NULL, int confId = -1);
virtual void drawMolecule(
const ROMol &mol, const std::string &legend,
const std::vector<int> *highlight_atoms = NULL,
const std::map<int, DrawColour> *highlight_map = NULL,
const std::map<int, double> *highlight_radii = NULL, int confId = -1);
virtual void drawMolecule(
const ROMol &mol, const std::vector<int> *highlight_atoms,
const std::vector<int> *highlight_bonds,
const std::map<int, DrawColour> *highlight_atom_map = NULL,
const std::map<int, DrawColour> *highlight_bond_map = NULL,
const std::map<int, double> *highlight_radii = NULL, int confId = -1);
virtual void drawMolecule(
const ROMol &mol, const std::string &legend,
const std::vector<int> *highlight_atoms,
const std::vector<int> *highlight_bonds,
const std::map<int, DrawColour> *highlight_atom_map = NULL,
const std::map<int, DrawColour> *highlight_bond_map = NULL,
const std::map<int, double> *highlight_radii = NULL, int confId = -1);
// transform a set of coords in the molecule's coordinate system
// to drawing system coordinates and vice versa. Note that the coordinates
// have
// the origin in the top left corner, which is how Qt and Cairo have it, no
// doubt a holdover from X Windows. This means that a higher y value will be
// nearer the bottom of the screen. This doesn't really matter except when
// doing text superscripts and subscripts.
virtual Point2D getDrawCoords(const Point2D &mol_cds) const;
virtual Point2D getDrawCoords(int at_num) const;
virtual Point2D getAtomCoords(const std::pair<int, int> &screen_cds) const;
virtual Point2D getAtomCoords(
const std::pair<double, double> &screen_cds) const;
virtual Point2D getAtomCoords(int at_num) const;
virtual int width() const { return width_; }
virtual int height() const { return height_; }
virtual double scale() const { return scale_; }
virtual void calculateScale();
virtual double fontSize() const { return font_size_; }
// set font size in molecule coordinate units. That's probably Angstrom for
// RDKit.
virtual void setFontSize(double new_size);
virtual void setColour(const DrawColour &col) { curr_colour_ = col; }
virtual DrawColour colour() const { return curr_colour_; }
virtual void setDash(const DashPattern &patt) { curr_dash_ = patt; }
virtual const DashPattern &dash() const { return curr_dash_; }
virtual void setLineWidth(int width) { curr_width_ = width; }
virtual int lineWidth() const { return curr_width_; }
// establishes whether to put string draw mode into super- or sub-script
// mode based on contents of instring from i onwards. Increments i
// appropriately
// and returns true or false depending on whether it did something or not
bool setStringDrawMode(const std::string &instring, TextDrawType &draw_mode,
int &i) const;
virtual void clearDrawing() = 0;
virtual void drawLine(const Point2D &cds1, const Point2D &cds2) = 0;
// using the current scale, work out the size of the label in molecule
// coordinates.
// Bear in mind when implementing this, that, for example, NH2 will appear as
// NH<sub>2</sub> to convey that the 2 is a subscript, and this needs to
// accounted
// for in the width and height.
virtual void getStringSize(const std::string &label, double &label_width,
double &label_height) const = 0;
// drawString centres the string on cds.
virtual void drawString(const std::string &str, const Point2D &cds);
// draw polygons:
virtual void drawPolygon(const std::vector<Point2D> &cds) = 0;
virtual void drawTriangle(const Point2D &cds1, const Point2D &cds2,
const Point2D &cds3);
virtual void drawEllipse(const Point2D &cds1, const Point2D &cds2);
virtual void drawRect(const Point2D &cds1, const Point2D &cds2);
virtual void drawAttachmentLine(const Point2D &cds1, const Point2D &cds2,
const DrawColour &col, double len = 1.0,
unsigned int nSegments = 8);
virtual void tagAtoms(const ROMol &mol) { RDUNUSED_PARAM(mol); };
virtual bool fillPolys() const { return fill_polys_; }
virtual void setFillPolys(bool val) { fill_polys_ = val; }
MolDrawOptions &drawOptions() { return options_; }
const MolDrawOptions &drawOptions() const { return options_; }
const std::vector<Point2D> &atomCoords() const { return at_cds_; };
const std::vector<std::pair<std::string, OrientType> > &atomSyms() const {
return atom_syms_;
};
private:
int width_, height_;
double scale_;
double x_min_, y_min_, x_range_, y_range_;
double x_trans_, y_trans_;
// font_size_ in molecule coordinate units. Default 0.5 (a bit bigger
// than the default width of a double bond)
double font_size_;
int curr_width_;
bool fill_polys_;
DrawColour curr_colour_;
DashPattern curr_dash_;
MolDrawOptions options_;
std::vector<Point2D> at_cds_; // from mol
std::vector<int> atomic_nums_;
std::vector<std::pair<std::string, OrientType> > atom_syms_;
Point2D bbox_[2];
// draw the char, with the bottom left hand corner at cds
virtual void drawChar(char c, const Point2D &cds) = 0;
// return a DrawColour based on the contents of highlight_atoms or
// highlight_map, falling back to atomic number by default
DrawColour getColour(int atom_idx,
const std::vector<int> *highlight_atoms = NULL,
const std::map<int, DrawColour> *highlight_map = NULL);
DrawColour getColourByAtomicNum(int atomic_num);
void extractAtomCoords(const ROMol &mol, int confId);
void extractAtomSymbols(const ROMol &mol);
virtual void drawLine(const Point2D &cds1, const Point2D &cds2,
const DrawColour &col1, const DrawColour &col2);
void drawBond(const ROMol &mol, const BOND_SPTR &bond, int at1_idx,
int at2_idx, const std::vector<int> *highlight_atoms = NULL,
const std::map<int, DrawColour> *highlight_atom_map = NULL,
const std::vector<int> *highlight_bonds = NULL,
const std::map<int, DrawColour> *highlight_bond_map = NULL);
void drawWedgedBond(const Point2D &cds1, const Point2D &cds2,
bool draw_dashed, const DrawColour &col1,
const DrawColour &col2);
void drawAtomLabel(int atom_num,
const std::vector<int> *highlight_atoms = NULL,
const std::map<int, DrawColour> *highlight_map = NULL);
// calculate normalised perpendicular to vector between two coords
Point2D calcPerpendicular(const Point2D &cds1, const Point2D &cds2);
// cds1 and cds2 are 2 atoms in a ring. Returns the perpendicular pointing
// into
// the ring.
Point2D bondInsideRing(const ROMol &mol, const BOND_SPTR &bond,
const Point2D &cds1, const Point2D &cds2);
// cds1 and cds2 are 2 atoms in a chain double bond. Returns the
// perpendicular
// pointing into the inside of the bond
Point2D bondInsideDoubleBond(const ROMol &mol, const BOND_SPTR &bond);
// calculate normalised perpendicular to vector between two coords, such that
// it's inside the angle made between (1 and 2) and (2 and 3).
Point2D calcInnerPerpendicular(const Point2D &cds1, const Point2D &cds2,
const Point2D &cds3);
// take the coords for atnum, with neighbour nbr_cds, and move cds out to
// accommodate
// the label associated with it.
void adjustBondEndForLabel(int atnum, const Point2D &nbr_cds,
Point2D &cds) const;
// adds LaTeX-like annotation for super- and sub-script.
std::pair<std::string, OrientType> getAtomSymbolAndOrientation(
const Atom &atom, const Point2D &nbr_sum);
virtual void doContinuousHighlighting(
const ROMol &mol, const std::vector<int> *highlight_atoms,
const std::vector<int> *highlight_bonds,
const std::map<int, DrawColour> *highlight_atom_map,
const std::map<int, DrawColour> *highlight_bond_map,
const std::map<int, double> *highlight_radii);
virtual void highlightCloseContacts();
};
}
#endif // RDKITMOLDRAW2D_H
|