19#include <boost/dynamic_bitset.hpp>
35 unsigned int bondStereo{
36 static_cast<unsigned int>(Bond::BondStereo::STEREONONE)};
37 unsigned int nbrSymClass{0};
38 unsigned int nbrIdx{0};
40 const canon_atom *controllingAtoms[4]{
nullptr,
nullptr,
nullptr,
nullptr};
41 const std::string *p_symbol{
43 unsigned int bondIdx{0};
47 unsigned int nsc,
unsigned int bidx)
49 bondStereo(static_cast<unsigned int>(bs)),
54 unsigned int nsc,
unsigned int bidx)
65 return compare(lhs, rhs) > 0;
69 unsigned int div = 1) {
103 unsigned int degree{0};
104 unsigned int totalNumHs{0};
105 bool hasRingNbr{
false};
106 bool isRingStereoAtom{
false};
107 unsigned int whichStereoGroup{0};
110 const std::string *p_symbol{
122 std::vector<std::pair<unsigned int, unsigned int>> &
result);
139 const boost::dynamic_bitset<> *dp_atomsInPlay{
nullptr},
140 *dp_bondsInPlay{
nullptr};
145 const boost::dynamic_bitset<> *atomsInPlay =
nullptr,
146 const boost::dynamic_bitset<> *bondsInPlay =
nullptr)
149 dp_atomsInPlay(atomsInPlay),
150 dp_bondsInPlay(bondsInPlay) {}
155 if (dp_atomsInPlay && !((*dp_atomsInPlay)[i] || (*dp_atomsInPlay)[j])) {
159 if (!dp_atomsInPlay || (*dp_atomsInPlay)[i]) {
162 if (!dp_atomsInPlay || (*dp_atomsInPlay)[j]) {
165 for (
unsigned int ii = 0;
166 ii < dp_atoms[i].bonds.size() && ii < dp_atoms[j].bonds.size(); ++ii) {
168 bondholder::compare(dp_atoms[i].bonds[ii], dp_atoms[j].bonds[ii]);
174 std::vector<std::pair<unsigned int, unsigned int>> swapsi;
175 std::vector<std::pair<unsigned int, unsigned int>> swapsj;
176 if (!dp_atomsInPlay || (*dp_atomsInPlay)[i]) {
179 if (!dp_atomsInPlay || (*dp_atomsInPlay)[j]) {
182 for (
unsigned int ii = 0; ii < swapsi.size() && ii < swapsj.size(); ++ii) {
183 int cmp = swapsi[ii].second - swapsj[ii].second;
196 const boost::dynamic_bitset<> *dp_atomsInPlay{
nullptr},
197 *dp_bondsInPlay{
nullptr};
202 const boost::dynamic_bitset<> *atomsInPlay =
nullptr,
203 const boost::dynamic_bitset<> *bondsInPlay =
nullptr)
206 dp_atomsInPlay(atomsInPlay),
207 dp_bondsInPlay(bondsInPlay) {}
212 if (dp_atomsInPlay && !((*dp_atomsInPlay)[i] || (*dp_atomsInPlay)[j])) {
216 if (dp_atoms[i].neighborNum < dp_atoms[j].neighborNum) {
218 }
else if (dp_atoms[i].neighborNum > dp_atoms[j].neighborNum) {
222 if (dp_atoms[i].revistedNeighbors < dp_atoms[j].revistedNeighbors) {
224 }
else if (dp_atoms[i].revistedNeighbors > dp_atoms[j].revistedNeighbors) {
228 if (!dp_atomsInPlay || (*dp_atomsInPlay)[i]) {
231 if (!dp_atomsInPlay || (*dp_atomsInPlay)[j]) {
234 for (
unsigned int ii = 0;
235 ii < dp_atoms[i].bonds.size() && ii < dp_atoms[j].bonds.size(); ++ii) {
237 bondholder::compare(dp_atoms[i].bonds[ii], dp_atoms[j].bonds[ii]);
243 if (dp_atoms[i].bonds.size() < dp_atoms[j].bonds.size()) {
245 }
else if (dp_atoms[i].bonds.size() > dp_atoms[j].bonds.size()) {
255 unsigned int res = 0;
256 std::vector<unsigned int>
perm;
257 perm.reserve(dp_atoms[i].atom->getDegree());
258 for (
const auto nbr : dp_mol->atomNeighbors(dp_atoms[i].atom)) {
259 auto rnk = dp_atoms[
nbr->getIdx()].index;
267 if (
perm.size() == dp_atoms[i].atom->getDegree()) {
268 auto ctag = dp_atoms[i].atom->getChiralTag();
284 unsigned int getAtomRingNbrCode(
unsigned int i)
const {
285 if (!dp_atoms[i].hasRingNbr) {
289 auto nbrs = dp_atoms[i].nbrIds.get();
290 unsigned int code = 0;
291 for (
unsigned j = 0; j < dp_atoms[i].degree; ++j) {
292 if (dp_atoms[nbrs[j]].isRingStereoAtom) {
293 code += dp_atoms[nbrs[j]].index * 10000 + 1;
299 int basecomp(
int i,
int j)
const {
300 unsigned int ivi, ivj;
303 ivi = dp_atoms[i].index;
304 ivj = dp_atoms[j].index;
307 }
else if (ivi > ivj) {
311 if (df_useNonStereoRanks) {
313 int rankingNumber_i = 0;
314 int rankingNumber_j = 0;
315 dp_atoms[i].atom->getPropIfPresent(
316 common_properties::_CanonicalRankingNumber, rankingNumber_i);
317 dp_atoms[j].atom->getPropIfPresent(
318 common_properties::_CanonicalRankingNumber, rankingNumber_j);
319 if (rankingNumber_i < rankingNumber_j) {
321 }
else if (rankingNumber_i > rankingNumber_j) {
326 if (df_useAtomMaps) {
328 int molAtomMapNumber_i = 0;
329 int molAtomMapNumber_j = 0;
330 dp_atoms[i].atom->getPropIfPresent(common_properties::molAtomMapNumber,
332 dp_atoms[j].atom->getPropIfPresent(common_properties::molAtomMapNumber,
334 if (molAtomMapNumber_i < molAtomMapNumber_j) {
336 }
else if (molAtomMapNumber_i > molAtomMapNumber_j) {
341 ivi = dp_atoms[i].degree;
342 ivj = dp_atoms[j].degree;
345 }
else if (ivi > ivj) {
348 if (dp_atoms[i].p_symbol && dp_atoms[j].p_symbol) {
349 if (*(dp_atoms[i].p_symbol) < *(dp_atoms[j].p_symbol)) {
351 }
else if (*(dp_atoms[i].p_symbol) > *(dp_atoms[j].p_symbol)) {
359 ivi = dp_atoms[i].atom->getAtomicNum();
360 ivj = dp_atoms[j].atom->getAtomicNum();
363 }
else if (ivi > ivj) {
367 if (df_useIsotopes) {
368 ivi = dp_atoms[i].atom->getIsotope();
369 ivj = dp_atoms[j].atom->getIsotope();
372 }
else if (ivi > ivj) {
378 ivi = dp_atoms[i].totalNumHs;
379 ivj = dp_atoms[j].totalNumHs;
382 }
else if (ivi > ivj) {
386 ivi = dp_atoms[i].atom->getFormalCharge();
387 ivj = dp_atoms[j].atom->getFormalCharge();
390 }
else if (ivi > ivj) {
394 if (df_useChiralPresence) {
396 dp_atoms[i].atom->getChiralTag() != Atom::ChiralType::CHI_UNSPECIFIED;
398 dp_atoms[j].atom->getChiralTag() != Atom::ChiralType::CHI_UNSPECIFIED;
401 }
else if (ivi > ivj) {
406 if (df_useChirality) {
408 ivi = dp_atoms[i].whichStereoGroup;
410 ivj = dp_atoms[j].whichStereoGroup;
414 }
else if (ivj && !ivi) {
416 }
else if (ivi && ivj) {
417 auto iType = dp_atoms[i].typeOfStereoGroup;
418 auto jType = dp_atoms[j].typeOfStereoGroup;
421 }
else if (iType > jType) {
426 std::set<unsigned int> sgi;
427 for (
const auto sgat :
429 sgi.insert(dp_atoms[sgat->getIdx()].index);
431 std::set<unsigned int> sgj;
432 for (
const auto sgat :
434 sgj.insert(dp_atoms[sgat->getIdx()].index);
438 }
else if (sgi > sgj) {
442 if (iType == StereoGroupType::STEREO_ABSOLUTE) {
443 ivi = getChiralRank(dp_mol, dp_atoms, i);
444 ivj = getChiralRank(dp_mol, dp_atoms, j);
447 }
else if (ivi > ivj) {
459 ivi = dp_atoms[i].atom->getChiralTag() != 0;
460 ivj = dp_atoms[j].atom->getChiralTag() != 0;
463 }
else if (ivi > ivj) {
469 ivi = getChiralRank(dp_mol, dp_atoms, i);
472 ivj = getChiralRank(dp_mol, dp_atoms, j);
476 }
else if (ivi > ivj) {
483 if (df_useChiralityRings) {
485 ivi = getAtomRingNbrCode(i);
486 ivj = getAtomRingNbrCode(j);
489 }
else if (ivi > ivj) {
499 const boost::dynamic_bitset<> *dp_atomsInPlay{
nullptr},
500 *dp_bondsInPlay{
nullptr};
501 bool df_useNbrs{
false};
502 bool df_useIsotopes{
true};
503 bool df_useChirality{
true};
504 bool df_useChiralityRings{
true};
505 bool df_useAtomMaps{
true};
506 bool df_useNonStereoRanks{
false};
507 bool df_useChiralPresence{
true};
511 const boost::dynamic_bitset<> *atomsInPlay =
nullptr,
512 const boost::dynamic_bitset<> *bondsInPlay =
nullptr)
515 dp_atomsInPlay(atomsInPlay),
516 dp_bondsInPlay(bondsInPlay) {}
519 if (dp_atomsInPlay && !((*dp_atomsInPlay)[i] || (*dp_atomsInPlay)[j])) {
522 int v = basecomp(i, j);
528 if (!dp_atomsInPlay || (*dp_atomsInPlay)[i]) {
531 if (!dp_atomsInPlay || (*dp_atomsInPlay)[j]) {
535 for (
unsigned int ii = 0;
536 ii < dp_atoms[i].bonds.size() && ii < dp_atoms[j].bonds.size();
539 bondholder::compare(dp_atoms[i].bonds[ii], dp_atoms[j].bonds[ii]);
545 if (dp_atoms[i].bonds.size() < dp_atoms[j].bonds.size()) {
547 }
else if (dp_atoms[i].bonds.size() > dp_atoms[j].bonds.size()) {
562 void getAtomNeighborhood(std::vector<bondholder> &nbrs)
const {
563 for (
unsigned j = 0; j < nbrs.size(); ++j) {
564 unsigned int nbrIdx = nbrs[j].nbrIdx;
569 const Atom *nbr = dp_atoms[nbrIdx].atom;
570 nbrs[j].nbrSymClass =
573 std::sort(nbrs.begin(), nbrs.end(), bondholder::greater);
577 int basecomp(
int i,
int j)
const {
579 unsigned int ivi, ivj;
582 ivi = dp_atoms[i].index;
583 ivj = dp_atoms[j].index;
586 }
else if (ivi > ivj) {
591 ivi = dp_atoms[i].atom->getAtomicNum();
592 ivj = dp_atoms[j].atom->getAtomicNum();
595 }
else if (ivi > ivj) {
600 ivi = dp_atoms[i].atom->getIsotope();
601 ivj = dp_atoms[j].atom->getIsotope();
604 }
else if (ivi > ivj) {
612 if (dp_atoms[i].atom->getPropIfPresent(common_properties::_CIPCode,
614 ivi = cipCode ==
"R" ? 2 : 1;
616 if (dp_atoms[j].atom->getPropIfPresent(common_properties::_CIPCode,
618 ivj = cipCode ==
"R" ? 2 : 1;
622 }
else if (ivi > ivj) {
633 bool df_useNbrs{
false};
636 : dp_atoms(atoms), dp_mol(&m), df_useNbrs(false) {}
641 int v = basecomp(i, j);
647 getAtomNeighborhood(dp_atoms[i].bonds);
648 getAtomNeighborhood(dp_atoms[j].bonds);
653 for (
unsigned int ii = 0;
654 ii < dp_atoms[i].bonds.size() && ii < dp_atoms[j].bonds.size();
656 int cmp = bondholder::compare(
662 for (
unsigned int ii = 0;
663 ii < dp_atoms[i].bonds.size() && ii < dp_atoms[j].bonds.size();
666 bondholder::compare(dp_atoms[i].bonds[ii], dp_atoms[j].bonds[ii]);
671 if (dp_atoms[i].bonds.size() < dp_atoms[j].bonds.size()) {
673 }
else if (dp_atoms[i].bonds.size() > dp_atoms[j].bonds.size()) {
686template <
typename CompareFunc>
719 start = order + offset;
737 for (
int k = 0;
k <
len; ++
k) {
744 for (i =
count[index]; i <
len; i++) {
754 for (
unsigned j = 0;
j < atoms[index].
degree; ++
j) {
762 for (i =
count[index]; i <
len; i++) {
764 for (
unsigned j = 0;
j < atoms[index].
degree; ++
j) {
783template <
typename CompareFunc>
794 for (
unsigned int i = 0; i <
nAtoms; i++) {
800 index = order[offset];
801 atoms[index].
index = offset;
806 if (atoms[index].degree < 1) {
809 for (
unsigned j = 0;
j < atoms[index].
degree; ++
j) {
836 int *order,
int *
count,
844 const ROMol &mol, std::vector<unsigned int> &
res,
bool breakTies =
true,
850 const ROMol &mol, std::vector<unsigned int> &
res,
853 const std::vector<std::string> *atomSymbols,
854 const std::vector<std::string> *
bondSymbols,
bool breakTies,
859 const ROMol &mol, std::vector<unsigned int> &
res,
862 const std::vector<std::string> *atomSymbols =
nullptr,
872 std::vector<unsigned int> &
res);
875 std::vector<Canon::canon_atom> &atoms,
881 std::vector<Canon::canon_atom> &atoms,
883 const std::vector<std::string> *atomSymbols,
890 bool useSpecial =
false,
bool useChirality =
false,
891 const boost::dynamic_bitset<> *
atomsInPlay =
nullptr,
892 const boost::dynamic_bitset<> *
bondsInPlay =
nullptr);
#define PRECONDITION(expr, mess)
Defines the primary molecule class ROMol as well as associated typedefs.
Defines the class StereoGroup which stores relationships between the absolute configurations of atoms...
The class for representing atoms.
int getAtomicNum() const
returns our atomic number
@ CHI_TETRAHEDRAL_CW
tetrahedral: clockwise rotation (SMILES @@)
@ CHI_TETRAHEDRAL_CCW
tetrahedral: counter-clockwise rotation (SMILES
BondStereo
the nature of the bond's stereochem (for cis/trans)
AtomCompareFunctor(Canon::canon_atom *atoms, const ROMol &m, const boost::dynamic_bitset<> *atomsInPlay=nullptr, const boost::dynamic_bitset<> *bondsInPlay=nullptr)
int operator()(int i, int j) const
ChiralAtomCompareFunctor(Canon::canon_atom *atoms, const ROMol &m)
int operator()(int i, int j) const
ChiralAtomCompareFunctor()
int operator()(int i, int j) const
SpecialChiralityAtomCompareFunctor(Canon::canon_atom *atoms, const ROMol &m, const boost::dynamic_bitset<> *atomsInPlay=nullptr, const boost::dynamic_bitset<> *bondsInPlay=nullptr)
SpecialChiralityAtomCompareFunctor()
SpecialSymmetryAtomCompareFunctor()
SpecialSymmetryAtomCompareFunctor(Canon::canon_atom *atoms, const ROMol &m, const boost::dynamic_bitset<> *atomsInPlay=nullptr, const boost::dynamic_bitset<> *bondsInPlay=nullptr)
int operator()(int i, int j) const
const std::vector< StereoGroup > & getStereoGroups() const
Gets a reference to the groups of atoms with relative stereochemistry.
unsigned int getNumAtoms() const
returns our number of atoms
#define RDKIT_GRAPHMOL_EXPORT
void rankWithFunctor(T &ftor, bool breakTies, int *order, bool useSpecial=false, bool useChirality=false, const boost::dynamic_bitset<> *atomsInPlay=nullptr, const boost::dynamic_bitset<> *bondsInPlay=nullptr)
void initFragmentCanonAtoms(const ROMol &mol, std::vector< Canon::canon_atom > &atoms, bool includeChirality, const std::vector< std::string > *atomSymbols, const std::vector< std::string > *bondSymbols, const boost::dynamic_bitset<> &atomsInPlay, const boost::dynamic_bitset<> &bondsInPlay, bool needsInit)
RDKIT_GRAPHMOL_EXPORT void initCanonAtoms(const ROMol &mol, std::vector< Canon::canon_atom > &atoms, bool includeChirality=true, bool includeStereoGroups=true)
RDKIT_GRAPHMOL_EXPORT void CreateSinglePartition(unsigned int nAtoms, int *order, int *count, canon_atom *atoms)
RDKIT_GRAPHMOL_EXPORT void rankFragmentAtoms(const ROMol &mol, std::vector< unsigned int > &res, const boost::dynamic_bitset<> &atomsInPlay, const boost::dynamic_bitset<> &bondsInPlay, const std::vector< std::string > *atomSymbols, const std::vector< std::string > *bondSymbols, bool breakTies, bool includeChirality, bool includeIsotope, bool includeAtomMaps, bool includeChiralPresence)
RDKIT_GRAPHMOL_EXPORT void ActivatePartitions(unsigned int nAtoms, int *order, int *count, int &activeset, int *next, int *changed)
const unsigned int ATNUM_CLASS_OFFSET
RDKIT_GRAPHMOL_EXPORT void updateAtomNeighborNumSwaps(canon_atom *atoms, std::vector< bondholder > &nbrs, unsigned int atomIdx, std::vector< std::pair< unsigned int, unsigned int > > &result)
void BreakTies(const ROMol &mol, canon_atom *atoms, CompareFunc compar, int mode, int *order, int *count, int &activeset, int *next, int *changed, char *touchedPartitions)
RDKIT_GRAPHMOL_EXPORT void rankMolAtoms(const ROMol &mol, std::vector< unsigned int > &res, bool breakTies=true, bool includeChirality=true, bool includeIsotopes=true, bool includeAtomMaps=true, bool includeChiralPresence=false, bool includeStereoGroups=true, bool useNonStereoRanks=false)
void RefinePartitions(const ROMol &mol, canon_atom *atoms, CompareFunc compar, int mode, int *order, int *count, int &activeset, int *next, int *changed, char *touchedPartitions)
RDKIT_GRAPHMOL_EXPORT void chiralRankMolAtoms(const ROMol &mol, std::vector< unsigned int > &res)
RDKIT_GRAPHMOL_EXPORT void updateAtomNeighborIndex(canon_atom *atoms, std::vector< bondholder > &nbrs)
bool rdvalue_is(const RDValue_cast_t)
void hanoisort(int *base, int nel, int *count, int *changed, CompareFunc compar)
unsigned int countSwapsToInterconvert(const T &ref, T probe)
const std::string * p_symbol
static bool greater(const bondholder &lhs, const bondholder &rhs)
bool operator<(const bondholder &o) const
int compareStereo(const bondholder &o) const
bondholder(Bond::BondType bt, unsigned int bs, unsigned int ni, unsigned int nsc, unsigned int bidx)
bondholder(Bond::BondType bt, Bond::BondStereo bs, unsigned int ni, unsigned int nsc, unsigned int bidx)
static int compare(const bondholder &x, const bondholder &y, unsigned int div=1)
std::vector< bondholder > bonds
std::unique_ptr< int[]> nbrIds
std::vector< int > revistedNeighbors
std::vector< int > neighborNum