This is part of a series of essays on how to fragment a molecular graph using RDKit. These are meant to describe the low-level steps that go into fragmentation, and the ways to think about testing. To fragment a molecule in RDKit, use FragmentOnBonds(). The essays in this series are:
- Molecular fragments, R-groups, and functional groups
- Fragment achiral molecules in RDKit using low-level functions
- Fragment chiral molecules in RDKit using low-level functions
- Use FragmentOnBonds to fragment a molecule in RDKit
- Fragment by copy and trim
Why another fragmentation method?
How do you tell if an algorithm is correct? Sometimes you can inspect the code. More often you have test cases where you know the correct answer. For complex algorithms, especially when using real-world data, testing is even harder. It's not always clear where edge cases are, and often the real-world is often more complicated than you think.
Another validation solution is to write two different algorithms which accomplish the same thing, and compare them with each other. I did that in my essay about different ways to evaluate the parity of a permutation order. That cross-validation testing was good enough, because it's easy to compute all possible input orders.
In the previous essay in this series, I cross-validated that fragment_chiral() and fragment_on_bonds() give the same results. They did. That isn't surprising because they implement essentially the same algorithm. Not only that, but I looked at the FragmentOnBonds() implementation when I found out my first fragment_chiral() didn't give the same answers. (I didn't know I needed to ClearComputedProps() after I edit the structure.)Cross-validation works better when the two algorithm are less similar. The way you think about a problem and implement a solution are connected. Two similar solutions may be the result of thinking about things the same way, and come with the same blind spots. (This could also be a design goal, if you want the new implementation to be "bug compatible" with the old.)
I've made enough hints that you likely know what I'm leading up to. RDKit's FragmentOnBonds() code currently (in mid-2016) converts directional bonds (the E-Z stereochemistry around double bonds into non-directional single bonds.
>>> from rdkit import Chem >>> mol = Chem.MolFromSmiles("F/C=C/F") >>> fragmented_mol = Chem.FragmentOnBonds(mol, [0], dummyLabels=[(0,0)]) >>> Chem.MolToSmiles(fragmented_mol, isomericSmiles=True) '[*]C=CF.[*]F'when I expected the last line to be
'[*]/C=C/F.[*]F'
This may or may not be what you want. Just in case, I've submitted a patch to discuss changing it in RDKit, so your experience in the future might be different than mine in the past.
I bring it up now to show how cross-validation of similar algorithms isn't always enough to figure out if the algorithms do as you expect.
Validate though re-assembly
As a reminder, in an earlier essay I did a much stronger validation test. I took the fragments, reassembled them via SMILES syntax manipulation, and compared the canonicalized result to the canonicalized input structure. These should always match, to within limits of the underlying chemistry support.
They didn't, because my original code didn't support directional bonds. Instead, in that essay I pre-processed the input SMILES string to replace the "/" and "\" characters with a "-". That gives the equivalent chemistry without directional bonds.
I could use that validation technique again, but I want to explore more of what it means to cross-validate by using a different fragmentation implementations.
Fragment by 'copy and trim'
Dave Cosgrove, on the RDKit mailing list, described the solution he uses to cut a bond and preserve chirality in toolkits which don't provide a high-level equivalent to FragmentOnBonds(). This method only works on non-ring bonds, which isn't a problem for me as I want to fragment R-groups. (As I discovered while doing the final testing, my implementation of the method also assumes there is only one molecule in the structure.)
To make fragment from a molecule, trim away all the atoms which aren't part of the fragment, except for the atom connected to the fragment. Convert that atom into the wildcard atom "*" by setting its atomic number, charge, and number of hydrogens to 0, and setting the chirality and aromaticity flags correctly. The image below shows the steps applied to cutting the ester off of aspirin:

This method never touches the bonds connected to a chiral atom of a fragment, so chirality or other bond properties (like bond direction!) aren't accidently removed by breaking the bond and making a new one in its place.
A downside is that I need to copy and trim twice in order to get both fragments after cutting a chain bond. I can predict now the performance won't be as fast as FragmentOnBonds().
Let's try it out.
Trim using the interactive shell
I'll use aspirin as my reference structure and cut the bond to the ester (the R-OCOCH3), which is the bond between atoms 2 and 3.

>>> from rdkit import Chem >>> aspirin = Chem.MolFromSmiles("O=C(Oc1ccccc1C(=O)O)C") >>> bond_idx = aspirin.GetBondBetweenAtoms(2, 3).GetIdx() >>> bond_idx 2 >>> fragmented_mol = Chem.FragmentOnBonds(aspirin, [bond_idx], dummyLabels=[(0,0)]) >>> Chem.MolToSmiles(fragmented_mol, isomericSmiles=True) '[*]OC(C)=O.[*]c1ccccc1C(=O)O'
I'll need a way to find all of the atoms which are on the ester side of the bond. I don't think there's a toolkit function to get all the atoms on one side of a bond, so I'll write one myself.
Atom 2 is the connection point on the ester to the rest of the aspirin structure. I'll start with that atom, show that it's an oxygen, and get information about its bonds:

>>> atom = aspirin.GetAtomWithIdx(2) >>> atom.GetSymbol() 'O' >>> [bond.GetBondType() for bond in atom.GetBonds()] [rdkit.Chem.rdchem.BondType.SINGLE, rdkit.Chem.rdchem.BondType.SINGLE]I'll use the bond object to get to the atom on the other side of the bond from atom 2, and report more detailed information about the atom at the other end of each bond:
>>> for bond in atom.GetBonds(): ... other_atom = bond.GetOtherAtom(atom) ... print(other_atom.GetIdx(), bond.GetBondType(), other_atom.GetSymbol(), other_atom.GetIsAromatic()) ... 1 SINGLE C False 3 SINGLE C TrueThis says that atom 1 is an aliphatic carbon, and atom 3 is an aromatic carbon. This matches the structure diagram I used earlier.
I know that atom 3 is the other end of the bond which was cut, so I can stop there. What about atom 1? What is it connected to?

>>> next_atom = aspirin.GetAtomWithIdx(1) >>> [b.GetOtherAtom(next_atom).GetIdx() for b in next_atom.GetBonds()] [0, 2, 12]I've already processed atom 2, so only atoms 0 and 12 are new.
What are those atoms connected to?

>>> next_atom = aspirin.GetAtomWithIdx(0) >>> [b.GetOtherAtom(next_atom).GetIdx() for b in next_atom.GetBonds()] [1] >>> next_atom = aspirin.GetAtomWithIdx(12) >>> [b.GetOtherAtom(next_atom).GetIdx() for b in next_atom.GetBonds()] [1]Only atom 1, which I've already seen before so I've found all of the atoms on the ester side of the bond.
Semi-automated depth-first search
There are more atoms on the other side of the bond, so I'll have to automate it somewhat. This sort of graph search is often implemented as a depth-first search (DFS) or a breadth-first search (BFS). Python lists easily work as stacks, which makes DFS slightly more natural to implement.
To give you an idea of what I'm about to explain, here's an animation of the aspirin depth-first search:

If there is the chance of a ring (called "cycle" in graph theory), then there are two ways to get to the same atom. To prevent processing the same atom multiple times, I'll set up set named "seen_ids", which contains the atoms indices I've before. Since it's the start, I've only seen the two atoms which are at the end of the bond to cut.
>>> seen_ids = set([2, 3])I also store a list of the atoms which are in this side of the bond, at this point is only atom 3, and a stack (a Python list) of the atoms I need to process further:
>>> atom_ids = [3] >>> stack = [aspirin.GetAtomWithIdx(3)]I'll start by getting the top of the stack (the last element of the list) and looking at its neighbors:
>>> atom = stack.pop() >>> neighbor_ids = [b.GetOtherAtom(atom).GetIdx() for b in atom.GetBonds()] >>> neighbor_ids [2, 4, 8]I'll need to filter out the neighbors I've already seen. I'll write a helper function for that. I'll need both the atom objects and the atom ids, so this will return two lists, one for each:
def get_atoms_to_visit(atom, seen_ids): neighbor_ids = [] neighbor_atoms = [] for bond in atom.GetBonds(): neighbor_atom = bond.GetOtherAtom(atom) neighbor_id = neighbor_atom.GetIdx() if neighbor_id not in seen_ids: neighbor_ids.append(neighbor_id) neighbor_atoms.append(neighbor_atom) return neighbor_ids, neighbor_atomsand use it:
>>> atom_ids_to_visit, atoms_to_visit = get_atoms_to_visit(atom, seen_ids) >>> atom_ids_to_visit [4, 8] >>> [a.GetSymbol() for a in atoms_to_visit] ['C', 'C']These atom ids are connected to the original atom, so add them all it to the atom_ids.
>>> atom_ids.extend(atom_ids_to_visit) >>> atom_ids [3, 4, 8]These haven't been seen before, so add the atoms (not the atom ids) to the stack of items to process:
>>> stack.extend(atoms_to_visit) >>> stack [<rdkit.Chem.rdchem.Atom object at 0x111bf37b0>, <rdkit.Chem.rdchem.Atom object at 0x111bf3760>] >>> [a.GetIdx() for a in stack] [4, 8]Now that they've been seen, I don't need to process them again, so add the new ids to the set of seen ids:
>>> seen_ids.update(atom_ids_to_visit) >>> seen_ids {8, 2, 3, 4}
That's the basic loop. The stack isn't empty, so pop the top of the stack to get a new atom object, and repeat the earlier steps:
>>> atom = stack.pop() >>> atom.GetIdx() 8 >>> atom_ids_to_visit, atoms_to_visit = get_atoms_to_visit(atom, seen_ids) >>> atom_ids_to_visit [7, 9] >>> atom_ids.extend(atom_ids_to_visit) >>> atom_ids [3, 4, 8, 7, 9] >>> stack.extend(atoms_to_visit) >>> [a.GetIdx() for a in stack] [4, 7, 9] >>> seen_ids.update(atom_ids_to_visit) >>> seen_ids {2, 3, 4, 7, 8, 9}Then another loop. I'll stick it in a while loop to process the stack until its empty, and I'll only have it print the new atom ids added to the list:
>>> while stack: ... atom = stack.pop() ... atom_ids_to_visit, atoms_to_visit = get_atoms_to_visit(atom, seen_ids) ... atom_ids.extend(atom_ids_to_visit) ... stack.extend(atoms_to_visit) ... seen_ids.update(atom_ids_to_visit) ... print("added atoms", atom_ids_to_visit) ... added atoms [10, 11] added atoms [] added atoms [] added atoms [6] added atoms [5] added atoms [] added atoms []The final set of atoms is:
>>> atom_ids [3, 4, 8, 7, 9, 10, 11, 6, 5]
Fully automated - fragment_trim()
In this section I'll put all the pieces together to make fragment_trim(), a function which implements the trim algorithm.
Find atoms to delete
The trim algorithm needs to know which atoms to delete. That will be all of the atoms on one side of the bond, except for the atom which is at the end of the bond. (I'll turn that atom into a "*" atom.) I'll use the above code to get the atom ids to delete:
# Look for neighbor atoms of 'atom' which haven't been seen before def get_atoms_to_visit(atom, seen_ids): neighbor_ids = [] neighbor_atoms = [] for bond in atom.GetBonds(): neighbor_atom = bond.GetOtherAtom(atom) neighbor_id = neighbor_atom.GetIdx() if neighbor_id not in seen_ids: neighbor_ids.append(neighbor_id) neighbor_atoms.append(neighbor_atom) return neighbor_ids, neighbor_atoms # Find all of the atoms connected to 'start_atom_id', except for 'ignore_atom_id' def find_atom_ids_to_delete(mol, start_atom_id, ignore_atom_id): seen_ids = {start_atom_id, ignore_atom_id} atom_ids = [] # Will only delete the newly found atoms, not the start atom stack = [mol.GetAtomWithIdx(start_atom_id)] # Use a depth-first search to find the connected atoms while stack: atom = stack.pop() atom_ids_to_visit, atoms_to_visit = get_atoms_to_visit(atom, seen_ids) atom_ids.extend(atom_ids_to_visit) stack.extend(atoms_to_visit) seen_ids.update(atom_ids_to_visit) return atom_idsand try it out:
>>> from rdkit import Chem >>> aspirin = Chem.MolFromSmiles("O=C(Oc1ccccc1C(=O)O)C") >>> find_atom_ids_to_delete(aspirin, 3, 2) [1, 0, 12] >>> find_atom_ids_to_delete(aspirin, 2, 3) [4, 8, 7, 9, 10, 11, 6, 5]That looks right. (I left out the other testing I did to get this right.)
Trim atoms
The trim function has two parts. The first is to turn the attachment point into the wildcard atom "*", which I'll do by removing any charges, hydrogens, chirality, or other atom properties. This atom will not be deleted. The second is to remove the other atoms on that side of the bond.
Removing atoms from a molecule is slightly tricky. The atom indices are reset after each atom is removed. (While I often use a variable name like "atom_id", the atom id is not a permanent id, but simply the current atom index.) When atom "i" is deleted, all of the atoms with a larger id "j" get the new id "j-1". That is, the larger ids are all shifted down one to fill in the gap.
This becomes a problem because I have a list of ids to delete, but as I delete them the real ids change. For example, if I delete atoms 0 and 1 from a two atom molecule, in that order, I will get an exception:
>>> rwmol = Chem.RWMol(Chem.MolFromSmiles("C#N")) >>> rwmol.RemoveAtom(0) >>> rwmol.RemoveAtom(1) [13:54:02] **** Range Error idx Violation occurred on line 155 in file /Users/dalke/ftps/rdkit-Release_2016_03_1/Code/GraphMol/ROMol.cpp Failed Expression: 1 <= 0 **** Traceback (most recent call last): File "<stdin>", line 1, in <module> RuntimeError: Range Error idx Violation occurred on line 155 in file Code/GraphMol/ROMol.cpp Failed Expression: 1 <= 0 RDKIT: 2016.03.1 BOOST: 1_60This is because after RemoveAtom(0) the old atom with id 1 gets the id 0. As another example, if I remove atoms 0 and 1 from a three atom molecule, I'll end up with what was originally the second atom:
>>> rwmol = Chem.RWMol(Chem.MolFromSmiles("CON")) >>> rwmol.RemoveAtom(0) >>> rwmol.RemoveAtom(1) >>> Chem.MolToSmiles(rwmol) 'O'Originally the ids were [C=0, O=1, N=2]. The RemoveAtom(0) removed the C and renumbered the remaining atoms, giving [O=0, N=1]. The RemoveAtom(1) then removed the N, leaving [O=0] as the remaining atom.
While you could pay attention to the renumbering and adjust the index of the atom to delete, the far easier solution is to sort the atom ids, and delete starting from the largest id.
Here is the function to turn the attachment atom into a wildcard and to delete the other atoms:
def trim_atoms(mol, wildcard_atom_id, atom_ids_to_delete): rwmol = Chem.RWMol(mol) # Change the attachment atom into a wildcard ("*") atom atom = rwmol.GetAtomWithIdx(wildcard_atom_id) atom.SetAtomicNum(0) atom.SetIsotope(0) atom.SetFormalCharge(0) atom.SetIsAromatic(False) atom.SetNumExplicitHs(0) # Remove the other atoms. # RDKit will renumber after every RemoveAtom() so # remove from highest to lowest atom index. # If not sorted, may get a "RuntimeError: Range Error" for atom_id in sorted(atom_ids_to_delete, reverse=True): rwmol.RemoveAtom(atom_id) # Don't need to ClearComputedProps() because that will # be done by CombineMols() return rwmol.GetMol()(If this were a more general-purpose function I would need to call ClearComputedProps(), which is needed after any molecular editing in RDKit. I don't need to do this here because it will be done during CombineMols(), which is coming up.)
How did I figure out which properties needed to be changed to make a wildcard atom? I tracked the down during cross-validation tests of an earlier version of this algorithm.
I'll try out the new code:
>>> fragment1 = trim_atoms(aspirin, 2, [1, 0, 12]) >>> Chem.MolToSmiles(fragment1, isomericSmiles=True) '[*]c1ccccc1C(=O)O' >>> fragment2 = trim_atoms(aspirin, 3, [4, 8, 7, 9, 10, 11, 6, 5]) >>> Chem.MolToSmiles(fragment2, isomericSmiles=True) '[*]OC(C)=O'
fragment_trim()
The high-level fragment code is straight-forward, and I don't think it requires explanation:
def fragment_trim(mol, atom1, atom2): # Find the fragments on either side of a bond delete_atom_ids1 = find_atom_ids_to_delete(mol, atom1, atom2) fragment1 = trim_atoms(mol, atom1, delete_atom_ids1) delete_atom_ids2 = find_atom_ids_to_delete(mol, atom2, atom1) fragment2 = trim_atoms(mol, atom2, delete_atom_ids2) # Merge the two fragments. # (CombineMols() does the required ClearComputedProps()) return Chem.CombineMols(fragment1, fragment2)
I'll check that it does what I think it should do:
>>> new_mol = fragment_trim(aspirin, 2, 3) >>> Chem.MolToSmiles(new_mol) '[*]OC(C)=O.[*]c1ccccc1C(=O)O'This matches the FragmentOnBonds() output at the start of this essay.
Testing
I used the same cross-validation method I did in my previous essay. I parsed structures from ChEMBL and checked that fragment_trim() produces the same results as FragmentOnBonds(). It doesn't. The first failure mode surprised me:
fragment_trim() only works with a single connected structure
Here's one of the failure reports:
Mismatch: record: 61 id: CHEMBL1203109 smiles: Cl.CNC(=O)c1cc(C(O)CNC(C)CCc2ccc3c(c2)OCO3)ccc1O cut: 1 2 smiles_trim: Cl.Cl.[*]C.[*]NC(=O)c1cc(C(O)CNC(C)CCc2ccc3c(c2)OCO3)ccc1O smiles_on_bond: Cl.[*]C.[*]NC(=O)c1cc(C(O)CNC(C)CCc2ccc3c(c2)OCO3)ccc1OSomehow the "Cl" appears twice. After thinking about it I realized that my implementation of the copy and trim algorithm assumes that the input structure is strongly connected, that is that it only contains a single molecule. Each copy contains a chlorine atom, so when I CombineMols() I end up with two chlorine atoms.
I could fix my implementation to handle this, but as I'm only interested in cross-validation, the easier solution is to never process a structure with multiple molecules. I decided that if the input SMILES contains multiple molecules (that is, if the SMILES contains the dot disconnection symbol ".") then I would choose the component which has the most characters, using the following:
if "." in smiles: # The fragment_trim() method only works on a connected molecule. # Arbitrarily pick the component with the longest SMILES string. smiles = max(smiles.split("."), key=len)
Directional bonds
After 1000 records and 31450 tests there were 362 mismatches. All of them appeared to be related to directional bonds, like this mismatch report:
Mismatch: record: 124 id: CHEMBL445177 smiles: CCCCCC/C=C\CCCCCCCc1cccc(O)c1C(=O)O cut: 7 8 smiles_trim: [*]/C=C\CCCCCC.[*]CCCCCCCc1cccc(O)c1C(=O)O smiles_on_bond: [*]C=CCCCCCC.[*]CCCCCCCc1cccc(O)c1C(=O)OI knew this would happen coming in to this essay, but it's still nice to see. It demonstrates that the fragment_trim() is a better way to cross-validate FragmentOnBonds() than my earlier fragment_chiral() algorithm.
It's possible that other mismatches are hidden in the hundreds of reports, so I removed directional bonds from the SMILES and processed again:
if "/" in smiles: smiles = smiles.replace("/", "") if "\\" in smiles: smiles = smiles.replace("\\", "")That testing shows I forgot to include "atom.SetIsotope(0)" when I converted the attachment atom into a wildcard atom. Without it, the algorithm turned a "[18F]" into a "[18*]". It surprised me because I copied it from working code I made for an earlier version of the algorithm. Looking into it, I realized I left that line out during the copy&paste. This is why regression tests using diverse real-world data are important. I stopped the testing after 100,00 records. Here is the final status line:
Processed 100000 records, 100000 molecules, 1120618 tests, 0 mismatches. T_trim: 2846.79 T_on_bond 258.18While trim code is slower than using the built-in function, the point of this exercise isn't to figure out the fastest implementation but to have a better way to cross-validate the original code, which it has done.
The final code
Here is the final code:
from __future__ import print_function import datetime import time from rdkit import Chem # Look for neighbor atoms of 'atom' which haven't been seen before def get_atoms_to_visit(atom, seen_ids): neighbor_ids = [] neighbor_atoms = [] for bond in atom.GetBonds(): neighbor_atom = bond.GetOtherAtom(atom) neighbor_id = neighbor_atom.GetIdx() if neighbor_id not in seen_ids: neighbor_ids.append(neighbor_id) neighbor_atoms.append(neighbor_atom) return neighbor_ids, neighbor_atoms # Find all of the atoms connected to 'start_atom_id', except for 'ignore_atom_id' def find_atom_ids_to_delete(mol, start_atom_id, ignore_atom_id): seen_ids = {ignore_atom_id, start_atom_id} atom_ids = [] # Will only delete the newly found atoms, not the start atom stack = [mol.GetAtomWithIdx(start_atom_id)] # Use a depth-first search to find the connected atoms while stack: atom = stack.pop() atom_ids_to_visit, atoms_to_visit = get_atoms_to_visit(atom, seen_ids) atom_ids.extend(atom_ids_to_visit) stack.extend(atoms_to_visit) seen_ids.update(atom_ids_to_visit) return atom_ids def trim_atoms(mol, wildcard_atom_id, atom_ids_to_delete): rwmol = Chem.RWMol(mol) # Change the attachment atom into a wildcard ("*") atom atom = rwmol.GetAtomWithIdx(wildcard_atom_id) atom.SetAtomicNum(0) atom.SetIsotope(0) atom.SetFormalCharge(0) atom.SetIsAromatic(False) atom.SetNumExplicitHs(0) # Remove the other atoms. # RDKit will renumber after every RemoveAtom() so # remove from highest to lowest atom index. # If not sorted, may get a "RuntimeError: Range Error" for atom_id in sorted(atom_ids_to_delete, reverse=True): rwmol.RemoveAtom(atom_id) # Don't need to ClearComputedProps() because that will # be done by CombineMols() return rwmol.GetMol() def fragment_trim(mol, atom1, atom2): # Find the fragments on either side of a bond delete_atom_ids1 = find_atom_ids_to_delete(mol, atom1, atom2) fragment1 = trim_atoms(mol, atom1, delete_atom_ids1) delete_atom_ids2 = find_atom_ids_to_delete(mol, atom2, atom1) fragment2 = trim_atoms(mol, atom2, delete_atom_ids2) # Merge the two fragments. # (CombineMols() does the required ClearComputedProps()) return Chem.CombineMols(fragment1, fragment2) ####### Cross-validation code def fragment_on_bond(mol, atom1, atom2): bond = mol.GetBondBetweenAtoms(atom1, atom2) return Chem.FragmentOnBonds(mol, [bond.GetIdx()], dummyLabels=[(0, 0)]) def read_records(filename): with open(filename) as infile: for recno, line in enumerate(infile): smiles, id = line.split() if "*" in smiles: continue yield recno, id, smiles def cross_validate(): # Match a single bond not in a ring BOND_SMARTS = "[!#0;!#1]-!@[!#0;!#1]" single_bond_pat = Chem.MolFromSmarts(BOND_SMARTS) num_mols = num_tests = num_mismatches = 0 time_trim = time_on_bond = 0.0 # Helper function to print status information. Since # the function is defined inside of another function, # it has access to variables in the outer function. def print_status(): print("Processed {} records, {} molecules, {} tests, {} mismatches."" T_trim: {:.2f} T_on_bond {:.2f}" .format(recno, num_mols, num_tests, num_mismatches, time_trim, time_on_bond)) filename = "/Users/dalke/databases/chembl_20_rdkit.smi" start_time = datetime.datetime.now() for recno, id, smiles in read_records(filename): if recno % 100 == 0: print_status() if "." in smiles: # The fragment_trim() method only works on a connected molecule. # Arbitrarily pick the component with the longest SMILES string. smiles = max(smiles.split("."), key=len) ## Remove directional bonds to see if there are mismatches ## which are not caused by directional bonds. #if "/" in smiles: # smiles = smiles.replace("/", "") #if "\\" in smiles: # smiles = smiles.replace("\\", "") mol = Chem.MolFromSmiles(smiles) if mol is None: continue num_mols += 1 # Find all of the single bonds matches = mol.GetSubstructMatches(single_bond_pat) for a1, a2 in matches: # For each pair of atom indices, split on that bond # and determine the canonicalized fragmented molecule. # Do it for both fragment_trim() ... t1 = time.time() mol_trim = fragment_trim(mol, a1, a2) t2 = time.time() time_trim += t2-t1 smiles_trim = Chem.MolToSmiles(mol_trim, isomericSmiles=True) # ... and for fragment_on_bond() t1 = time.time() mol_on_bond = fragment_on_bond(mol, a1, a2) t2 = time.time() time_on_bond += t2-t1 smiles_on_bond = Chem.MolToSmiles(mol_on_bond, isomericSmiles=True) # Report any mismatches and keep on going. num_tests += 1 if smiles_trim != smiles_on_bond: print("Mismatch: record: {} id: {} smiles: {} cut: {} {}".format( recno, id, smiles, a1, a2)) print(" smiles_trim:", smiles_trim) print("smiles_on_bond:", smiles_on_bond) num_mismatches += 1 end_time = datetime.datetime.now() elapsed_time = str(end_time - start_time) elapsed_time = elapsed_time.partition(".")[0] # don't display subseconds print("Done.") print_status() print("elapsed time:", elapsed_time) if __name__ == "__main__": cross_validate()