Skip to content

Instantly share code, notes, and snippets.

@maclandrol
Last active March 14, 2022 20:03
Show Gist options
  • Save maclandrol/dd5695299107c1e167d6d1f671a786d1 to your computer and use it in GitHub Desktop.
Save maclandrol/dd5695299107c1e167d6d1f671a786d1 to your computer and use it in GitHub Desktop.
template alignment
Display the source blob
Display the rendered blob
Raw
{
"cells": [
{
"cell_type": "code",
"execution_count": 1,
"metadata": {},
"outputs": [],
"source": [
"%load_ext autoreload\n",
"%autoreload 2"
]
},
{
"cell_type": "code",
"execution_count": 2,
"metadata": {},
"outputs": [],
"source": [
"from typing import List\n",
"from typing import Optional\n",
"\n",
"import datamol as dm\n",
"from rdkit import Chem\n",
"from rdkit.Chem import Draw, rdFMCS, AllChem\n",
"from rdkit.Chem import rdDepictor\n",
"from rdkit.Chem.Scaffolds import MurckoScaffold\n",
"from collections import defaultdict as ddict"
]
},
{
"cell_type": "code",
"execution_count": 3,
"metadata": {},
"outputs": [],
"source": [
"def current_alignment(mol, template_smiles:Optional[str]=None):\n",
" if not template_smiles:\n",
" return mol\n",
" rdDepictor.Compute2DCoords(mol)\n",
" template = Chem.MolFromSmiles(template_smiles)\n",
" #rdDepictor.Compute2DCoords(template)\n",
" mcs = rdFMCS.FindMCS([mol, template])\n",
" if mcs.smartsString:\n",
" patt = Chem.MolFromSmarts(mcs.smartsString)\n",
"\n",
" query_match = mol.GetSubstructMatch(patt)\n",
" template_match = template.GetSubstructMatch(patt)\n",
" AllChem.AlignMol(\n",
" mol, template, atomMap=list(zip(query_match, template_match))\n",
" )\n",
" return mol"
]
},
{
"cell_type": "code",
"execution_count": 4,
"metadata": {},
"outputs": [],
"source": [
"def check_should_align(mols):\n",
" \"\"\"Check whether we should align the molecules on upload\"\"\"\n",
" # EN: rational is if any of the molecules already have computed conformers\n",
" # then we do not want to align them automatically (unless asked), because of the\n",
" # risk of overwritting the coordinates provided by the user\n",
" return not any(mol.GetNumConformers()> 0 for mol in mols)\n",
" \n",
"def _strip_molecule_to_core(mol, bond_cutter:dm.Mol=None):\n",
" \"\"\"\n",
" Strip a molecule to its core, i.e. remove all atoms not in the core.\n",
" This method 'guess' the molecular core, by finding the ring system\n",
" \"\"\"\n",
" if bond_cutter is None:\n",
" bond_cutter = dm.from_smarts(\"[R;!$(*=,#[!#6])]!@!=!#[*;$([A;!R][A;!R])]\")\n",
" \n",
" with dm.without_rdkit_log():\n",
" scaffold = MurckoScaffold.GetScaffoldForMol(mol)\n",
" out = mol.GetSubstructMatches(bond_cutter)\n",
" bond_inds = [mol.GetBondBetweenAtoms(i, j).GetIdx() for i, j in out]\n",
" if len(bond_inds) > 0:\n",
" fragmented = Chem.FragmentOnBonds(mol, bond_inds)\n",
" fragmented = dm.remove_dummies(fragmented)\n",
" fragmented = MurckoScaffold.GetScaffoldForMol(fragmented)\n",
" scaffold = dm.keep_largest_fragment(fragmented)\n",
" return scaffold\n",
" \n",
" \n",
"def make_scaffold_generic(mol, include_bonds:bool=False):\n",
" \"\"\"Make the atom in a scaffold or molecule generic\n",
" \n",
" Args:\n",
" mol: molecule or scaffold on which we should apply this function\n",
" include_bonds: whether we should also update bond order or keep as is\n",
" \"\"\"\n",
" res = Chem.Mol(mol)\n",
" for atom in res.GetAtoms():\n",
" if atom.GetAtomicNum() != 1:\n",
" atom.SetAtomicNum(0)\n",
" atom.SetFormalCharge(0)\n",
" atom.SetChiralTag(Chem.ChiralType.CHI_UNSPECIFIED)\n",
" atom.SetNoImplicit(0)\n",
" atom.SetNumExplicitHs(0)\n",
" if include_bonds:\n",
" for bond in res.GetBonds():\n",
" bond.SetBondType(Chem.BondType.UNSPECIFIED)\n",
" return dm.from_smarts(dm.to_smiles(res))\n",
"\n",
"def partition_and_align_mols(mols, partition:str=\"scaffold\", copy:bool=True, cutoff:float=0.7, **kwargs):\n",
" \"\"\"\n",
" Partition a list of molecules into clusters sharing common scaffold of common core,\n",
" then align the molecules to that common core. This function will compute the list of \n",
" smiles/smarts representative of each cluster first\n",
"\n",
" !!! note\n",
" Use this function at upload to align molecule when needed\n",
" \n",
" Args:\n",
" mols: list of molecules to partition\n",
" partition (str, optional): Partition method to use. Defaults to \"scaffold\".\n",
" One of ['scaffold', 'strip-scaffold', 'anongraph-scaffold', 'cluster' and 'anon-scaffold']. \n",
" copy: whether to copy the molecules before aligning them. Defaults to True.\n",
" cutoff: Optional cluster cutoff. Defaults to 0.7.\n",
" kwargs: Additional arguments to pass to clustering method\n",
" \"\"\"\n",
" if copy:\n",
" mols = [dm.copy_mol(mol) for mol in mols]\n",
" mol_groups = ddict(list) # map scaffold index to list of unique molecules\n",
" scaffold_mols = {}\n",
" if \"scaffold\" in partition:\n",
" scaffolds = [MurckoScaffold.GetScaffoldForMol(m) for m in mols]\n",
" scaffolds_ids = [dm.to_smiles(x) for x in scaffolds]\n",
" if partition.startswith(\"strip-\"):\n",
" # with brics scaffold we compute brics bonds, then re-infer and select the biggest\n",
" # fragment as candidate for core\n",
" bond_cutter = dm.from_smarts(\"[R;!$(*=,#[!#6])]!@!=!#[*;$([A;!R][A;!R])]\")\n",
" scaffolds = [_strip_molecule_to_core(x, bond_cutter=bond_cutter) for x in scaffolds]\n",
" scaffolds_ids = [dm.to_smiles(x) for x in scaffolds]\n",
" elif partition.startswith('anongraph-'):\n",
" scaffolds = [make_scaffold_generic(s, include_bonds=True) for s in scaffolds]\n",
" scaffolds_ids = [dm.to_smiles(x) for x in scaffolds]\n",
" elif partition.startswith(\"anon-\"):\n",
" scaffolds = [make_scaffold_generic(s, include_bonds=False) for s in scaffolds]\n",
" scaffolds_ids = [dm.to_smiles(x) for x in scaffolds]\n",
" for i, s in enumerate(scaffolds_ids):\n",
" mol_groups[s].append(i)\n",
" AllChem.Compute2DCoords(scaffolds[i])\n",
" scaffold_mols[s] = scaffolds[i]\n",
" else:\n",
" # partition is cluster, first compute molecule clusters\n",
" clusters, mol_clusters = dm.cluster_mols(mols, cutoff=cutoff, **kwargs)\n",
" # now compute the mcs for each clusters\n",
" cluster_mcs = [(dm.find_mcs(mol_cluster) if len(mol_cluster)>1 else dm.to_smiles(mol_cluster[0])) for mol_cluster in mol_clusters]\n",
" scaffolds_ids = [cluster_mcs[cluster_id] for cluster_id, _ in enumerate(clusters)]\n",
" for i, s in enumerate(scaffolds_ids):\n",
" mol_groups[s].extend(clusters[i])\n",
" for x in scaffolds_ids:\n",
" core = None\n",
" if x is not None:\n",
" core = dm.from_smarts(x)\n",
" AllChem.Compute2DCoords(core)\n",
" scaffold_mols[x] = core\n",
" \n",
" # now we match each molecule to the scaffold and align them\n",
" # note that the molecule object will be modified in place in the list\n",
" for core, mols_ids in mol_groups.items():\n",
" core_mol = scaffold_mols[core]\n",
" if core_mol is None:\n",
" print(core_mol)\n",
" pass\n",
" else:\n",
" for mol_id in mols_ids:\n",
" rdDepictor.GenerateDepictionMatching2DStructure(\n",
" mols[mol_id],\n",
" reference=core_mol,\n",
" acceptFailure=True,\n",
" allowRGroups=True,\n",
" )\n",
"\n",
"\n",
" # EN: you can discard the mol_groups (or keep it and match the values \n",
" # to molecular line notation, so you will not have to reocompute the above)\n",
" # and convert the mols into cxsmiles if you want\n",
" return mols, mol_groups\n",
" \n",
" \n",
"def template_align(mol, template:Optional[str]=None, copy:bool=True, use_depiction:bool=True, remove_confs:bool=True, auto_select_coord_gen:bool=False):\n",
" \"\"\"Align an input molecule to a template\n",
"\n",
" Args:\n",
" mol: input molecule\n",
" template_smiles: template to align to Defaults to None.\n",
" copy: whether to copy the molecule before aligning it. Defaults to True.\n",
" use_depiction: whether to use the depiction API or use MolAlign\n",
" The main difference is around how 3D information is handled, but also, because the depiction API\n",
" will emphasize the atoms that do not match, whereas AlignMol will not.\n",
" remove_confs: Whether to remove all conformation in the input molecule first. Default to True.\n",
" You set this to true when not using depiction\n",
" auto_select_coord_gen: whether to automatically select the coordinate generation method. \n",
"\n",
" Returns:\n",
" mol: aligned molecule to template\n",
" \"\"\"\n",
" # EN: this is for lines: 132-144 in lambda_handler_svg\n",
" # this assumes that whenever template_smiles is None, we should not align\n",
" # the reason being that this needs to be requested by the user\n",
" if isinstance(mol, str):\n",
" mol = dm.to_mol(mol)\n",
" \n",
" elif copy:\n",
" mol = dm.copy_mol(mol)\n",
" \n",
" if isinstance(template, str):\n",
" template = dm.to_mol(template)\n",
" \n",
" if template is None:\n",
" return mol\n",
" \n",
" if remove_confs:\n",
" mol.RemoveAllConformers()\n",
" \n",
" # EN: to make this more general and robust, we need to first check whether the template\n",
" # has 2D coordinates or not. If it does not, we need to compute them.\n",
" # This is a very rare edge case if requests are comming from the UI, but better to check than not xD\n",
" if template.GetNumConformers() == 0:\n",
" AllChem.Compute2DCoords(template)\n",
" # EN: now we can align the molecule to the template\n",
" # but first, we should avoid MCS as much as possible, because it's expensive\n",
" # so if the template is a subgraph of the molecule, no need to perform any MCS\n",
" # Another reason for this, is to avoid inconsistency in alignment between molecules that are\n",
" # supergraph of the template vs molecules that are subgraph of the template.\n",
" pattern = template\n",
" if not mol.HasSubstructMatch(template):\n",
" pattern = None\n",
" mcs_smarts = dm.find_mcs([mol, template]) \n",
" if mcs_smarts is not None:\n",
" pattern = dm.from_smarts(mcs_smarts)\n",
" \n",
" if pattern is not None:\n",
" if auto_select_coord_gen:\n",
" rdDepictor.SetPreferCoordGen(use_depiction)\n",
" # we would need to compute 2d coordinates for the molecules if it doesn't have any\n",
" if mol.GetNumConformers() == 0:\n",
" AllChem.Compute2DCoords(mol)\n",
" if use_depiction:\n",
" rdDepictor.GenerateDepictionMatching2DStructure(\n",
" mol,\n",
" reference=template,\n",
" refPatt=pattern,\n",
" acceptFailure=True,\n",
" allowRGroups=True,\n",
" )\n",
" else:\n",
" query_match = mol.GetSubstructMatch(pattern)\n",
" template_match = template.GetSubstructMatch(pattern)\n",
" AllChem.AlignMol(mol, template, atomMap=list(zip(query_match, template_match)))\n",
" return mol"
]
},
{
"cell_type": "markdown",
"metadata": {},
"source": [
"Scenario:\n",
"\n",
"1. On upload check whether the molecules have coordinate already with `check_should_align`\n",
" - If yes, do nothing\n",
" - Otherwise, attemp to partition and align then store the new coordinate\n",
"2. When the user perfom alignment again a template\n",
" - Call `template_align` with the input template"
]
},
{
"cell_type": "markdown",
"metadata": {},
"source": [
"### Test obvious failure cases"
]
},
{
"cell_type": "markdown",
"metadata": {},
"source": [
"1. Test coordinate presence"
]
},
{
"cell_type": "code",
"execution_count": 5,
"metadata": {},
"outputs": [],
"source": [
"# use the volkamer data\n",
"import pandas as pd\n",
"data = pd.read_csv(\"~/Desktop/chem-series.csv\")\n",
"# prioritize the smaller molecules xD"
]
},
{
"cell_type": "code",
"execution_count": 6,
"metadata": {},
"outputs": [],
"source": [
"molecules = data.SMILES.apply(dm.to_mol).values"
]
},
{
"cell_type": "code",
"execution_count": 7,
"metadata": {},
"outputs": [],
"source": [
"# we compute random coordinates for the molecules\n",
"molecules_with_confs = [dm.conformers.generate(mol, n_confs=2, align_conformers=False) for mol in molecules]"
]
},
{
"cell_type": "code",
"execution_count": 8,
"metadata": {},
"outputs": [],
"source": [
"# if we convert to cx smiles and reload, we should still have the coordinates\n",
"molecules_cx_smiles = [dm.to_smiles(x, cxsmiles=True) for x in molecules_with_confs]\n",
"molecules_cx = [dm.to_mol(x) for x in molecules_cx_smiles]"
]
},
{
"cell_type": "code",
"execution_count": 9,
"metadata": {},
"outputs": [],
"source": [
"# we expect no alignment on input for the molecules with conformers\n",
"assert check_should_align(molecules_with_confs) == False\n",
"assert check_should_align(molecules_cx) == False\n",
"assert check_should_align(molecules) == True"
]
},
{
"cell_type": "markdown",
"metadata": {},
"source": [
"2. Test partition and align on full dataset effect"
]
},
{
"cell_type": "code",
"execution_count": 10,
"metadata": {},
"outputs": [
{
"data": {
"image/svg+xml": "<svg baseProfile=\"full\" height=\"600px\" version=\"1.1\" viewBox=\"0 0 800 600\" width=\"800px\" xml:space=\"preserve\" xmlns=\"http://www.w3.org/2000/svg\" xmlns:rdkit=\"http://www.rdkit.org/xml\" xmlns:xlink=\"http://www.w3.org/1999/xlink\">\n<!-- END OF HEADER -->\n<rect height=\"600.0\" style=\"opacity:1.0;fill:#FFFFFF;stroke:none\" width=\"800.0\" x=\"0.0\" y=\"0.0\"> </rect>\n<rect height=\"600.0\" style=\"opacity:1.0;fill:#FFFFFF;stroke:none\" width=\"800.0\" x=\"0.0\" y=\"0.0\"> </rect>\n<rect height=\"600.0\" style=\"opacity:1.0;fill:#FFFFFF;stroke:none\" width=\"800.0\" x=\"0.0\" y=\"0.0\"> </rect>\n<rect height=\"600.0\" style=\"opacity:1.0;fill:#FFFFFF;stroke:none\" width=\"800.0\" x=\"0.0\" y=\"0.0\"> </rect>\n<rect height=\"600.0\" style=\"opacity:1.0;fill:#FFFFFF;stroke:none\" width=\"800.0\" x=\"0.0\" y=\"0.0\"> </rect>\n<rect height=\"600.0\" style=\"opacity:1.0;fill:#FFFFFF;stroke:none\" width=\"800.0\" x=\"0.0\" y=\"0.0\"> </rect>\n<rect height=\"600.0\" style=\"opacity:1.0;fill:#FFFFFF;stroke:none\" width=\"800.0\" x=\"0.0\" y=\"0.0\"> </rect>\n<rect height=\"600.0\" style=\"opacity:1.0;fill:#FFFFFF;stroke:none\" width=\"800.0\" x=\"0.0\" y=\"0.0\"> </rect>\n<rect height=\"600.0\" style=\"opacity:1.0;fill:#FFFFFF;stroke:none\" width=\"800.0\" x=\"0.0\" y=\"0.0\"> </rect>\n<rect height=\"600.0\" style=\"opacity:1.0;fill:#FFFFFF;stroke:none\" width=\"800.0\" x=\"0.0\" y=\"0.0\"> </rect>\n<rect height=\"600.0\" style=\"opacity:1.0;fill:#FFFFFF;stroke:none\" width=\"800.0\" x=\"0.0\" y=\"0.0\"> </rect>\n<rect height=\"600.0\" style=\"opacity:1.0;fill:#FFFFFF;stroke:none\" width=\"800.0\" x=\"0.0\" y=\"0.0\"> </rect>\n<rect height=\"600.0\" style=\"opacity:1.0;fill:#FFFFFF;stroke:none\" width=\"800.0\" x=\"0.0\" y=\"0.0\"> </rect>\n<rect height=\"600.0\" style=\"opacity:1.0;fill:#FFFFFF;stroke:none\" width=\"800.0\" x=\"0.0\" y=\"0.0\"> </rect>\n<rect height=\"600.0\" style=\"opacity:1.0;fill:#FFFFFF;stroke:none\" width=\"800.0\" x=\"0.0\" y=\"0.0\"> </rect>\n<rect height=\"600.0\" style=\"opacity:1.0;fill:#FFFFFF;stroke:none\" width=\"800.0\" x=\"0.0\" y=\"0.0\"> </rect>\n<rect height=\"600.0\" style=\"opacity:1.0;fill:#FFFFFF;stroke:none\" width=\"800.0\" x=\"0.0\" y=\"0.0\"> </rect>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 124.0,59.7 L 122.6,65.6\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 122.6,65.6 L 121.2,71.5\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 126.9,60.4 L 125.5,66.3\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 125.5,66.3 L 124.1,72.1\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-1 atom-1 atom-2\" d=\"M 122.7,71.8 L 127.0,75.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-1 atom-1 atom-2\" d=\"M 127.0,75.9 L 131.4,80.0\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-9 atom-1 atom-10\" d=\"M 122.7,71.8 L 116.6,73.6\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-9 atom-1 atom-10\" d=\"M 116.6,73.6 L 110.5,75.4\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-2 atom-2 atom-3\" d=\"M 135.3,81.3 L 141.4,79.5\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-2 atom-2 atom-3\" d=\"M 141.4,79.5 L 147.5,77.7\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-3 atom-3 atom-4\" d=\"M 147.5,77.7 L 158.1,87.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-3 atom-3 atom-4\" d=\"M 151.1,77.1 L 158.6,84.2\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-22 atom-8 atom-3\" d=\"M 150.9,63.4 L 147.5,77.7\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-4 atom-4 atom-5\" d=\"M 158.1,87.8 L 172.2,83.6\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-5 atom-5 atom-6\" d=\"M 172.2,83.6 L 175.7,69.3\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-5 atom-5 atom-6\" d=\"M 169.9,80.8 L 172.3,70.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-6 atom-6 atom-7\" d=\"M 175.7,69.3 L 165.0,59.2\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-7 atom-7 atom-8\" d=\"M 165.0,59.2 L 150.9,63.4\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-7 atom-7 atom-8\" d=\"M 163.7,62.6 L 153.8,65.6\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-8 atom-8 atom-9\" d=\"M 150.9,63.4 L 145.8,58.6\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-8 atom-8 atom-9\" d=\"M 145.8,58.6 L 140.8,53.9\" style=\"fill:none;fill-rule:evenodd;stroke:#00CC00;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-10 atom-10 atom-11\" d=\"M 106.6,74.1 L 102.2,70.0\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-10 atom-10 atom-11\" d=\"M 102.2,70.0 L 97.9,65.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-23 atom-22 atom-10\" d=\"M 105.2,90.3 L 106.6,84.4\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-23 atom-22 atom-10\" d=\"M 106.6,84.4 L 108.0,78.5\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-11 atom-11 atom-12\" d=\"M 97.9,65.9 L 83.8,70.1\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-12 atom-12 atom-13\" d=\"M 83.8,70.1 L 80.4,84.4\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-13 atom-13 atom-14\" d=\"M 80.4,84.4 L 66.3,88.6\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-20 atom-13 atom-21\" d=\"M 80.4,84.4 L 91.1,94.5\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-14 atom-14 atom-15\" d=\"M 66.3,88.6 L 61.9,84.5\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-14 atom-14 atom-15\" d=\"M 61.9,84.5 L 57.6,80.4\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-15 atom-15 atom-16\" d=\"M 56.2,76.0 L 57.6,70.1\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-15 atom-15 atom-16\" d=\"M 57.6,70.1 L 59.0,64.2\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-24 atom-20 atom-15\" d=\"M 41.5,82.7 L 47.5,80.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-24 atom-20 atom-15\" d=\"M 47.5,80.9 L 53.6,79.1\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-16 atom-16 atom-17\" d=\"M 59.0,64.2 L 48.3,54.1\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-17 atom-17 atom-18\" d=\"M 48.3,54.1 L 42.4,55.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-17 atom-17 atom-18\" d=\"M 42.4,55.8 L 36.5,57.6\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-18 atom-18 atom-19\" d=\"M 33.6,60.8 L 32.2,66.7\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-18 atom-18 atom-19\" d=\"M 32.2,66.7 L 30.8,72.6\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-19 atom-19 atom-20\" d=\"M 30.8,72.6 L 41.5,82.7\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-21 atom-21 atom-22\" d=\"M 91.1,94.5 L 105.2,90.3\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"atom-0\" d=\"M 124.1 57.5 Q 124.1 56.5, 124.6 55.9 Q 125.1 55.3, 126.1 55.3 Q 127.0 55.3, 127.5 55.9 Q 128.0 56.5, 128.0 57.5 Q 128.0 58.5, 127.5 59.1 Q 127.0 59.7, 126.1 59.7 Q 125.1 59.7, 124.6 59.1 Q 124.1 58.5, 124.1 57.5 M 126.1 59.2 Q 126.7 59.2, 127.1 58.8 Q 127.4 58.3, 127.4 57.5 Q 127.4 56.7, 127.1 56.2 Q 126.7 55.8, 126.1 55.8 Q 125.4 55.8, 125.1 56.2 Q 124.7 56.7, 124.7 57.5 Q 124.7 58.4, 125.1 58.8 Q 125.4 59.2, 126.1 59.2 \" fill=\"#FF0000\"/>\n<path class=\"atom-2\" d=\"M 132.4 79.8 L 133.8 82.0 Q 133.9 82.3, 134.2 82.7 Q 134.4 83.1, 134.4 83.1 L 134.4 79.8 L 135.0 79.8 L 135.0 84.0 L 134.4 84.0 L 132.9 81.6 Q 132.7 81.3, 132.5 81.0 Q 132.3 80.6, 132.3 80.5 L 132.3 84.0 L 131.7 84.0 L 131.7 79.8 L 132.4 79.8 \" fill=\"#0000FF\"/>\n<path class=\"atom-2\" d=\"M 131.7 84.5 L 132.3 84.5 L 132.3 86.3 L 134.4 86.3 L 134.4 84.5 L 135.0 84.5 L 135.0 88.7 L 134.4 88.7 L 134.4 86.7 L 132.3 86.7 L 132.3 88.7 L 131.7 88.7 L 131.7 84.5 \" fill=\"#0000FF\"/>\n<path class=\"atom-9\" d=\"M 136.1 53.4 Q 136.1 52.4, 136.6 51.8 Q 137.1 51.3, 138.0 51.3 Q 138.9 51.3, 139.4 51.9 L 139.0 52.2 Q 138.7 51.8, 138.0 51.8 Q 137.4 51.8, 137.1 52.2 Q 136.7 52.6, 136.7 53.4 Q 136.7 54.3, 137.1 54.7 Q 137.4 55.1, 138.1 55.1 Q 138.6 55.1, 139.1 54.9 L 139.3 55.3 Q 139.1 55.4, 138.7 55.5 Q 138.4 55.6, 138.0 55.6 Q 137.1 55.6, 136.6 55.1 Q 136.1 54.5, 136.1 53.4 \" fill=\"#00CC00\"/>\n<path class=\"atom-9\" d=\"M 139.9 51.0 L 140.5 51.0 L 140.5 55.6 L 139.9 55.6 L 139.9 51.0 \" fill=\"#00CC00\"/>\n<path class=\"atom-10\" d=\"M 107.6 73.9 L 109.0 76.1 Q 109.2 76.3, 109.4 76.7 Q 109.6 77.1, 109.6 77.2 L 109.6 73.9 L 110.2 73.9 L 110.2 78.1 L 109.6 78.1 L 108.1 75.7 Q 107.9 75.4, 107.7 75.0 Q 107.6 74.7, 107.5 74.6 L 107.5 78.1 L 107.0 78.1 L 107.0 73.9 L 107.6 73.9 \" fill=\"#0000FF\"/>\n<path class=\"atom-15\" d=\"M 54.6 76.4 L 56.0 78.6 Q 56.2 78.8, 56.4 79.2 Q 56.6 79.6, 56.6 79.7 L 56.6 76.4 L 57.2 76.4 L 57.2 80.6 L 56.6 80.6 L 55.1 78.1 Q 54.9 77.9, 54.8 77.5 Q 54.6 77.2, 54.5 77.1 L 54.5 80.6 L 54.0 80.6 L 54.0 76.4 L 54.6 76.4 \" fill=\"#0000FF\"/>\n<path class=\"atom-18\" d=\"M 32.3 58.3 Q 32.3 57.2, 32.8 56.7 Q 33.3 56.1, 34.2 56.1 Q 35.2 56.1, 35.7 56.7 Q 36.2 57.2, 36.2 58.3 Q 36.2 59.3, 35.7 59.9 Q 35.1 60.5, 34.2 60.5 Q 33.3 60.5, 32.8 59.9 Q 32.3 59.3, 32.3 58.3 M 34.2 60.0 Q 34.9 60.0, 35.2 59.6 Q 35.6 59.1, 35.6 58.3 Q 35.6 57.4, 35.2 57.0 Q 34.9 56.6, 34.2 56.6 Q 33.6 56.6, 33.2 57.0 Q 32.9 57.4, 32.9 58.3 Q 32.9 59.1, 33.2 59.6 Q 33.6 60.0, 34.2 60.0 \" fill=\"#FF0000\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 321.9,59.2 L 320.5,65.1\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 320.5,65.1 L 319.1,70.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 324.7,59.9 L 323.3,65.8\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 323.3,65.8 L 321.9,71.6\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-1 atom-1 atom-2\" d=\"M 320.5,71.3 L 324.9,75.4\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-1 atom-1 atom-2\" d=\"M 324.9,75.4 L 329.2,79.5\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-9 atom-1 atom-10\" d=\"M 320.5,71.3 L 314.5,73.1\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-9 atom-1 atom-10\" d=\"M 314.5,73.1 L 308.4,74.9\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-2 atom-2 atom-3\" d=\"M 333.2,80.8 L 339.2,79.0\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-2 atom-2 atom-3\" d=\"M 339.2,79.0 L 345.3,77.2\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-3 atom-3 atom-4\" d=\"M 345.3,77.2 L 356.0,87.3\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-3 atom-3 atom-4\" d=\"M 348.9,76.6 L 356.4,83.7\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-22 atom-9 atom-3\" d=\"M 348.7,62.9 L 345.3,77.2\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-4 atom-4 atom-5\" d=\"M 356.0,87.3 L 370.1,83.1\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-5 atom-5 atom-6\" d=\"M 370.1,83.1 L 373.5,68.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-5 atom-5 atom-6\" d=\"M 367.7,80.3 L 370.1,70.3\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-6 atom-6 atom-7\" d=\"M 373.5,68.8 L 379.7,66.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-6 atom-6 atom-7\" d=\"M 379.7,66.9 L 386.0,65.1\" style=\"fill:none;fill-rule:evenodd;stroke:#33CCCC;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-7 atom-6 atom-8\" d=\"M 373.5,68.8 L 362.8,58.7\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-8 atom-8 atom-9\" d=\"M 362.8,58.7 L 348.7,62.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-8 atom-8 atom-9\" d=\"M 361.5,62.1 L 351.7,65.1\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-10 atom-10 atom-11\" d=\"M 304.4,73.6 L 300.1,69.5\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-10 atom-10 atom-11\" d=\"M 300.1,69.5 L 295.7,65.4\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-23 atom-22 atom-10\" d=\"M 303.0,89.8 L 304.4,83.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-23 atom-22 atom-10\" d=\"M 304.4,83.9 L 305.8,78.0\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-11 atom-11 atom-12\" d=\"M 295.7,65.4 L 281.6,69.6\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-12 atom-12 atom-13\" d=\"M 281.6,69.6 L 278.2,83.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-13 atom-13 atom-14\" d=\"M 278.2,83.9 L 264.1,88.1\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-20 atom-13 atom-21\" d=\"M 278.2,83.9 L 288.9,94.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-14 atom-14 atom-15\" d=\"M 264.1,88.1 L 259.8,84.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-14 atom-14 atom-15\" d=\"M 259.8,84.0 L 255.4,79.8\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-15 atom-15 atom-16\" d=\"M 254.0,75.5 L 255.4,69.6\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-15 atom-15 atom-16\" d=\"M 255.4,69.6 L 256.8,63.7\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-24 atom-20 atom-15\" d=\"M 239.3,82.2 L 245.4,80.4\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-24 atom-20 atom-15\" d=\"M 245.4,80.4 L 251.5,78.6\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-16 atom-16 atom-17\" d=\"M 256.8,63.7 L 246.2,53.5\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-17 atom-17 atom-18\" d=\"M 246.2,53.5 L 240.3,55.3\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-17 atom-17 atom-18\" d=\"M 240.3,55.3 L 234.4,57.0\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-18 atom-18 atom-19\" d=\"M 231.4,60.3 L 230.0,66.2\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-18 atom-18 atom-19\" d=\"M 230.0,66.2 L 228.6,72.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-19 atom-19 atom-20\" d=\"M 228.6,72.0 L 239.3,82.2\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-21 atom-21 atom-22\" d=\"M 288.9,94.0 L 303.0,89.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"atom-0\" d=\"M 322.0 57.0 Q 322.0 56.0, 322.5 55.4 Q 323.0 54.8, 323.9 54.8 Q 324.9 54.8, 325.4 55.4 Q 325.9 56.0, 325.9 57.0 Q 325.9 58.0, 325.4 58.6 Q 324.9 59.2, 323.9 59.2 Q 323.0 59.2, 322.5 58.6 Q 322.0 58.0, 322.0 57.0 M 323.9 58.7 Q 324.6 58.7, 324.9 58.3 Q 325.3 57.8, 325.3 57.0 Q 325.3 56.1, 324.9 55.7 Q 324.6 55.3, 323.9 55.3 Q 323.3 55.3, 322.9 55.7 Q 322.6 56.1, 322.6 57.0 Q 322.6 57.8, 322.9 58.3 Q 323.3 58.7, 323.9 58.7 \" fill=\"#FF0000\"/>\n<path class=\"atom-2\" d=\"M 330.3 79.3 L 331.7 81.5 Q 331.8 81.7, 332.0 82.1 Q 332.2 82.5, 332.2 82.6 L 332.2 79.3 L 332.8 79.3 L 332.8 83.5 L 332.2 83.5 L 330.7 81.1 Q 330.6 80.8, 330.4 80.4 Q 330.2 80.1, 330.1 80.0 L 330.1 83.5 L 329.6 83.5 L 329.6 79.3 L 330.3 79.3 \" fill=\"#0000FF\"/>\n<path class=\"atom-2\" d=\"M 329.5 83.9 L 330.1 83.9 L 330.1 85.7 L 332.3 85.7 L 332.3 83.9 L 332.9 83.9 L 332.9 88.2 L 332.3 88.2 L 332.3 86.2 L 330.1 86.2 L 330.1 88.2 L 329.5 88.2 L 329.5 83.9 \" fill=\"#0000FF\"/>\n<path class=\"atom-7\" d=\"M 386.3 62.5 L 388.9 62.5 L 388.9 63.0 L 386.9 63.0 L 386.9 64.3 L 388.6 64.3 L 388.6 64.7 L 386.9 64.7 L 386.9 66.7 L 386.3 66.7 L 386.3 62.5 \" fill=\"#33CCCC\"/>\n<path class=\"atom-10\" d=\"M 305.5 73.4 L 306.9 75.6 Q 307.0 75.8, 307.2 76.2 Q 307.4 76.6, 307.5 76.7 L 307.5 73.4 L 308.0 73.4 L 308.0 77.6 L 307.4 77.6 L 305.9 75.1 Q 305.8 74.9, 305.6 74.5 Q 305.4 74.2, 305.4 74.1 L 305.4 77.6 L 304.8 77.6 L 304.8 73.4 L 305.5 73.4 \" fill=\"#0000FF\"/>\n<path class=\"atom-15\" d=\"M 252.5 75.8 L 253.9 78.1 Q 254.0 78.3, 254.2 78.7 Q 254.5 79.1, 254.5 79.1 L 254.5 75.8 L 255.0 75.8 L 255.0 80.1 L 254.5 80.1 L 253.0 77.6 Q 252.8 77.3, 252.6 77.0 Q 252.4 76.7, 252.4 76.6 L 252.4 80.1 L 251.8 80.1 L 251.8 75.8 L 252.5 75.8 \" fill=\"#0000FF\"/>\n<path class=\"atom-18\" d=\"M 230.1 57.8 Q 230.1 56.7, 230.6 56.2 Q 231.1 55.6, 232.1 55.6 Q 233.0 55.6, 233.5 56.2 Q 234.0 56.7, 234.0 57.8 Q 234.0 58.8, 233.5 59.4 Q 233.0 60.0, 232.1 60.0 Q 231.1 60.0, 230.6 59.4 Q 230.1 58.8, 230.1 57.8 M 232.1 59.5 Q 232.7 59.5, 233.1 59.0 Q 233.4 58.6, 233.4 57.8 Q 233.4 56.9, 233.1 56.5 Q 232.7 56.1, 232.1 56.1 Q 231.4 56.1, 231.1 56.5 Q 230.7 56.9, 230.7 57.8 Q 230.7 58.6, 231.1 59.0 Q 231.4 59.5, 232.1 59.5 \" fill=\"#FF0000\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 412.3,83.2 L 418.4,81.5\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 418.4,81.5 L 424.5,79.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 413.1,86.0 L 418.3,84.6\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 418.3,84.6 L 423.5,83.2\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 411.5,80.4 L 416.7,78.9\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 416.7,78.9 L 421.9,77.5\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-1 atom-1 atom-2\" d=\"M 424.5,79.8 L 438.7,75.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-2 atom-2 atom-3\" d=\"M 438.7,75.9 L 442.4,61.7\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-2 atom-2 atom-3\" d=\"M 442.1,74.5 L 444.7,64.5\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-23 atom-23 atom-2\" d=\"M 449.2,86.2 L 438.7,75.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-3 atom-3 atom-4\" d=\"M 442.4,61.7 L 456.6,57.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-4 atom-4 atom-5\" d=\"M 456.6,57.8 L 467.0,68.1\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-4 atom-4 atom-5\" d=\"M 456.1,61.4 L 463.4,68.6\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-5 atom-5 atom-6\" d=\"M 467.0,68.1 L 473.1,66.4\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-5 atom-5 atom-6\" d=\"M 473.1,66.4 L 479.3,64.7\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-21 atom-5 atom-22\" d=\"M 467.0,68.1 L 463.3,82.3\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-6 atom-6 atom-7\" d=\"M 483.2,66.1 L 487.5,70.3\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-6 atom-6 atom-7\" d=\"M 487.5,70.3 L 491.7,74.5\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-7 atom-7 atom-8\" d=\"M 490.3,74.1 L 488.8,80.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-7 atom-7 atom-8\" d=\"M 488.8,80.0 L 487.2,85.8\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-7 atom-7 atom-8\" d=\"M 493.1,74.9 L 491.6,80.7\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-7 atom-7 atom-8\" d=\"M 491.6,80.7 L 490.1,86.6\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-8 atom-7 atom-9\" d=\"M 491.7,74.5 L 497.8,72.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-8 atom-7 atom-9\" d=\"M 497.8,72.8 L 503.9,71.1\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-9 atom-9 atom-10\" d=\"M 507.9,72.5 L 512.1,76.7\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-9 atom-9 atom-10\" d=\"M 512.1,76.7 L 516.4,80.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-24 atom-21 atom-9\" d=\"M 509.6,56.3 L 508.1,62.2\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-24 atom-21 atom-9\" d=\"M 508.1,62.2 L 506.5,68.1\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-10 atom-10 atom-11\" d=\"M 516.4,80.9 L 530.6,77.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-11 atom-11 atom-12\" d=\"M 530.6,77.0 L 534.3,62.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-12 atom-12 atom-13\" d=\"M 534.3,62.8 L 548.4,58.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-19 atom-12 atom-20\" d=\"M 534.3,62.8 L 523.8,52.4\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-13 atom-13 atom-14\" d=\"M 548.4,58.8 L 552.7,63.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-13 atom-13 atom-14\" d=\"M 552.7,63.0 L 556.9,67.2\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-14 atom-14 atom-15\" d=\"M 558.3,71.7 L 556.7,77.5\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-14 atom-14 atom-15\" d=\"M 556.7,77.5 L 555.2,83.4\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-25 atom-19 atom-14\" d=\"M 573.1,65.3 L 567.0,66.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-25 atom-19 atom-14\" d=\"M 567.0,66.9 L 560.9,68.6\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-15 atom-15 atom-16\" d=\"M 555.2,83.4 L 565.7,93.7\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-16 atom-16 atom-17\" d=\"M 565.7,93.7 L 571.6,92.1\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-16 atom-16 atom-17\" d=\"M 571.6,92.1 L 577.6,90.5\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-17 atom-17 atom-18\" d=\"M 580.5,87.3 L 582.0,81.4\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-17 atom-17 atom-18\" d=\"M 582.0,81.4 L 583.6,75.6\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-18 atom-18 atom-19\" d=\"M 583.6,75.6 L 573.1,65.3\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-20 atom-20 atom-21\" d=\"M 523.8,52.4 L 509.6,56.3\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-22 atom-22 atom-23\" d=\"M 463.3,82.3 L 449.2,86.2\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-22 atom-22 atom-23\" d=\"M 460.4,80.1 L 450.5,82.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"atom-0\" d=\"M 409.4 81.6 L 410.8 83.9 Q 410.9 84.1, 411.1 84.5 Q 411.4 84.9, 411.4 84.9 L 411.4 81.6 L 411.9 81.6 L 411.9 85.9 L 411.4 85.9 L 409.9 83.4 Q 409.7 83.1, 409.5 82.8 Q 409.3 82.4, 409.3 82.3 L 409.3 85.9 L 408.7 85.9 L 408.7 81.6 L 409.4 81.6 \" fill=\"#0000FF\"/>\n<path class=\"atom-6\" d=\"M 480.3 62.0 L 481.7 64.3 Q 481.8 64.5, 482.0 64.9 Q 482.3 65.3, 482.3 65.3 L 482.3 62.0 L 482.8 62.0 L 482.8 66.3 L 482.3 66.3 L 480.8 63.8 Q 480.6 63.5, 480.4 63.2 Q 480.2 62.9, 480.2 62.8 L 480.2 66.3 L 479.6 66.3 L 479.6 62.0 L 480.3 62.0 \" fill=\"#0000FF\"/>\n<path class=\"atom-6\" d=\"M 479.6 57.4 L 480.1 57.4 L 480.1 59.2 L 482.3 59.2 L 482.3 57.4 L 482.9 57.4 L 482.9 61.6 L 482.3 61.6 L 482.3 59.7 L 480.1 59.7 L 480.1 61.6 L 479.6 61.6 L 479.6 57.4 \" fill=\"#0000FF\"/>\n<path class=\"atom-8\" d=\"M 486.1 88.7 Q 486.1 87.7, 486.6 87.2 Q 487.1 86.6, 488.0 86.6 Q 488.9 86.6, 489.5 87.2 Q 490.0 87.7, 490.0 88.7 Q 490.0 89.8, 489.4 90.4 Q 488.9 90.9, 488.0 90.9 Q 487.1 90.9, 486.6 90.4 Q 486.1 89.8, 486.1 88.7 M 488.0 90.5 Q 488.7 90.5, 489.0 90.0 Q 489.4 89.6, 489.4 88.7 Q 489.4 87.9, 489.0 87.5 Q 488.7 87.1, 488.0 87.1 Q 487.4 87.1, 487.0 87.5 Q 486.7 87.9, 486.7 88.7 Q 486.7 89.6, 487.0 90.0 Q 487.4 90.5, 488.0 90.5 \" fill=\"#FF0000\"/>\n<path class=\"atom-9\" d=\"M 505.0 68.5 L 506.3 70.7 Q 506.5 70.9, 506.7 71.3 Q 506.9 71.7, 506.9 71.8 L 506.9 68.5 L 507.5 68.5 L 507.5 72.7 L 506.9 72.7 L 505.4 70.2 Q 505.3 70.0, 505.1 69.6 Q 504.9 69.3, 504.8 69.2 L 504.8 72.7 L 504.3 72.7 L 504.3 68.5 L 505.0 68.5 \" fill=\"#0000FF\"/>\n<path class=\"atom-14\" d=\"M 558.0 67.0 L 559.4 69.3 Q 559.5 69.5, 559.7 69.9 Q 559.9 70.3, 560.0 70.3 L 560.0 67.0 L 560.5 67.0 L 560.5 71.3 L 559.9 71.3 L 558.4 68.8 Q 558.3 68.5, 558.1 68.2 Q 557.9 67.9, 557.9 67.8 L 557.9 71.3 L 557.3 71.3 L 557.3 67.0 L 558.0 67.0 \" fill=\"#0000FF\"/>\n<path class=\"atom-17\" d=\"M 577.9 89.8 Q 577.9 88.8, 578.4 88.2 Q 578.9 87.7, 579.9 87.7 Q 580.8 87.7, 581.3 88.2 Q 581.8 88.8, 581.8 89.8 Q 581.8 90.9, 581.3 91.5 Q 580.8 92.0, 579.9 92.0 Q 578.9 92.0, 578.4 91.5 Q 577.9 90.9, 577.9 89.8 M 579.9 91.6 Q 580.5 91.6, 580.9 91.1 Q 581.2 90.7, 581.2 89.8 Q 581.2 89.0, 580.9 88.6 Q 580.5 88.2, 579.9 88.2 Q 579.2 88.2, 578.9 88.6 Q 578.5 89.0, 578.5 89.8 Q 578.5 90.7, 578.9 91.1 Q 579.2 91.6, 579.9 91.6 \" fill=\"#FF0000\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 640.4,99.8 L 644.1,85.6\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-1 atom-1 atom-2\" d=\"M 644.1,85.6 L 633.7,75.2\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-1 atom-1 atom-2\" d=\"M 644.6,82.0 L 637.3,74.7\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-22 atom-22 atom-1\" d=\"M 658.3,81.7 L 644.1,85.6\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-2 atom-2 atom-3\" d=\"M 633.7,75.2 L 637.4,61.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-3 atom-3 atom-4\" d=\"M 637.4,61.0 L 651.6,57.2\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-3 atom-3 atom-4\" d=\"M 640.3,63.3 L 650.3,60.6\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-4 atom-4 atom-5\" d=\"M 651.6,57.2 L 662.1,67.5\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-5 atom-5 atom-6\" d=\"M 662.1,67.5 L 668.2,65.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-5 atom-5 atom-6\" d=\"M 668.2,65.8 L 674.3,64.2\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-21 atom-5 atom-22\" d=\"M 662.1,67.5 L 658.3,81.7\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-21 atom-5 atom-22\" d=\"M 658.7,68.9 L 656.0,78.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-6 atom-6 atom-7\" d=\"M 678.2,65.6 L 682.5,69.8\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-6 atom-6 atom-7\" d=\"M 682.5,69.8 L 686.7,74.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-7 atom-7 atom-8\" d=\"M 685.3,73.6 L 683.8,79.5\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-7 atom-7 atom-8\" d=\"M 683.8,79.5 L 682.2,85.3\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-7 atom-7 atom-8\" d=\"M 688.1,74.4 L 686.6,80.2\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-7 atom-7 atom-8\" d=\"M 686.6,80.2 L 685.1,86.1\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-8 atom-7 atom-9\" d=\"M 686.7,74.0 L 692.8,72.3\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-8 atom-7 atom-9\" d=\"M 692.8,72.3 L 698.9,70.7\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-9 atom-9 atom-10\" d=\"M 702.9,72.1 L 707.1,76.3\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-9 atom-9 atom-10\" d=\"M 707.1,76.3 L 711.4,80.5\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-23 atom-21 atom-9\" d=\"M 704.7,55.9 L 703.1,61.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-23 atom-21 atom-9\" d=\"M 703.1,61.8 L 701.6,67.6\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-10 atom-10 atom-11\" d=\"M 711.4,80.5 L 725.6,76.6\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-11 atom-11 atom-12\" d=\"M 725.6,76.6 L 729.3,62.4\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-12 atom-12 atom-13\" d=\"M 729.3,62.4 L 743.5,58.5\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-19 atom-12 atom-20\" d=\"M 729.3,62.4 L 718.9,52.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-13 atom-13 atom-14\" d=\"M 743.5,58.5 L 747.7,62.7\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-13 atom-13 atom-14\" d=\"M 747.7,62.7 L 752.0,66.9\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-14 atom-14 atom-15\" d=\"M 753.3,71.4 L 751.7,77.2\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-14 atom-14 atom-15\" d=\"M 751.7,77.2 L 750.2,83.1\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-24 atom-19 atom-14\" d=\"M 768.1,65.0 L 762.0,66.7\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-24 atom-19 atom-14\" d=\"M 762.0,66.7 L 755.9,68.3\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-15 atom-15 atom-16\" d=\"M 750.2,83.1 L 760.6,93.5\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-16 atom-16 atom-17\" d=\"M 760.6,93.5 L 766.6,91.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-16 atom-16 atom-17\" d=\"M 766.6,91.8 L 772.5,90.2\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-17 atom-17 atom-18\" d=\"M 775.5,87.1 L 777.0,81.2\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-17 atom-17 atom-18\" d=\"M 777.0,81.2 L 778.6,75.4\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-18 atom-18 atom-19\" d=\"M 778.6,75.4 L 768.1,65.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-20 atom-20 atom-21\" d=\"M 718.9,52.0 L 704.7,55.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"atom-6\" d=\"M 675.3 61.5 L 676.7 63.8 Q 676.9 64.0, 677.1 64.4 Q 677.3 64.8, 677.3 64.8 L 677.3 61.5 L 677.9 61.5 L 677.9 65.8 L 677.3 65.8 L 675.8 63.3 Q 675.6 63.0, 675.4 62.7 Q 675.3 62.4, 675.2 62.3 L 675.2 65.8 L 674.7 65.8 L 674.7 61.5 L 675.3 61.5 \" fill=\"#0000FF\"/>\n<path class=\"atom-6\" d=\"M 674.6 56.8 L 675.2 56.8 L 675.2 58.6 L 677.4 58.6 L 677.4 56.8 L 677.9 56.8 L 677.9 61.1 L 677.4 61.1 L 677.4 59.1 L 675.2 59.1 L 675.2 61.1 L 674.6 61.1 L 674.6 56.8 \" fill=\"#0000FF\"/>\n<path class=\"atom-8\" d=\"M 681.0 88.2 Q 681.0 87.2, 681.5 86.6 Q 682.0 86.1, 683.0 86.1 Q 683.9 86.1, 684.4 86.6 Q 684.9 87.2, 684.9 88.2 Q 684.9 89.3, 684.4 89.9 Q 683.9 90.4, 683.0 90.4 Q 682.0 90.4, 681.5 89.9 Q 681.0 89.3, 681.0 88.2 M 683.0 90.0 Q 683.6 90.0, 684.0 89.5 Q 684.3 89.1, 684.3 88.2 Q 684.3 87.4, 684.0 87.0 Q 683.6 86.6, 683.0 86.6 Q 682.3 86.6, 682.0 87.0 Q 681.6 87.4, 681.6 88.2 Q 681.6 89.1, 682.0 89.5 Q 682.3 90.0, 683.0 90.0 \" fill=\"#FF0000\"/>\n<path class=\"atom-9\" d=\"M 700.0 68.0 L 701.4 70.3 Q 701.5 70.5, 701.7 70.9 Q 701.9 71.3, 702.0 71.3 L 702.0 68.0 L 702.5 68.0 L 702.5 72.3 L 701.9 72.3 L 700.4 69.8 Q 700.3 69.5, 700.1 69.2 Q 699.9 68.8, 699.9 68.7 L 699.9 72.3 L 699.3 72.3 L 699.3 68.0 L 700.0 68.0 \" fill=\"#0000FF\"/>\n<path class=\"atom-14\" d=\"M 753.0 66.8 L 754.4 69.0 Q 754.5 69.2, 754.8 69.6 Q 755.0 70.0, 755.0 70.1 L 755.0 66.8 L 755.5 66.8 L 755.5 71.0 L 755.0 71.0 L 753.5 68.5 Q 753.3 68.3, 753.1 67.9 Q 752.9 67.6, 752.9 67.5 L 752.9 71.0 L 752.3 71.0 L 752.3 66.8 L 753.0 66.8 \" fill=\"#0000FF\"/>\n<path class=\"atom-17\" d=\"M 772.9 89.6 Q 772.9 88.6, 773.4 88.0 Q 773.9 87.4, 774.8 87.4 Q 775.8 87.4, 776.3 88.0 Q 776.8 88.6, 776.8 89.6 Q 776.8 90.6, 776.3 91.2 Q 775.8 91.8, 774.8 91.8 Q 773.9 91.8, 773.4 91.2 Q 772.9 90.6, 772.9 89.6 M 774.8 91.3 Q 775.5 91.3, 775.8 90.9 Q 776.2 90.5, 776.2 89.6 Q 776.2 88.8, 775.8 88.4 Q 775.5 87.9, 774.8 87.9 Q 774.2 87.9, 773.8 88.3 Q 773.5 88.8, 773.5 89.6 Q 773.5 90.5, 773.8 90.9 Q 774.2 91.3, 774.8 91.3 \" fill=\"#FF0000\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 121.5,207.1 L 120.3,213.1\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 120.3,213.1 L 119.2,219.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 124.4,207.7 L 123.2,213.6\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 123.2,213.6 L 122.1,219.6\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-1 atom-1 atom-2\" d=\"M 120.6,219.3 L 125.2,223.2\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-1 atom-1 atom-2\" d=\"M 125.2,223.2 L 129.8,227.2\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-9 atom-1 atom-10\" d=\"M 120.6,219.3 L 114.7,221.3\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-9 atom-1 atom-10\" d=\"M 114.7,221.3 L 108.7,223.4\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-2 atom-2 atom-3\" d=\"M 133.8,228.2 L 139.7,226.1\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-2 atom-2 atom-3\" d=\"M 139.7,226.1 L 145.7,224.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-3 atom-3 atom-4\" d=\"M 145.7,224.0 L 156.8,233.7\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-3 atom-3 atom-4\" d=\"M 149.3,223.3 L 157.1,230.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-22 atom-9 atom-3\" d=\"M 148.4,209.6 L 145.7,224.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-4 atom-4 atom-5\" d=\"M 156.8,233.7 L 170.7,228.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-5 atom-5 atom-6\" d=\"M 170.7,228.8 L 175.5,232.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-5 atom-5 atom-6\" d=\"M 175.5,232.9 L 180.2,237.0\" style=\"fill:none;fill-rule:evenodd;stroke:#33CCCC;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-6 atom-5 atom-7\" d=\"M 170.7,228.8 L 173.5,214.4\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-6 atom-5 atom-7\" d=\"M 168.2,226.1 L 170.2,216.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-7 atom-7 atom-8\" d=\"M 173.5,214.4 L 162.3,204.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-8 atom-8 atom-9\" d=\"M 162.3,204.8 L 148.4,209.6\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-8 atom-8 atom-9\" d=\"M 161.2,208.3 L 151.5,211.7\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-10 atom-10 atom-11\" d=\"M 104.8,222.4 L 100.2,218.5\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-10 atom-10 atom-11\" d=\"M 100.2,218.5 L 95.6,214.5\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-23 atom-22 atom-10\" d=\"M 104.0,238.6 L 105.1,232.6\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-23 atom-22 atom-10\" d=\"M 105.1,232.6 L 106.3,226.6\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-11 atom-11 atom-12\" d=\"M 95.6,214.5 L 81.7,219.3\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-12 atom-12 atom-13\" d=\"M 81.7,219.3 L 79.0,233.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-13 atom-13 atom-14\" d=\"M 79.0,233.8 L 65.1,238.6\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-20 atom-13 atom-21\" d=\"M 79.0,233.8 L 90.1,243.4\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-14 atom-14 atom-15\" d=\"M 65.1,238.6 L 60.5,234.7\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-14 atom-14 atom-15\" d=\"M 60.5,234.7 L 55.9,230.7\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-15 atom-15 atom-16\" d=\"M 54.4,226.5 L 55.6,220.5\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-15 atom-15 atom-16\" d=\"M 55.6,220.5 L 56.7,214.6\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-24 atom-20 atom-15\" d=\"M 40.0,233.9 L 46.0,231.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-24 atom-20 atom-15\" d=\"M 46.0,231.8 L 52.0,229.7\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-16 atom-16 atom-17\" d=\"M 56.7,214.6 L 45.6,205.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-17 atom-17 atom-18\" d=\"M 45.6,205.0 L 39.8,207.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-17 atom-17 atom-18\" d=\"M 39.8,207.0 L 34.0,209.0\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-18 atom-18 atom-19\" d=\"M 31.2,212.4 L 30.0,218.3\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-18 atom-18 atom-19\" d=\"M 30.0,218.3 L 28.9,224.2\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-19 atom-19 atom-20\" d=\"M 28.9,224.2 L 40.0,233.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-21 atom-21 atom-22\" d=\"M 90.1,243.4 L 104.0,238.6\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"atom-0\" d=\"M 121.5 204.8 Q 121.5 203.8, 122.0 203.2 Q 122.5 202.7, 123.4 202.7 Q 124.3 202.7, 124.8 203.2 Q 125.4 203.8, 125.4 204.8 Q 125.4 205.9, 124.8 206.5 Q 124.3 207.0, 123.4 207.0 Q 122.5 207.0, 122.0 206.5 Q 121.5 205.9, 121.5 204.8 M 123.4 206.6 Q 124.0 206.6, 124.4 206.1 Q 124.8 205.7, 124.8 204.8 Q 124.8 204.0, 124.4 203.6 Q 124.0 203.2, 123.4 203.2 Q 122.8 203.2, 122.4 203.6 Q 122.1 204.0, 122.1 204.8 Q 122.1 205.7, 122.4 206.1 Q 122.8 206.6, 123.4 206.6 \" fill=\"#FF0000\"/>\n<path class=\"atom-2\" d=\"M 130.8 226.8 L 132.2 229.0 Q 132.4 229.2, 132.6 229.6 Q 132.8 230.0, 132.8 230.1 L 132.8 226.8 L 133.4 226.8 L 133.4 231.0 L 132.8 231.0 L 131.3 228.6 Q 131.1 228.3, 131.0 227.9 Q 130.8 227.6, 130.7 227.5 L 130.7 231.0 L 130.2 231.0 L 130.2 226.8 L 130.8 226.8 \" fill=\"#0000FF\"/>\n<path class=\"atom-2\" d=\"M 130.1 231.4 L 130.7 231.4 L 130.7 233.2 L 132.9 233.2 L 132.9 231.4 L 133.4 231.4 L 133.4 235.7 L 132.9 235.7 L 132.9 233.7 L 130.7 233.7 L 130.7 235.7 L 130.1 235.7 L 130.1 231.4 \" fill=\"#0000FF\"/>\n<path class=\"atom-6\" d=\"M 180.6 236.3 L 183.1 236.3 L 183.1 236.8 L 181.1 236.8 L 181.1 238.1 L 182.9 238.1 L 182.9 238.6 L 181.1 238.6 L 181.1 240.6 L 180.6 240.6 L 180.6 236.3 \" fill=\"#33CCCC\"/>\n<path class=\"atom-10\" d=\"M 105.8 222.0 L 107.2 224.2 Q 107.3 224.5, 107.6 224.9 Q 107.8 225.3, 107.8 225.3 L 107.8 222.0 L 108.4 222.0 L 108.4 226.2 L 107.8 226.2 L 106.3 223.8 Q 106.1 223.5, 105.9 223.2 Q 105.7 222.8, 105.7 222.7 L 105.7 226.2 L 105.1 226.2 L 105.1 222.0 L 105.8 222.0 \" fill=\"#0000FF\"/>\n<path class=\"atom-15\" d=\"M 53.0 226.9 L 54.4 229.1 Q 54.5 229.4, 54.7 229.8 Q 55.0 230.2, 55.0 230.2 L 55.0 226.9 L 55.5 226.9 L 55.5 231.1 L 55.0 231.1 L 53.5 228.7 Q 53.3 228.4, 53.1 228.1 Q 52.9 227.7, 52.9 227.6 L 52.9 231.1 L 52.3 231.1 L 52.3 226.9 L 53.0 226.9 \" fill=\"#0000FF\"/>\n<path class=\"atom-18\" d=\"M 29.7 209.8 Q 29.7 208.8, 30.2 208.2 Q 30.7 207.6, 31.7 207.6 Q 32.6 207.6, 33.1 208.2 Q 33.6 208.8, 33.6 209.8 Q 33.6 210.8, 33.1 211.4 Q 32.6 212.0, 31.7 212.0 Q 30.7 212.0, 30.2 211.4 Q 29.7 210.8, 29.7 209.8 M 31.7 211.5 Q 32.3 211.5, 32.7 211.1 Q 33.0 210.7, 33.0 209.8 Q 33.0 209.0, 32.7 208.6 Q 32.3 208.1, 31.7 208.1 Q 31.0 208.1, 30.7 208.5 Q 30.3 209.0, 30.3 209.8 Q 30.3 210.7, 30.7 211.1 Q 31.0 211.5, 31.7 211.5 \" fill=\"#FF0000\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 324.0,209.7 L 322.6,215.6\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 322.6,215.6 L 321.2,221.5\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 326.9,210.4 L 325.5,216.3\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 325.5,216.3 L 324.1,222.1\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-1 atom-1 atom-2\" d=\"M 322.7,221.8 L 327.0,225.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-1 atom-1 atom-2\" d=\"M 327.0,225.9 L 331.4,230.0\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-9 atom-1 atom-10\" d=\"M 322.7,221.8 L 316.6,223.6\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-9 atom-1 atom-10\" d=\"M 316.6,223.6 L 310.5,225.4\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-2 atom-2 atom-3\" d=\"M 335.3,231.3 L 341.4,229.5\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-2 atom-2 atom-3\" d=\"M 341.4,229.5 L 347.5,227.7\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-3 atom-3 atom-4\" d=\"M 347.5,227.7 L 358.1,237.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-3 atom-3 atom-4\" d=\"M 351.1,227.1 L 358.6,234.2\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-22 atom-8 atom-3\" d=\"M 350.9,213.4 L 347.5,227.7\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-4 atom-4 atom-5\" d=\"M 358.1,237.8 L 372.2,233.6\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-5 atom-5 atom-6\" d=\"M 372.2,233.6 L 375.7,219.3\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-5 atom-5 atom-6\" d=\"M 369.9,230.8 L 372.3,220.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-6 atom-6 atom-7\" d=\"M 375.7,219.3 L 365.0,209.2\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-7 atom-7 atom-8\" d=\"M 365.0,209.2 L 350.9,213.4\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-7 atom-7 atom-8\" d=\"M 363.7,212.6 L 353.8,215.6\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-8 atom-8 atom-9\" d=\"M 350.9,213.4 L 346.3,209.1\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-8 atom-8 atom-9\" d=\"M 346.3,209.1 L 341.8,204.8\" style=\"fill:none;fill-rule:evenodd;stroke:#33CCCC;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-10 atom-10 atom-11\" d=\"M 306.6,224.1 L 302.2,220.0\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-10 atom-10 atom-11\" d=\"M 302.2,220.0 L 297.9,215.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-23 atom-22 atom-10\" d=\"M 305.2,240.3 L 306.6,234.4\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-23 atom-22 atom-10\" d=\"M 306.6,234.4 L 308.0,228.5\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-11 atom-11 atom-12\" d=\"M 297.9,215.9 L 283.8,220.1\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-12 atom-12 atom-13\" d=\"M 283.8,220.1 L 280.4,234.4\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-13 atom-13 atom-14\" d=\"M 280.4,234.4 L 266.3,238.6\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-20 atom-13 atom-21\" d=\"M 280.4,234.4 L 291.1,244.5\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-14 atom-14 atom-15\" d=\"M 266.3,238.6 L 261.9,234.5\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-14 atom-14 atom-15\" d=\"M 261.9,234.5 L 257.6,230.4\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-15 atom-15 atom-16\" d=\"M 256.2,226.0 L 257.6,220.1\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-15 atom-15 atom-16\" d=\"M 257.6,220.1 L 259.0,214.2\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-24 atom-20 atom-15\" d=\"M 241.5,232.7 L 247.5,230.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-24 atom-20 atom-15\" d=\"M 247.5,230.9 L 253.6,229.1\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-16 atom-16 atom-17\" d=\"M 259.0,214.2 L 248.3,204.1\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-17 atom-17 atom-18\" d=\"M 248.3,204.1 L 242.4,205.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-17 atom-17 atom-18\" d=\"M 242.4,205.8 L 236.5,207.6\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-18 atom-18 atom-19\" d=\"M 233.6,210.8 L 232.2,216.7\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-18 atom-18 atom-19\" d=\"M 232.2,216.7 L 230.8,222.6\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-19 atom-19 atom-20\" d=\"M 230.8,222.6 L 241.5,232.7\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-21 atom-21 atom-22\" d=\"M 291.1,244.5 L 305.2,240.3\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"atom-0\" d=\"M 324.1 207.5 Q 324.1 206.5, 324.6 205.9 Q 325.1 205.3, 326.1 205.3 Q 327.0 205.3, 327.5 205.9 Q 328.0 206.5, 328.0 207.5 Q 328.0 208.5, 327.5 209.1 Q 327.0 209.7, 326.1 209.7 Q 325.1 209.7, 324.6 209.1 Q 324.1 208.5, 324.1 207.5 M 326.1 209.2 Q 326.7 209.2, 327.1 208.8 Q 327.4 208.3, 327.4 207.5 Q 327.4 206.7, 327.1 206.2 Q 326.7 205.8, 326.1 205.8 Q 325.4 205.8, 325.1 206.2 Q 324.7 206.7, 324.7 207.5 Q 324.7 208.4, 325.1 208.8 Q 325.4 209.2, 326.1 209.2 \" fill=\"#FF0000\"/>\n<path class=\"atom-2\" d=\"M 332.4 229.8 L 333.8 232.0 Q 333.9 232.3, 334.2 232.7 Q 334.4 233.1, 334.4 233.1 L 334.4 229.8 L 335.0 229.8 L 335.0 234.0 L 334.4 234.0 L 332.9 231.6 Q 332.7 231.3, 332.5 231.0 Q 332.3 230.6, 332.3 230.5 L 332.3 234.0 L 331.7 234.0 L 331.7 229.8 L 332.4 229.8 \" fill=\"#0000FF\"/>\n<path class=\"atom-2\" d=\"M 331.7 234.5 L 332.3 234.5 L 332.3 236.3 L 334.4 236.3 L 334.4 234.5 L 335.0 234.5 L 335.0 238.7 L 334.4 238.7 L 334.4 236.7 L 332.3 236.7 L 332.3 238.7 L 331.7 238.7 L 331.7 234.5 \" fill=\"#0000FF\"/>\n<path class=\"atom-9\" d=\"M 338.9 201.2 L 341.4 201.2 L 341.4 201.6 L 339.5 201.6 L 339.5 202.9 L 341.2 202.9 L 341.2 203.4 L 339.5 203.4 L 339.5 205.4 L 338.9 205.4 L 338.9 201.2 \" fill=\"#33CCCC\"/>\n<path class=\"atom-10\" d=\"M 307.6 223.9 L 309.0 226.1 Q 309.2 226.3, 309.4 226.7 Q 309.6 227.1, 309.6 227.2 L 309.6 223.9 L 310.2 223.9 L 310.2 228.1 L 309.6 228.1 L 308.1 225.7 Q 307.9 225.4, 307.7 225.0 Q 307.6 224.7, 307.5 224.6 L 307.5 228.1 L 307.0 228.1 L 307.0 223.9 L 307.6 223.9 \" fill=\"#0000FF\"/>\n<path class=\"atom-15\" d=\"M 254.6 226.4 L 256.0 228.6 Q 256.2 228.8, 256.4 229.2 Q 256.6 229.6, 256.6 229.7 L 256.6 226.4 L 257.2 226.4 L 257.2 230.6 L 256.6 230.6 L 255.1 228.1 Q 254.9 227.9, 254.8 227.5 Q 254.6 227.2, 254.5 227.1 L 254.5 230.6 L 254.0 230.6 L 254.0 226.4 L 254.6 226.4 \" fill=\"#0000FF\"/>\n<path class=\"atom-18\" d=\"M 232.3 208.3 Q 232.3 207.2, 232.8 206.7 Q 233.3 206.1, 234.2 206.1 Q 235.2 206.1, 235.7 206.7 Q 236.2 207.2, 236.2 208.3 Q 236.2 209.3, 235.7 209.9 Q 235.1 210.5, 234.2 210.5 Q 233.3 210.5, 232.8 209.9 Q 232.3 209.3, 232.3 208.3 M 234.2 210.0 Q 234.9 210.0, 235.2 209.6 Q 235.6 209.1, 235.6 208.3 Q 235.6 207.4, 235.2 207.0 Q 234.9 206.6, 234.2 206.6 Q 233.6 206.6, 233.2 207.0 Q 232.9 207.4, 232.9 208.3 Q 232.9 209.1, 233.2 209.6 Q 233.6 210.0, 234.2 210.0 \" fill=\"#FF0000\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 449.6,249.1 L 455.7,248.2\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 455.7,248.2 L 461.9,247.3\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-1 atom-1 atom-2\" d=\"M 465.2,244.4 L 467.4,238.9\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-1 atom-1 atom-2\" d=\"M 467.4,238.9 L 469.6,233.3\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-2 atom-2 atom-3\" d=\"M 469.6,233.3 L 484.2,231.2\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-3 atom-3 atom-4\" d=\"M 484.2,231.2 L 486.4,225.6\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-3 atom-3 atom-4\" d=\"M 486.4,225.6 L 488.6,220.0\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-4 atom-4 atom-5\" d=\"M 487.7,215.0 L 484.1,210.5\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-4 atom-4 atom-5\" d=\"M 484.1,210.5 L 480.5,206.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-7 atom-4 atom-8\" d=\"M 491.6,217.2 L 497.9,216.3\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-7 atom-4 atom-8\" d=\"M 497.9,216.3 L 504.2,215.4\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-5 atom-5 atom-6\" d=\"M 480.5,206.0 L 466.0,208.1\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-6 atom-6 atom-7\" d=\"M 466.0,208.1 L 462.4,203.6\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-6 atom-6 atom-7\" d=\"M 462.4,203.6 L 458.9,199.1\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-8 atom-8 atom-9\" d=\"M 505.6,215.9 L 507.8,210.4\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-8 atom-8 atom-9\" d=\"M 507.8,210.4 L 510.0,204.9\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-8 atom-8 atom-9\" d=\"M 502.8,214.9 L 505.0,209.3\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-8 atom-8 atom-9\" d=\"M 505.0,209.3 L 507.2,203.8\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-9 atom-8 atom-10\" d=\"M 504.2,215.4 L 507.8,219.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-9 atom-8 atom-10\" d=\"M 507.8,219.9 L 511.3,224.5\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-10 atom-10 atom-11\" d=\"M 515.3,226.7 L 521.6,225.7\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-10 atom-10 atom-11\" d=\"M 521.6,225.7 L 527.9,224.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-11 atom-11 atom-12\" d=\"M 527.9,224.8 L 533.3,211.2\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-11 atom-11 atom-12\" d=\"M 531.4,223.9 L 535.2,214.3\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-17 atom-16 atom-11\" d=\"M 537.0,236.4 L 527.9,224.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-12 atom-12 atom-13\" d=\"M 533.3,211.2 L 547.9,209.1\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-13 atom-13 atom-14\" d=\"M 547.9,209.1 L 557.0,220.6\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-13 atom-13 atom-14\" d=\"M 546.9,212.6 L 553.3,220.7\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-14 atom-14 atom-15\" d=\"M 557.0,220.6 L 551.5,234.3\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-15 atom-15 atom-16\" d=\"M 551.5,234.3 L 537.0,236.4\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-15 atom-15 atom-16\" d=\"M 548.9,231.7 L 538.7,233.2\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-16 atom-16 atom-17\" d=\"M 537.0,236.4 L 534.6,242.4\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-16 atom-16 atom-17\" d=\"M 534.6,242.4 L 532.2,248.4\" style=\"fill:none;fill-rule:evenodd;stroke:#00CC00;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"atom-1\" d=\"M 462.2 247.0 Q 462.2 246.0, 462.7 245.4 Q 463.2 244.8, 464.2 244.8 Q 465.1 244.8, 465.6 245.4 Q 466.1 246.0, 466.1 247.0 Q 466.1 248.0, 465.6 248.6 Q 465.1 249.2, 464.2 249.2 Q 463.2 249.2, 462.7 248.6 Q 462.2 248.0, 462.2 247.0 M 464.2 248.7 Q 464.8 248.7, 465.2 248.3 Q 465.5 247.8, 465.5 247.0 Q 465.5 246.1, 465.2 245.7 Q 464.8 245.3, 464.2 245.3 Q 463.5 245.3, 463.2 245.7 Q 462.8 246.1, 462.8 247.0 Q 462.8 247.8, 463.2 248.3 Q 463.5 248.7, 464.2 248.7 \" fill=\"#FF0000\"/>\n<path class=\"atom-4\" d=\"M 488.7 215.4 L 490.1 217.6 Q 490.2 217.9, 490.4 218.3 Q 490.7 218.7, 490.7 218.7 L 490.7 215.4 L 491.2 215.4 L 491.2 219.6 L 490.7 219.6 L 489.2 217.2 Q 489.0 216.9, 488.8 216.6 Q 488.6 216.2, 488.6 216.1 L 488.6 219.6 L 488.0 219.6 L 488.0 215.4 L 488.7 215.4 \" fill=\"#0000FF\"/>\n<path class=\"atom-7\" d=\"M 451.3 194.4 L 451.8 194.4 L 451.8 196.2 L 454.0 196.2 L 454.0 194.4 L 454.6 194.4 L 454.6 198.7 L 454.0 198.7 L 454.0 196.7 L 451.8 196.7 L 451.8 198.7 L 451.3 198.7 L 451.3 194.4 \" fill=\"#FF0000\"/>\n<path class=\"atom-7\" d=\"M 454.9 196.5 Q 454.9 195.5, 455.4 195.0 Q 455.9 194.4, 456.8 194.4 Q 457.8 194.4, 458.3 195.0 Q 458.8 195.5, 458.8 196.5 Q 458.8 197.6, 458.3 198.2 Q 457.8 198.7, 456.8 198.7 Q 455.9 198.7, 455.4 198.2 Q 454.9 197.6, 454.9 196.5 M 456.8 198.3 Q 457.5 198.3, 457.8 197.8 Q 458.2 197.4, 458.2 196.5 Q 458.2 195.7, 457.8 195.3 Q 457.5 194.9, 456.8 194.9 Q 456.2 194.9, 455.8 195.3 Q 455.5 195.7, 455.5 196.5 Q 455.5 197.4, 455.8 197.8 Q 456.2 198.3, 456.8 198.3 \" fill=\"#FF0000\"/>\n<path class=\"atom-9\" d=\"M 507.7 201.7 Q 507.7 200.7, 508.2 200.2 Q 508.7 199.6, 509.6 199.6 Q 510.6 199.6, 511.1 200.2 Q 511.6 200.7, 511.6 201.7 Q 511.6 202.8, 511.1 203.4 Q 510.6 203.9, 509.6 203.9 Q 508.7 203.9, 508.2 203.4 Q 507.7 202.8, 507.7 201.7 M 509.6 203.5 Q 510.3 203.5, 510.6 203.0 Q 511.0 202.6, 511.0 201.7 Q 511.0 200.9, 510.6 200.5 Q 510.3 200.1, 509.6 200.1 Q 509.0 200.1, 508.6 200.5 Q 508.3 200.9, 508.3 201.7 Q 508.3 202.6, 508.6 203.0 Q 509.0 203.5, 509.6 203.5 \" fill=\"#FF0000\"/>\n<path class=\"atom-10\" d=\"M 507.9 224.8 L 508.4 224.8 L 508.4 226.6 L 510.6 226.6 L 510.6 224.8 L 511.2 224.8 L 511.2 229.1 L 510.6 229.1 L 510.6 227.1 L 508.4 227.1 L 508.4 229.1 L 507.9 229.1 L 507.9 224.8 \" fill=\"#0000FF\"/>\n<path class=\"atom-10\" d=\"M 512.4 224.8 L 513.7 227.1 Q 513.9 227.3, 514.1 227.7 Q 514.3 228.1, 514.3 228.1 L 514.3 224.8 L 514.9 224.8 L 514.9 229.1 L 514.3 229.1 L 512.8 226.6 Q 512.7 226.3, 512.5 226.0 Q 512.3 225.7, 512.2 225.6 L 512.2 229.1 L 511.7 229.1 L 511.7 224.8 L 512.4 224.8 \" fill=\"#0000FF\"/>\n<path class=\"atom-17\" d=\"M 527.5 250.2 Q 527.5 249.1, 527.9 248.6 Q 528.4 248.0, 529.4 248.0 Q 530.3 248.0, 530.7 248.6 L 530.3 249.0 Q 530.0 248.5, 529.4 248.5 Q 528.7 248.5, 528.4 249.0 Q 528.1 249.4, 528.1 250.2 Q 528.1 251.0, 528.4 251.5 Q 528.8 251.9, 529.4 251.9 Q 529.9 251.9, 530.5 251.6 L 530.6 252.1 Q 530.4 252.2, 530.1 252.3 Q 529.7 252.4, 529.4 252.4 Q 528.4 252.4, 527.9 251.8 Q 527.5 251.3, 527.5 250.2 \" fill=\"#00CC00\"/>\n<path class=\"atom-17\" d=\"M 531.2 247.8 L 531.8 247.8 L 531.8 252.3 L 531.2 252.3 L 531.2 247.8 \" fill=\"#00CC00\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 788.1,242.2 L 783.4,238.4\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 783.4,238.4 L 778.6,234.6\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 790.0,239.9 L 785.9,236.7\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 785.9,236.7 L 781.9,233.5\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 786.3,244.5 L 782.2,241.3\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 782.2,241.3 L 778.2,238.1\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-1 atom-1 atom-2\" d=\"M 778.6,234.6 L 767.1,225.4\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-2 atom-2 atom-3\" d=\"M 767.1,225.4 L 753.4,230.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-2 atom-2 atom-3\" d=\"M 764.0,223.5 L 754.4,227.3\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-23 atom-23 atom-2\" d=\"M 769.3,210.9 L 767.1,225.4\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-3 atom-3 atom-4\" d=\"M 753.4,230.8 L 741.9,221.6\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-4 atom-4 atom-5\" d=\"M 741.9,221.6 L 736.1,223.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-4 atom-4 atom-5\" d=\"M 736.1,223.9 L 730.2,226.2\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-20 atom-4 atom-21\" d=\"M 741.9,221.6 L 744.1,207.1\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-20 atom-4 atom-21\" d=\"M 745.2,219.9 L 746.7,209.7\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-5 atom-5 atom-6\" d=\"M 726.3,225.4 L 721.5,221.6\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-5 atom-5 atom-6\" d=\"M 721.5,221.6 L 716.7,217.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-6 atom-6 atom-7\" d=\"M 718.2,218.0 L 719.1,212.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-6 atom-6 atom-7\" d=\"M 719.1,212.0 L 720.0,206.0\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-6 atom-6 atom-7\" d=\"M 715.3,217.5 L 716.2,211.6\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-6 atom-6 atom-7\" d=\"M 716.2,211.6 L 717.1,205.6\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-7 atom-6 atom-8\" d=\"M 716.7,217.8 L 710.9,220.1\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-7 atom-6 atom-8\" d=\"M 710.9,220.1 L 705.0,222.3\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-8 atom-8 atom-9\" d=\"M 701.1,221.5 L 696.3,217.7\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-8 atom-8 atom-9\" d=\"M 696.3,217.7 L 691.6,213.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-24 atom-20 atom-8\" d=\"M 700.8,237.7 L 701.7,231.6\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-24 atom-20 atom-8\" d=\"M 701.7,231.6 L 702.7,225.6\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-9 atom-9 atom-10\" d=\"M 691.6,213.9 L 677.9,219.3\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-10 atom-10 atom-11\" d=\"M 677.9,219.3 L 675.6,233.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-11 atom-11 atom-12\" d=\"M 675.6,233.8 L 661.9,239.2\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-18 atom-11 atom-19\" d=\"M 675.6,233.8 L 687.1,243.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-12 atom-12 atom-13\" d=\"M 661.9,239.2 L 657.2,235.4\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-12 atom-12 atom-13\" d=\"M 657.2,235.4 L 652.4,231.6\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-13 atom-13 atom-14\" d=\"M 650.8,227.5 L 651.7,221.5\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-13 atom-13 atom-14\" d=\"M 651.7,221.5 L 652.7,215.4\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-25 atom-18 atom-13\" d=\"M 636.7,235.3 L 642.6,233.1\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-25 atom-18 atom-13\" d=\"M 642.6,233.1 L 648.5,230.8\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-14 atom-14 atom-15\" d=\"M 652.7,215.4 L 641.2,206.3\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-15 atom-15 atom-16\" d=\"M 641.2,206.3 L 635.5,208.5\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-15 atom-15 atom-16\" d=\"M 635.5,208.5 L 629.8,210.7\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-16 atom-16 atom-17\" d=\"M 627.1,214.2 L 626.2,220.2\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-16 atom-16 atom-17\" d=\"M 626.2,220.2 L 625.3,226.2\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-17 atom-17 atom-18\" d=\"M 625.3,226.2 L 636.7,235.3\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-19 atom-19 atom-20\" d=\"M 687.1,243.0 L 700.8,237.7\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-21 atom-21 atom-22\" d=\"M 744.1,207.1 L 757.9,201.7\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-22 atom-22 atom-23\" d=\"M 757.9,201.7 L 769.3,210.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-22 atom-22 atom-23\" d=\"M 757.7,205.4 L 765.8,211.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"atom-0\" d=\"M 789.2 241.7 L 790.6 243.9 Q 790.7 244.2, 790.9 244.6 Q 791.1 245.0, 791.1 245.0 L 791.1 241.7 L 791.7 241.7 L 791.7 245.9 L 791.1 245.9 L 789.6 243.5 Q 789.5 243.2, 789.3 242.9 Q 789.1 242.5, 789.0 242.4 L 789.0 245.9 L 788.5 245.9 L 788.5 241.7 L 789.2 241.7 \" fill=\"#0000FF\"/>\n<path class=\"atom-5\" d=\"M 727.3 224.8 L 728.7 227.1 Q 728.8 227.3, 729.0 227.7 Q 729.3 228.1, 729.3 228.1 L 729.3 224.8 L 729.8 224.8 L 729.8 229.1 L 729.3 229.1 L 727.8 226.6 Q 727.6 226.3, 727.4 226.0 Q 727.2 225.7, 727.2 225.6 L 727.2 229.1 L 726.6 229.1 L 726.6 224.8 L 727.3 224.8 \" fill=\"#0000FF\"/>\n<path class=\"atom-5\" d=\"M 726.6 229.5 L 727.1 229.5 L 727.1 231.3 L 729.3 231.3 L 729.3 229.5 L 729.9 229.5 L 729.9 233.8 L 729.3 233.8 L 729.3 231.8 L 727.1 231.8 L 727.1 233.8 L 726.6 233.8 L 726.6 229.5 \" fill=\"#0000FF\"/>\n<path class=\"atom-7\" d=\"M 717.0 203.2 Q 717.0 202.2, 717.5 201.6 Q 718.0 201.1, 719.0 201.1 Q 719.9 201.1, 720.4 201.6 Q 720.9 202.2, 720.9 203.2 Q 720.9 204.3, 720.4 204.9 Q 719.9 205.4, 719.0 205.4 Q 718.0 205.4, 717.5 204.9 Q 717.0 204.3, 717.0 203.2 M 719.0 205.0 Q 719.6 205.0, 720.0 204.5 Q 720.3 204.1, 720.3 203.2 Q 720.3 202.4, 720.0 202.0 Q 719.6 201.6, 719.0 201.6 Q 718.3 201.6, 718.0 202.0 Q 717.6 202.4, 717.6 203.2 Q 717.6 204.1, 718.0 204.5 Q 718.3 205.0, 719.0 205.0 \" fill=\"#FF0000\"/>\n<path class=\"atom-8\" d=\"M 702.1 221.0 L 703.5 223.2 Q 703.6 223.5, 703.9 223.9 Q 704.1 224.3, 704.1 224.3 L 704.1 221.0 L 704.7 221.0 L 704.7 225.2 L 704.1 225.2 L 702.6 222.8 Q 702.4 222.5, 702.2 222.2 Q 702.0 221.8, 702.0 221.7 L 702.0 225.2 L 701.4 225.2 L 701.4 221.0 L 702.1 221.0 \" fill=\"#0000FF\"/>\n<path class=\"atom-13\" d=\"M 649.5 227.9 L 650.9 230.1 Q 651.0 230.3, 651.3 230.7 Q 651.5 231.1, 651.5 231.2 L 651.5 227.9 L 652.1 227.9 L 652.1 232.1 L 651.5 232.1 L 650.0 229.7 Q 649.8 229.4, 649.6 229.0 Q 649.4 228.7, 649.4 228.6 L 649.4 232.1 L 648.8 232.1 L 648.8 227.9 L 649.5 227.9 \" fill=\"#0000FF\"/>\n<path class=\"atom-16\" d=\"M 625.5 211.6 Q 625.5 210.6, 626.0 210.0 Q 626.5 209.5, 627.5 209.5 Q 628.4 209.5, 628.9 210.0 Q 629.4 210.6, 629.4 211.6 Q 629.4 212.7, 628.9 213.2 Q 628.4 213.8, 627.5 213.8 Q 626.5 213.8, 626.0 213.2 Q 625.5 212.7, 625.5 211.6 M 627.5 213.3 Q 628.1 213.3, 628.5 212.9 Q 628.8 212.5, 628.8 211.6 Q 628.8 210.8, 628.5 210.4 Q 628.1 209.9, 627.5 209.9 Q 626.8 209.9, 626.5 210.4 Q 626.1 210.8, 626.1 211.6 Q 626.1 212.5, 626.5 212.9 Q 626.8 213.3, 627.5 213.3 \" fill=\"#FF0000\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 26.1,372.9 L 32.4,371.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 32.4,371.8 L 38.6,370.7\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-1 atom-1 atom-2\" d=\"M 41.5,367.9 L 43.6,362.2\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-1 atom-1 atom-2\" d=\"M 43.6,362.2 L 45.6,356.5\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-2 atom-1 atom-3\" d=\"M 42.6,372.7 L 46.3,377.2\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-2 atom-1 atom-3\" d=\"M 46.3,377.2 L 50.1,381.6\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-3 atom-3 atom-4\" d=\"M 50.1,381.6 L 64.6,379.1\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-4 atom-4 atom-5\" d=\"M 64.6,379.1 L 69.6,365.2\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-20 atom-20 atom-4\" d=\"M 74.0,390.3 L 64.6,379.1\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-5 atom-5 atom-6\" d=\"M 69.6,365.2 L 84.1,362.7\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-6 atom-6 atom-7\" d=\"M 84.1,362.7 L 87.8,367.1\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-6 atom-6 atom-7\" d=\"M 87.8,367.1 L 91.6,371.6\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-7 atom-7 atom-8\" d=\"M 95.5,373.6 L 101.8,372.5\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-7 atom-7 atom-8\" d=\"M 101.8,372.5 L 108.0,371.4\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-18 atom-7 atom-19\" d=\"M 92.6,376.4 L 90.6,382.1\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-18 atom-7 atom-19\" d=\"M 90.6,382.1 L 88.5,387.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-8 atom-8 atom-9\" d=\"M 109.4,371.9 L 111.4,366.2\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-8 atom-8 atom-9\" d=\"M 111.4,366.2 L 113.5,360.6\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-8 atom-8 atom-9\" d=\"M 106.6,370.8 L 108.7,365.2\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-8 atom-8 atom-9\" d=\"M 108.7,365.2 L 110.7,359.6\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-9 atom-8 atom-10\" d=\"M 108.0,371.4 L 111.8,375.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-9 atom-8 atom-10\" d=\"M 111.8,375.8 L 115.5,380.3\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-10 atom-10 atom-11\" d=\"M 119.5,382.3 L 125.7,381.2\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-10 atom-10 atom-11\" d=\"M 125.7,381.2 L 132.0,380.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-11 atom-11 atom-12\" d=\"M 132.0,380.0 L 141.4,391.3\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-11 atom-11 atom-12\" d=\"M 135.6,379.8 L 142.3,387.7\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-21 atom-18 atom-11\" d=\"M 137.0,366.2 L 132.0,380.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-12 atom-12 atom-13\" d=\"M 141.4,391.3 L 155.9,388.7\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-13 atom-13 atom-14\" d=\"M 155.9,388.7 L 160.9,374.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-13 atom-13 atom-14\" d=\"M 153.9,385.7 L 157.4,376.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-14 atom-14 atom-15\" d=\"M 160.9,374.9 L 167.2,373.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-14 atom-14 atom-15\" d=\"M 167.2,373.8 L 173.4,372.7\" style=\"fill:none;fill-rule:evenodd;stroke:#00CC00;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-15 atom-14 atom-16\" d=\"M 160.9,374.9 L 151.5,363.6\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-16 atom-16 atom-17\" d=\"M 151.5,363.6 L 153.5,358.1\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-16 atom-16 atom-17\" d=\"M 153.5,358.1 L 155.5,352.5\" style=\"fill:none;fill-rule:evenodd;stroke:#00CC00;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-17 atom-16 atom-18\" d=\"M 151.5,363.6 L 137.0,366.2\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-17 atom-16 atom-18\" d=\"M 149.8,366.9 L 139.7,368.7\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-19 atom-19 atom-20\" d=\"M 88.5,387.8 L 74.0,390.3\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"atom-1\" d=\"M 39.7 368.2 L 41.1 370.5 Q 41.2 370.7, 41.4 371.1 Q 41.6 371.5, 41.7 371.5 L 41.7 368.2 L 42.2 368.2 L 42.2 372.5 L 41.6 372.5 L 40.1 370.0 Q 40.0 369.7, 39.8 369.4 Q 39.6 369.1, 39.5 369.0 L 39.5 372.5 L 39.0 372.5 L 39.0 368.2 L 39.7 368.2 \" fill=\"#0000FF\"/>\n<path class=\"atom-7\" d=\"M 92.6 371.8 L 94.0 374.0 Q 94.1 374.3, 94.3 374.7 Q 94.6 375.1, 94.6 375.1 L 94.6 371.8 L 95.1 371.8 L 95.1 376.0 L 94.6 376.0 L 93.1 373.6 Q 92.9 373.3, 92.7 373.0 Q 92.5 372.6, 92.5 372.5 L 92.5 376.0 L 91.9 376.0 L 91.9 371.8 L 92.6 371.8 \" fill=\"#0000FF\"/>\n<path class=\"atom-9\" d=\"M 111.1 357.5 Q 111.1 356.5, 111.6 355.9 Q 112.1 355.4, 113.0 355.4 Q 114.0 355.4, 114.5 355.9 Q 115.0 356.5, 115.0 357.5 Q 115.0 358.6, 114.5 359.2 Q 114.0 359.7, 113.0 359.7 Q 112.1 359.7, 111.6 359.2 Q 111.1 358.6, 111.1 357.5 M 113.0 359.3 Q 113.7 359.3, 114.0 358.8 Q 114.4 358.4, 114.4 357.5 Q 114.4 356.7, 114.0 356.3 Q 113.7 355.9, 113.0 355.9 Q 112.4 355.9, 112.0 356.3 Q 111.7 356.7, 111.7 357.5 Q 111.7 358.4, 112.0 358.8 Q 112.4 359.3, 113.0 359.3 \" fill=\"#FF0000\"/>\n<path class=\"atom-10\" d=\"M 116.5 380.5 L 117.9 382.7 Q 118.1 383.0, 118.3 383.4 Q 118.5 383.8, 118.5 383.8 L 118.5 380.5 L 119.1 380.5 L 119.1 384.7 L 118.5 384.7 L 117.0 382.3 Q 116.8 382.0, 116.7 381.7 Q 116.5 381.3, 116.4 381.2 L 116.4 384.7 L 115.9 384.7 L 115.9 380.5 L 116.5 380.5 \" fill=\"#0000FF\"/>\n<path class=\"atom-10\" d=\"M 115.8 385.2 L 116.4 385.2 L 116.4 387.0 L 118.6 387.0 L 118.6 385.2 L 119.1 385.2 L 119.1 389.4 L 118.6 389.4 L 118.6 387.4 L 116.4 387.4 L 116.4 389.4 L 115.8 389.4 L 115.8 385.2 \" fill=\"#0000FF\"/>\n<path class=\"atom-15\" d=\"M 173.8 372.5 Q 173.8 371.4, 174.3 370.9 Q 174.8 370.3, 175.7 370.3 Q 176.6 370.3, 177.1 370.9 L 176.7 371.3 Q 176.3 370.8, 175.7 370.8 Q 175.1 370.8, 174.7 371.2 Q 174.4 371.7, 174.4 372.5 Q 174.4 373.3, 174.7 373.7 Q 175.1 374.2, 175.8 374.2 Q 176.3 374.2, 176.8 373.9 L 177.0 374.3 Q 176.7 374.5, 176.4 374.6 Q 176.1 374.7, 175.7 374.7 Q 174.8 374.7, 174.3 374.1 Q 173.8 373.5, 173.8 372.5 \" fill=\"#00CC00\"/>\n<path class=\"atom-15\" d=\"M 177.6 370.1 L 178.1 370.1 L 178.1 374.6 L 177.6 374.6 L 177.6 370.1 \" fill=\"#00CC00\"/>\n<path class=\"atom-17\" d=\"M 154.9 350.0 Q 154.9 348.9, 155.3 348.4 Q 155.8 347.8, 156.8 347.8 Q 157.7 347.8, 158.1 348.4 L 157.7 348.7 Q 157.4 348.3, 156.8 348.3 Q 156.1 348.3, 155.8 348.7 Q 155.5 349.1, 155.5 350.0 Q 155.5 350.8, 155.8 351.2 Q 156.2 351.7, 156.8 351.7 Q 157.3 351.7, 157.9 351.4 L 158.0 351.8 Q 157.8 352.0, 157.5 352.1 Q 157.1 352.1, 156.8 352.1 Q 155.8 352.1, 155.3 351.6 Q 154.9 351.0, 154.9 350.0 \" fill=\"#00CC00\"/>\n<path class=\"atom-17\" d=\"M 158.6 347.5 L 159.2 347.5 L 159.2 352.1 L 158.6 352.1 L 158.6 347.5 \" fill=\"#00CC00\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 228.2,399.1 L 234.3,397.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 234.3,397.8 L 240.3,396.4\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-1 atom-1 atom-2\" d=\"M 243.4,393.4 L 245.2,387.6\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-1 atom-1 atom-2\" d=\"M 245.2,387.6 L 247.0,381.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-2 atom-2 atom-3\" d=\"M 247.0,381.8 L 237.0,371.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-2 atom-2 atom-3\" d=\"M 247.6,378.2 L 240.6,370.7\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-23 atom-23 atom-2\" d=\"M 261.3,378.6 L 247.0,381.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-3 atom-3 atom-4\" d=\"M 237.0,371.0 L 241.3,357.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-4 atom-4 atom-5\" d=\"M 241.3,357.0 L 255.7,353.7\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-4 atom-4 atom-5\" d=\"M 244.1,359.4 L 254.2,357.1\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-5 atom-5 atom-6\" d=\"M 255.7,353.7 L 265.7,364.6\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-6 atom-6 atom-7\" d=\"M 265.7,364.6 L 271.9,363.2\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-6 atom-6 atom-7\" d=\"M 271.9,363.2 L 278.0,361.8\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-22 atom-6 atom-23\" d=\"M 265.7,364.6 L 261.3,378.6\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-22 atom-6 atom-23\" d=\"M 262.2,365.8 L 259.1,375.6\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-7 atom-7 atom-8\" d=\"M 282.0,363.4 L 286.0,367.8\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-7 atom-7 atom-8\" d=\"M 286.0,367.8 L 290.0,372.1\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-8 atom-8 atom-9\" d=\"M 288.6,371.7 L 286.8,377.4\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-8 atom-8 atom-9\" d=\"M 286.8,377.4 L 285.0,383.2\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-8 atom-8 atom-9\" d=\"M 291.4,372.5 L 289.6,378.3\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-8 atom-8 atom-9\" d=\"M 289.6,378.3 L 287.8,384.1\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-9 atom-8 atom-10\" d=\"M 290.0,372.1 L 296.2,370.7\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-9 atom-8 atom-10\" d=\"M 296.2,370.7 L 302.4,369.3\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-10 atom-10 atom-11\" d=\"M 306.3,371.0 L 310.3,375.3\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-10 atom-10 atom-11\" d=\"M 310.3,375.3 L 314.3,379.7\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-24 atom-22 atom-10\" d=\"M 308.7,354.8 L 306.9,360.6\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-24 atom-22 atom-10\" d=\"M 306.9,360.6 L 305.1,366.4\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-11 atom-11 atom-12\" d=\"M 314.3,379.7 L 328.7,376.4\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-12 atom-12 atom-13\" d=\"M 328.7,376.4 L 333.0,362.4\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-13 atom-13 atom-14\" d=\"M 333.0,362.4 L 347.4,359.1\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-20 atom-13 atom-21\" d=\"M 333.0,362.4 L 323.1,351.6\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-14 atom-14 atom-15\" d=\"M 347.4,359.1 L 351.4,363.5\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-14 atom-14 atom-15\" d=\"M 351.4,363.5 L 355.4,367.8\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-15 atom-15 atom-16\" d=\"M 356.6,372.4 L 354.8,378.2\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-15 atom-15 atom-16\" d=\"M 354.8,378.2 L 353.0,384.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-25 atom-20 atom-15\" d=\"M 371.7,366.7 L 365.5,368.1\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-25 atom-20 atom-15\" d=\"M 365.5,368.1 L 359.4,369.5\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-16 atom-16 atom-17\" d=\"M 353.0,384.0 L 363.0,394.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-17 atom-17 atom-18\" d=\"M 363.0,394.8 L 369.0,393.4\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-17 atom-17 atom-18\" d=\"M 369.0,393.4 L 375.0,392.1\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-18 atom-18 atom-19\" d=\"M 378.1,389.0 L 379.9,383.3\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-18 atom-18 atom-19\" d=\"M 379.9,383.3 L 381.7,377.5\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-19 atom-19 atom-20\" d=\"M 381.7,377.5 L 371.7,366.7\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-21 atom-21 atom-22\" d=\"M 323.1,351.6 L 308.7,354.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"atom-1\" d=\"M 240.6 395.9 Q 240.6 394.9, 241.1 394.3 Q 241.6 393.7, 242.6 393.7 Q 243.5 393.7, 244.0 394.3 Q 244.5 394.9, 244.5 395.9 Q 244.5 396.9, 244.0 397.5 Q 243.5 398.1, 242.6 398.1 Q 241.7 398.1, 241.1 397.5 Q 240.6 396.9, 240.6 395.9 M 242.6 397.6 Q 243.2 397.6, 243.6 397.2 Q 243.9 396.8, 243.9 395.9 Q 243.9 395.1, 243.6 394.7 Q 243.2 394.2, 242.6 394.2 Q 241.9 394.2, 241.6 394.6 Q 241.2 395.1, 241.2 395.9 Q 241.2 396.8, 241.6 397.2 Q 241.9 397.6, 242.6 397.6 \" fill=\"#FF0000\"/>\n<path class=\"atom-7\" d=\"M 279.1 359.2 L 280.5 361.4 Q 280.6 361.7, 280.8 362.1 Q 281.1 362.5, 281.1 362.5 L 281.1 359.2 L 281.6 359.2 L 281.6 363.4 L 281.0 363.4 L 279.6 361.0 Q 279.4 360.7, 279.2 360.4 Q 279.0 360.0, 279.0 359.9 L 279.0 363.4 L 278.4 363.4 L 278.4 359.2 L 279.1 359.2 \" fill=\"#0000FF\"/>\n<path class=\"atom-7\" d=\"M 278.4 354.5 L 278.9 354.5 L 278.9 356.3 L 281.1 356.3 L 281.1 354.5 L 281.7 354.5 L 281.7 358.8 L 281.1 358.8 L 281.1 356.8 L 278.9 356.8 L 278.9 358.8 L 278.4 358.8 L 278.4 354.5 \" fill=\"#0000FF\"/>\n<path class=\"atom-9\" d=\"M 283.7 386.2 Q 283.7 385.2, 284.2 384.6 Q 284.7 384.0, 285.6 384.0 Q 286.6 384.0, 287.1 384.6 Q 287.6 385.2, 287.6 386.2 Q 287.6 387.2, 287.1 387.8 Q 286.6 388.4, 285.6 388.4 Q 284.7 388.4, 284.2 387.8 Q 283.7 387.2, 283.7 386.2 M 285.6 387.9 Q 286.3 387.9, 286.6 387.5 Q 287.0 387.0, 287.0 386.2 Q 287.0 385.3, 286.6 384.9 Q 286.3 384.5, 285.6 384.5 Q 285.0 384.5, 284.6 384.9 Q 284.3 385.3, 284.3 386.2 Q 284.3 387.0, 284.6 387.5 Q 285.0 387.9, 285.6 387.9 \" fill=\"#FF0000\"/>\n<path class=\"atom-10\" d=\"M 303.4 366.7 L 304.8 369.0 Q 304.9 369.2, 305.2 369.6 Q 305.4 370.0, 305.4 370.0 L 305.4 366.7 L 306.0 366.7 L 306.0 371.0 L 305.4 371.0 L 303.9 368.5 Q 303.7 368.2, 303.5 367.9 Q 303.3 367.6, 303.3 367.5 L 303.3 371.0 L 302.7 371.0 L 302.7 366.7 L 303.4 366.7 \" fill=\"#0000FF\"/>\n<path class=\"atom-15\" d=\"M 356.4 367.8 L 357.8 370.1 Q 358.0 370.3, 358.2 370.7 Q 358.4 371.1, 358.4 371.1 L 358.4 367.8 L 359.0 367.8 L 359.0 372.1 L 358.4 372.1 L 356.9 369.6 Q 356.7 369.3, 356.6 369.0 Q 356.4 368.7, 356.3 368.6 L 356.3 372.1 L 355.8 372.1 L 355.8 367.8 L 356.4 367.8 \" fill=\"#0000FF\"/>\n<path class=\"atom-18\" d=\"M 375.4 391.6 Q 375.4 390.5, 375.9 390.0 Q 376.4 389.4, 377.4 389.4 Q 378.3 389.4, 378.8 390.0 Q 379.3 390.5, 379.3 391.6 Q 379.3 392.6, 378.8 393.2 Q 378.3 393.8, 377.4 393.8 Q 376.4 393.8, 375.9 393.2 Q 375.4 392.6, 375.4 391.6 M 377.4 393.3 Q 378.0 393.3, 378.3 392.8 Q 378.7 392.4, 378.7 391.6 Q 378.7 390.7, 378.3 390.3 Q 378.0 389.9, 377.4 389.9 Q 376.7 389.9, 376.3 390.3 Q 376.0 390.7, 376.0 391.6 Q 376.0 392.4, 376.3 392.8 Q 376.7 393.3, 377.4 393.3 \" fill=\"#FF0000\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 423.0,378.2 L 437.2,374.4\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-1 atom-1 atom-2\" d=\"M 437.2,374.4 L 441.1,360.2\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-1 atom-1 atom-2\" d=\"M 440.6,373.1 L 443.3,363.1\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-23 atom-22 atom-1\" d=\"M 447.6,384.9 L 437.2,374.4\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-2 atom-2 atom-3\" d=\"M 441.1,360.2 L 455.3,356.5\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-3 atom-3 atom-4\" d=\"M 455.3,356.5 L 465.7,366.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-3 atom-3 atom-4\" d=\"M 454.8,360.1 L 462.0,367.4\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-4 atom-4 atom-5\" d=\"M 465.7,366.9 L 471.8,365.3\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-4 atom-4 atom-5\" d=\"M 471.8,365.3 L 477.9,363.7\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-20 atom-4 atom-21\" d=\"M 465.7,366.9 L 461.8,381.1\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-5 atom-5 atom-6\" d=\"M 481.9,365.2 L 486.1,369.4\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-5 atom-5 atom-6\" d=\"M 486.1,369.4 L 490.2,373.6\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-6 atom-6 atom-7\" d=\"M 488.8,373.2 L 487.2,379.1\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-6 atom-6 atom-7\" d=\"M 487.2,379.1 L 485.6,384.9\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-6 atom-6 atom-7\" d=\"M 491.7,374.0 L 490.1,379.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-6 atom-6 atom-7\" d=\"M 490.1,379.9 L 488.5,385.7\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-7 atom-6 atom-8\" d=\"M 490.2,373.6 L 496.4,372.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-7 atom-6 atom-8\" d=\"M 496.4,372.0 L 502.5,370.4\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-8 atom-8 atom-9\" d=\"M 506.4,371.9 L 510.6,376.1\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-8 atom-8 atom-9\" d=\"M 510.6,376.1 L 514.8,380.3\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-24 atom-20 atom-8\" d=\"M 508.3,355.7 L 506.7,361.5\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-24 atom-20 atom-8\" d=\"M 506.7,361.5 L 505.1,367.4\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-9 atom-9 atom-10\" d=\"M 514.8,380.3 L 529.0,376.6\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-10 atom-10 atom-11\" d=\"M 529.0,376.6 L 532.9,362.4\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-11 atom-11 atom-12\" d=\"M 532.9,362.4 L 547.1,358.7\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-18 atom-11 atom-19\" d=\"M 532.9,362.4 L 522.6,352.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-12 atom-12 atom-13\" d=\"M 547.1,358.7 L 551.3,362.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-12 atom-12 atom-13\" d=\"M 551.3,362.9 L 555.5,367.1\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-13 atom-13 atom-14\" d=\"M 556.8,371.6 L 555.2,377.4\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-13 atom-13 atom-14\" d=\"M 555.2,377.4 L 553.6,383.3\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-25 atom-18 atom-13\" d=\"M 571.7,365.4 L 565.6,367.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-25 atom-18 atom-13\" d=\"M 565.6,367.0 L 559.5,368.6\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-14 atom-14 atom-15\" d=\"M 553.6,383.3 L 564.0,393.7\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-15 atom-15 atom-16\" d=\"M 564.0,393.7 L 569.9,392.2\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-15 atom-15 atom-16\" d=\"M 569.9,392.2 L 575.9,390.6\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-16 atom-16 atom-17\" d=\"M 578.9,387.5 L 580.5,381.7\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-16 atom-16 atom-17\" d=\"M 580.5,381.7 L 582.1,375.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-17 atom-17 atom-18\" d=\"M 582.1,375.8 L 571.7,365.4\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-19 atom-19 atom-20\" d=\"M 522.6,352.0 L 508.3,355.7\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-21 atom-21 atom-22\" d=\"M 461.8,381.1 L 447.6,384.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-21 atom-21 atom-22\" d=\"M 458.9,378.8 L 448.9,381.5\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-22 atom-22 atom-23\" d=\"M 447.6,384.9 L 446.0,390.7\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-22 atom-22 atom-23\" d=\"M 446.0,390.7 L 444.4,396.6\" style=\"fill:none;fill-rule:evenodd;stroke:#33CCCC;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"atom-5\" d=\"M 478.9 361.1 L 480.3 363.3 Q 480.5 363.5, 480.7 363.9 Q 480.9 364.3, 480.9 364.4 L 480.9 361.1 L 481.5 361.1 L 481.5 365.3 L 480.9 365.3 L 479.4 362.8 Q 479.2 362.6, 479.1 362.2 Q 478.9 361.9, 478.8 361.8 L 478.8 365.3 L 478.3 365.3 L 478.3 361.1 L 478.9 361.1 \" fill=\"#0000FF\"/>\n<path class=\"atom-5\" d=\"M 478.2 356.4 L 478.8 356.4 L 478.8 358.2 L 481.0 358.2 L 481.0 356.4 L 481.5 356.4 L 481.5 360.6 L 481.0 360.6 L 481.0 358.7 L 478.8 358.7 L 478.8 360.6 L 478.2 360.6 L 478.2 356.4 \" fill=\"#0000FF\"/>\n<path class=\"atom-7\" d=\"M 484.4 387.8 Q 484.4 386.8, 484.9 386.2 Q 485.4 385.7, 486.4 385.7 Q 487.3 385.7, 487.8 386.2 Q 488.3 386.8, 488.3 387.8 Q 488.3 388.9, 487.8 389.5 Q 487.3 390.0, 486.4 390.0 Q 485.4 390.0, 484.9 389.5 Q 484.4 388.9, 484.4 387.8 M 486.4 389.6 Q 487.0 389.6, 487.4 389.1 Q 487.7 388.7, 487.7 387.8 Q 487.7 387.0, 487.4 386.6 Q 487.0 386.2, 486.4 386.2 Q 485.7 386.2, 485.4 386.6 Q 485.0 387.0, 485.0 387.8 Q 485.0 388.7, 485.4 389.1 Q 485.7 389.6, 486.4 389.6 \" fill=\"#FF0000\"/>\n<path class=\"atom-8\" d=\"M 503.5 367.8 L 504.9 370.0 Q 505.1 370.2, 505.3 370.6 Q 505.5 371.0, 505.5 371.1 L 505.5 367.8 L 506.1 367.8 L 506.1 372.0 L 505.5 372.0 L 504.0 369.6 Q 503.8 369.3, 503.6 368.9 Q 503.5 368.6, 503.4 368.5 L 503.4 372.0 L 502.9 372.0 L 502.9 367.8 L 503.5 367.8 \" fill=\"#0000FF\"/>\n<path class=\"atom-13\" d=\"M 556.6 367.0 L 558.0 369.2 Q 558.1 369.5, 558.3 369.9 Q 558.5 370.3, 558.5 370.3 L 558.5 367.0 L 559.1 367.0 L 559.1 371.2 L 558.5 371.2 L 557.0 368.8 Q 556.9 368.5, 556.7 368.2 Q 556.5 367.8, 556.4 367.7 L 556.4 371.2 L 555.9 371.2 L 555.9 367.0 L 556.6 367.0 \" fill=\"#0000FF\"/>\n<path class=\"atom-16\" d=\"M 576.3 390.0 Q 576.3 389.0, 576.8 388.4 Q 577.3 387.9, 578.2 387.9 Q 579.2 387.9, 579.7 388.4 Q 580.2 389.0, 580.2 390.0 Q 580.2 391.0, 579.7 391.6 Q 579.1 392.2, 578.2 392.2 Q 577.3 392.2, 576.8 391.6 Q 576.3 391.1, 576.3 390.0 M 578.2 391.7 Q 578.9 391.7, 579.2 391.3 Q 579.6 390.9, 579.6 390.0 Q 579.6 389.2, 579.2 388.8 Q 578.9 388.3, 578.2 388.3 Q 577.6 388.3, 577.2 388.8 Q 576.9 389.2, 576.9 390.0 Q 576.9 390.9, 577.2 391.3 Q 577.6 391.7, 578.2 391.7 \" fill=\"#FF0000\"/>\n<path class=\"atom-23\" d=\"M 442.4 396.9 L 444.9 396.9 L 444.9 397.4 L 443.0 397.4 L 443.0 398.7 L 444.7 398.7 L 444.7 399.2 L 443.0 399.2 L 443.0 401.2 L 442.4 401.2 L 442.4 396.9 \" fill=\"#33CCCC\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 627.5,376.7 L 641.9,374.1\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-1 atom-1 atom-2\" d=\"M 641.9,374.1 L 646.9,360.2\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-1 atom-1 atom-2\" d=\"M 645.5,373.0 L 648.9,363.3\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-20 atom-20 atom-1\" d=\"M 651.5,385.3 L 641.9,374.1\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-2 atom-2 atom-3\" d=\"M 646.9,360.2 L 661.4,357.6\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-3 atom-3 atom-4\" d=\"M 661.4,357.6 L 670.9,368.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-3 atom-3 atom-4\" d=\"M 660.6,361.2 L 667.2,369.1\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-4 atom-4 atom-5\" d=\"M 670.9,368.8 L 677.1,367.7\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-4 atom-4 atom-5\" d=\"M 677.1,367.7 L 683.4,366.6\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-18 atom-4 atom-19\" d=\"M 670.9,368.8 L 665.9,382.7\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-5 atom-5 atom-6\" d=\"M 687.3,368.5 L 691.1,373.0\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-5 atom-5 atom-6\" d=\"M 691.1,373.0 L 694.9,377.4\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-6 atom-6 atom-7\" d=\"M 693.5,376.9 L 691.5,382.6\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-6 atom-6 atom-7\" d=\"M 691.5,382.6 L 689.4,388.3\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-6 atom-6 atom-7\" d=\"M 696.3,377.9 L 694.2,383.6\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-6 atom-6 atom-7\" d=\"M 694.2,383.6 L 692.2,389.3\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-7 atom-6 atom-8\" d=\"M 694.9,377.4 L 701.1,376.3\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-7 atom-6 atom-8\" d=\"M 701.1,376.3 L 707.4,375.2\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-8 atom-8 atom-9\" d=\"M 711.3,377.1 L 715.1,381.6\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-8 atom-8 atom-9\" d=\"M 715.1,381.6 L 718.9,386.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-21 atom-18 atom-8\" d=\"M 714.3,360.9 L 712.3,366.6\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-21 atom-18 atom-8\" d=\"M 712.3,366.6 L 710.2,372.3\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-9 atom-9 atom-10\" d=\"M 718.9,386.0 L 733.3,383.4\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-10 atom-10 atom-11\" d=\"M 733.3,383.4 L 738.3,369.5\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-11 atom-11 atom-12\" d=\"M 738.3,369.5 L 752.8,366.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-16 atom-11 atom-17\" d=\"M 738.3,369.5 L 728.8,358.3\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-12 atom-12 atom-13\" d=\"M 754.2,367.4 L 756.2,361.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-12 atom-12 atom-13\" d=\"M 756.2,361.8 L 758.2,356.1\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-12 atom-12 atom-13\" d=\"M 751.4,366.4 L 753.4,360.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-12 atom-12 atom-13\" d=\"M 753.4,360.8 L 755.4,355.1\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-13 atom-12 atom-14\" d=\"M 752.8,366.9 L 756.5,371.3\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-13 atom-12 atom-14\" d=\"M 756.5,371.3 L 760.3,375.8\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-14 atom-14 atom-15\" d=\"M 764.3,377.8 L 770.5,376.6\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-14 atom-14 atom-15\" d=\"M 770.5,376.6 L 776.8,375.5\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-15 atom-14 atom-16\" d=\"M 761.4,380.6 L 759.4,386.3\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-15 atom-14 atom-16\" d=\"M 759.4,386.3 L 757.3,392.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-17 atom-17 atom-18\" d=\"M 728.8,358.3 L 714.3,360.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-19 atom-19 atom-20\" d=\"M 665.9,382.7 L 651.5,385.3\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-19 atom-19 atom-20\" d=\"M 663.2,380.2 L 653.1,382.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"atom-5\" d=\"M 684.4 364.1 L 685.8 366.3 Q 686.0 366.6, 686.2 367.0 Q 686.4 367.4, 686.4 367.4 L 686.4 364.1 L 687.0 364.1 L 687.0 368.3 L 686.4 368.3 L 684.9 365.9 Q 684.7 365.6, 684.5 365.3 Q 684.4 364.9, 684.3 364.8 L 684.3 368.3 L 683.7 368.3 L 683.7 364.1 L 684.4 364.1 \" fill=\"#0000FF\"/>\n<path class=\"atom-5\" d=\"M 683.7 359.4 L 684.3 359.4 L 684.3 361.2 L 686.4 361.2 L 686.4 359.4 L 687.0 359.4 L 687.0 363.7 L 686.4 363.7 L 686.4 361.7 L 684.3 361.7 L 684.3 363.7 L 683.7 363.7 L 683.7 359.4 \" fill=\"#0000FF\"/>\n<path class=\"atom-7\" d=\"M 688.0 391.3 Q 688.0 390.3, 688.5 389.7 Q 689.0 389.1, 689.9 389.1 Q 690.9 389.1, 691.4 389.7 Q 691.9 390.3, 691.9 391.3 Q 691.9 392.3, 691.4 392.9 Q 690.8 393.5, 689.9 393.5 Q 689.0 393.5, 688.5 392.9 Q 688.0 392.3, 688.0 391.3 M 689.9 393.0 Q 690.6 393.0, 690.9 392.6 Q 691.3 392.1, 691.3 391.3 Q 691.3 390.5, 690.9 390.0 Q 690.6 389.6, 689.9 389.6 Q 689.3 389.6, 688.9 390.0 Q 688.6 390.4, 688.6 391.3 Q 688.6 392.1, 688.9 392.6 Q 689.3 393.0, 689.9 393.0 \" fill=\"#FF0000\"/>\n<path class=\"atom-8\" d=\"M 708.4 372.7 L 709.8 374.9 Q 709.9 375.1, 710.2 375.5 Q 710.4 375.9, 710.4 376.0 L 710.4 372.7 L 711.0 372.7 L 711.0 376.9 L 710.4 376.9 L 708.9 374.5 Q 708.7 374.2, 708.5 373.8 Q 708.3 373.5, 708.3 373.4 L 708.3 376.9 L 707.7 376.9 L 707.7 372.7 L 708.4 372.7 \" fill=\"#0000FF\"/>\n<path class=\"atom-13\" d=\"M 755.8 353.1 Q 755.8 352.0, 756.3 351.5 Q 756.8 350.9, 757.7 350.9 Q 758.7 350.9, 759.2 351.5 Q 759.7 352.0, 759.7 353.1 Q 759.7 354.1, 759.2 354.7 Q 758.7 355.3, 757.7 355.3 Q 756.8 355.3, 756.3 354.7 Q 755.8 354.1, 755.8 353.1 M 757.7 354.8 Q 758.4 354.8, 758.7 354.3 Q 759.1 353.9, 759.1 353.1 Q 759.1 352.2, 758.7 351.8 Q 758.4 351.4, 757.7 351.4 Q 757.1 351.4, 756.7 351.8 Q 756.4 352.2, 756.4 353.1 Q 756.4 353.9, 756.7 354.3 Q 757.1 354.8, 757.7 354.8 \" fill=\"#FF0000\"/>\n<path class=\"atom-14\" d=\"M 761.3 376.0 L 762.7 378.2 Q 762.9 378.5, 763.1 378.9 Q 763.3 379.3, 763.3 379.3 L 763.3 376.0 L 763.9 376.0 L 763.9 380.2 L 763.3 380.2 L 761.8 377.8 Q 761.6 377.5, 761.5 377.2 Q 761.3 376.8, 761.2 376.7 L 761.2 380.2 L 760.7 380.2 L 760.7 376.0 L 761.3 376.0 \" fill=\"#0000FF\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 93.6,538.9 L 94.8,533.0\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 94.8,533.0 L 96.0,527.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 90.7,538.3 L 91.9,532.4\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 91.9,532.4 L 93.1,526.4\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-1 atom-1 atom-2\" d=\"M 94.5,526.7 L 90.0,522.7\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-1 atom-1 atom-2\" d=\"M 90.0,522.7 L 85.5,518.7\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-11 atom-1 atom-12\" d=\"M 94.5,526.7 L 100.5,524.7\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-11 atom-1 atom-12\" d=\"M 100.5,524.7 L 106.5,522.7\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-2 atom-2 atom-3\" d=\"M 81.5,517.7 L 75.5,519.7\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-2 atom-2 atom-3\" d=\"M 75.5,519.7 L 69.6,521.7\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-3 atom-3 atom-4\" d=\"M 69.6,521.7 L 66.6,536.1\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-3 atom-3 atom-4\" d=\"M 66.2,523.2 L 64.2,533.3\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-24 atom-11 atom-3\" d=\"M 58.5,511.9 L 69.6,521.7\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-4 atom-4 atom-5\" d=\"M 66.6,536.1 L 52.7,540.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-5 atom-5 atom-6\" d=\"M 52.7,540.8 L 41.7,531.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-5 atom-5 atom-6\" d=\"M 53.0,537.1 L 45.3,530.3\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-6 atom-6 atom-7\" d=\"M 41.7,531.0 L 35.5,531.7\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-6 atom-6 atom-7\" d=\"M 35.5,531.7 L 29.4,532.4\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-26 atom-10 atom-6\" d=\"M 44.6,516.6 L 41.7,531.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-7 atom-7 atom-8\" d=\"M 25.9,530.2 L 23.4,524.7\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-7 atom-7 atom-8\" d=\"M 23.4,524.7 L 20.9,519.3\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-8 atom-8 atom-9\" d=\"M 20.9,519.3 L 25.2,515.4\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-8 atom-8 atom-9\" d=\"M 25.2,515.4 L 29.5,511.5\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-9 atom-9 atom-10\" d=\"M 34.1,510.7 L 39.3,513.6\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-9 atom-9 atom-10\" d=\"M 39.3,513.6 L 44.6,516.6\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-10 atom-10 atom-11\" d=\"M 44.6,516.6 L 58.5,511.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-10 atom-10 atom-11\" d=\"M 47.6,518.7 L 57.4,515.4\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-12 atom-12 atom-13\" d=\"M 110.5,523.8 L 115.0,527.8\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-12 atom-12 atom-13\" d=\"M 115.0,527.8 L 119.5,531.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-25 atom-24 atom-12\" d=\"M 111.4,507.7 L 110.2,513.6\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-25 atom-24 atom-12\" d=\"M 110.2,513.6 L 109.0,519.6\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-13 atom-13 atom-14\" d=\"M 119.5,531.8 L 133.5,527.1\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-14 atom-14 atom-15\" d=\"M 133.5,527.1 L 136.4,512.7\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-15 atom-15 atom-16\" d=\"M 136.4,512.7 L 150.3,508.1\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-22 atom-15 atom-23\" d=\"M 136.4,512.7 L 125.4,503.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-16 atom-16 atom-17\" d=\"M 150.3,508.1 L 154.9,512.1\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-16 atom-16 atom-17\" d=\"M 154.9,512.1 L 159.4,516.1\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-17 atom-17 atom-18\" d=\"M 160.8,520.3 L 159.6,526.3\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-17 atom-17 atom-18\" d=\"M 159.6,526.3 L 158.4,532.2\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-27 atom-22 atom-17\" d=\"M 175.3,513.1 L 169.3,515.1\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-27 atom-22 atom-17\" d=\"M 169.3,515.1 L 163.3,517.1\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-18 atom-18 atom-19\" d=\"M 158.4,532.2 L 169.4,542.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-19 atom-19 atom-20\" d=\"M 169.4,542.0 L 175.3,540.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-19 atom-19 atom-20\" d=\"M 175.3,540.0 L 181.1,538.1\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-20 atom-20 atom-21\" d=\"M 183.9,534.8 L 185.1,528.8\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-20 atom-20 atom-21\" d=\"M 185.1,528.8 L 186.3,522.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-21 atom-21 atom-22\" d=\"M 186.3,522.9 L 175.3,513.1\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-23 atom-23 atom-24\" d=\"M 125.4,503.0 L 111.4,507.7\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"atom-0\" d=\"M 89.7 541.2 Q 89.7 540.2, 90.2 539.6 Q 90.7 539.0, 91.6 539.0 Q 92.5 539.0, 93.0 539.6 Q 93.6 540.2, 93.6 541.2 Q 93.6 542.2, 93.0 542.8 Q 92.5 543.4, 91.6 543.4 Q 90.7 543.4, 90.2 542.8 Q 89.7 542.2, 89.7 541.2 M 91.6 542.9 Q 92.2 542.9, 92.6 542.5 Q 93.0 542.0, 93.0 541.2 Q 93.0 540.3, 92.6 539.9 Q 92.2 539.5, 91.6 539.5 Q 91.0 539.5, 90.6 539.9 Q 90.3 540.3, 90.3 541.2 Q 90.3 542.0, 90.6 542.5 Q 91.0 542.9, 91.6 542.9 \" fill=\"#FF0000\"/>\n<path class=\"atom-2\" d=\"M 82.6 514.9 L 84.0 517.1 Q 84.1 517.3, 84.3 517.7 Q 84.5 518.1, 84.6 518.2 L 84.6 514.9 L 85.1 514.9 L 85.1 519.1 L 84.5 519.1 L 83.0 516.7 Q 82.9 516.4, 82.7 516.0 Q 82.5 515.7, 82.5 515.6 L 82.5 519.1 L 81.9 519.1 L 81.9 514.9 L 82.6 514.9 \" fill=\"#0000FF\"/>\n<path class=\"atom-2\" d=\"M 81.9 510.2 L 82.4 510.2 L 82.4 512.0 L 84.6 512.0 L 84.6 510.2 L 85.2 510.2 L 85.2 514.4 L 84.6 514.4 L 84.6 512.5 L 82.4 512.5 L 82.4 514.4 L 81.9 514.4 L 81.9 510.2 \" fill=\"#0000FF\"/>\n<path class=\"atom-7\" d=\"M 25.1 532.7 Q 25.1 531.7, 25.6 531.1 Q 26.1 530.5, 27.0 530.5 Q 28.0 530.5, 28.5 531.1 Q 29.0 531.7, 29.0 532.7 Q 29.0 533.7, 28.5 534.3 Q 28.0 534.9, 27.0 534.9 Q 26.1 534.9, 25.6 534.3 Q 25.1 533.7, 25.1 532.7 M 27.0 534.4 Q 27.7 534.4, 28.0 534.0 Q 28.4 533.5, 28.4 532.7 Q 28.4 531.9, 28.0 531.4 Q 27.7 531.0, 27.0 531.0 Q 26.4 531.0, 26.0 531.4 Q 25.7 531.8, 25.7 532.7 Q 25.7 533.5, 26.0 534.0 Q 26.4 534.4, 27.0 534.4 \" fill=\"#FF0000\"/>\n<path class=\"atom-9\" d=\"M 29.8 509.4 Q 29.8 508.3, 30.3 507.8 Q 30.8 507.2, 31.8 507.2 Q 32.7 507.2, 33.2 507.8 Q 33.7 508.3, 33.7 509.4 Q 33.7 510.4, 33.2 511.0 Q 32.7 511.6, 31.8 511.6 Q 30.9 511.6, 30.3 511.0 Q 29.8 510.4, 29.8 509.4 M 31.8 511.1 Q 32.4 511.1, 32.8 510.6 Q 33.1 510.2, 33.1 509.4 Q 33.1 508.5, 32.8 508.1 Q 32.4 507.7, 31.8 507.7 Q 31.1 507.7, 30.8 508.1 Q 30.4 508.5, 30.4 509.4 Q 30.4 510.2, 30.8 510.6 Q 31.1 511.1, 31.8 511.1 \" fill=\"#FF0000\"/>\n<path class=\"atom-12\" d=\"M 107.5 519.9 L 108.9 522.2 Q 109.1 522.4, 109.3 522.8 Q 109.5 523.2, 109.5 523.2 L 109.5 519.9 L 110.1 519.9 L 110.1 524.2 L 109.5 524.2 L 108.0 521.7 Q 107.8 521.4, 107.7 521.1 Q 107.5 520.8, 107.4 520.7 L 107.4 524.2 L 106.9 524.2 L 106.9 519.9 L 107.5 519.9 \" fill=\"#0000FF\"/>\n<path class=\"atom-17\" d=\"M 160.4 515.7 L 161.8 517.9 Q 161.9 518.2, 162.2 518.6 Q 162.4 519.0, 162.4 519.0 L 162.4 515.7 L 163.0 515.7 L 163.0 519.9 L 162.4 519.9 L 160.9 517.5 Q 160.7 517.2, 160.5 516.9 Q 160.3 516.5, 160.3 516.4 L 160.3 519.9 L 159.7 519.9 L 159.7 515.7 L 160.4 515.7 \" fill=\"#0000FF\"/>\n<path class=\"atom-20\" d=\"M 181.4 537.3 Q 181.4 536.3, 181.9 535.7 Q 182.5 535.2, 183.4 535.2 Q 184.3 535.2, 184.8 535.7 Q 185.3 536.3, 185.3 537.3 Q 185.3 538.3, 184.8 538.9 Q 184.3 539.5, 183.4 539.5 Q 182.5 539.5, 181.9 538.9 Q 181.4 538.4, 181.4 537.3 M 183.4 539.0 Q 184.0 539.0, 184.4 538.6 Q 184.7 538.2, 184.7 537.3 Q 184.7 536.5, 184.4 536.1 Q 184.0 535.6, 183.4 535.6 Q 182.7 535.6, 182.4 536.1 Q 182.0 536.5, 182.0 537.3 Q 182.0 538.2, 182.4 538.6 Q 182.7 539.0, 183.4 539.0 \" fill=\"#FF0000\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 236.9,549.3 L 244.7,536.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-1 atom-1 atom-2\" d=\"M 244.7,536.8 L 250.9,537.1\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-1 atom-1 atom-2\" d=\"M 250.9,537.1 L 257.1,537.3\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-2 atom-2 atom-3\" d=\"M 261.0,534.9 L 264.1,529.9\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-2 atom-2 atom-3\" d=\"M 264.1,529.9 L 267.2,524.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-3 atom-3 atom-4\" d=\"M 267.2,524.9 L 260.4,511.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-20 atom-20 atom-3\" d=\"M 281.9,525.5 L 267.2,524.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-4 atom-4 atom-5\" d=\"M 260.4,511.9 L 268.2,499.5\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-5 atom-5 atom-6\" d=\"M 268.2,499.5 L 282.9,500.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-6 atom-6 atom-7\" d=\"M 282.9,500.0 L 285.7,505.3\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-6 atom-6 atom-7\" d=\"M 285.7,505.3 L 288.4,510.5\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-7 atom-7 atom-8\" d=\"M 291.7,513.1 L 298.1,513.3\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-7 atom-7 atom-8\" d=\"M 298.1,513.3 L 304.5,513.6\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-19 atom-7 atom-20\" d=\"M 288.2,515.5 L 285.1,520.5\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-19 atom-7 atom-20\" d=\"M 285.1,520.5 L 281.9,525.5\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-8 atom-8 atom-9\" d=\"M 305.7,514.4 L 308.8,509.4\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-8 atom-8 atom-9\" d=\"M 308.8,509.4 L 311.9,504.5\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-8 atom-8 atom-9\" d=\"M 303.2,512.8 L 306.3,507.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-8 atom-8 atom-9\" d=\"M 306.3,507.9 L 309.4,502.9\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-9 atom-8 atom-10\" d=\"M 304.5,513.6 L 307.2,518.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-9 atom-8 atom-10\" d=\"M 307.2,518.8 L 310.0,524.1\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-10 atom-10 atom-11\" d=\"M 313.3,526.7 L 319.7,526.9\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-10 atom-10 atom-11\" d=\"M 319.7,526.9 L 326.0,527.1\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-11 atom-11 atom-12\" d=\"M 326.0,527.1 L 332.9,540.2\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-11 atom-11 atom-12\" d=\"M 329.7,527.7 L 334.5,536.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-21 atom-18 atom-11\" d=\"M 333.9,514.7 L 326.0,527.1\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-12 atom-12 atom-13\" d=\"M 332.9,540.2 L 325.1,552.6\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-13 atom-12 atom-14\" d=\"M 332.9,540.2 L 347.6,540.7\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-14 atom-14 atom-15\" d=\"M 347.6,540.7 L 355.4,528.3\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-14 atom-14 atom-15\" d=\"M 346.3,537.3 L 351.8,528.6\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-15 atom-15 atom-16\" d=\"M 355.4,528.3 L 370.1,528.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-16 atom-15 atom-17\" d=\"M 355.4,528.3 L 348.6,515.3\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-17 atom-17 atom-18\" d=\"M 348.6,515.3 L 333.9,514.7\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-17 atom-17 atom-18\" d=\"M 346.2,518.1 L 336.0,517.7\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-18 atom-18 atom-19\" d=\"M 333.9,514.7 L 330.7,508.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-18 atom-18 atom-19\" d=\"M 330.7,508.8 L 327.6,502.9\" style=\"fill:none;fill-rule:evenodd;stroke:#00CC00;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"atom-2\" d=\"M 257.4 537.4 Q 257.4 536.4, 257.9 535.8 Q 258.4 535.2, 259.4 535.2 Q 260.3 535.2, 260.8 535.8 Q 261.3 536.4, 261.3 537.4 Q 261.3 538.4, 260.8 539.0 Q 260.3 539.6, 259.4 539.6 Q 258.5 539.6, 257.9 539.0 Q 257.4 538.4, 257.4 537.4 M 259.4 539.1 Q 260.0 539.1, 260.4 538.7 Q 260.7 538.2, 260.7 537.4 Q 260.7 536.6, 260.4 536.1 Q 260.0 535.7, 259.4 535.7 Q 258.7 535.7, 258.4 536.1 Q 258.0 536.5, 258.0 537.4 Q 258.0 538.2, 258.4 538.7 Q 258.7 539.1, 259.4 539.1 \" fill=\"#FF0000\"/>\n<path class=\"atom-7\" d=\"M 288.8 510.9 L 290.2 513.1 Q 290.3 513.4, 290.6 513.8 Q 290.8 514.2, 290.8 514.2 L 290.8 510.9 L 291.4 510.9 L 291.4 515.1 L 290.8 515.1 L 289.3 512.7 Q 289.1 512.4, 288.9 512.1 Q 288.8 511.7, 288.7 511.6 L 288.7 515.1 L 288.1 515.1 L 288.1 510.9 L 288.8 510.9 \" fill=\"#0000FF\"/>\n<path class=\"atom-9\" d=\"M 310.3 501.1 Q 310.3 500.1, 310.8 499.5 Q 311.3 499.0, 312.3 499.0 Q 313.2 499.0, 313.7 499.5 Q 314.2 500.1, 314.2 501.1 Q 314.2 502.2, 313.7 502.8 Q 313.2 503.3, 312.3 503.3 Q 311.4 503.3, 310.8 502.8 Q 310.3 502.2, 310.3 501.1 M 312.3 502.9 Q 312.9 502.9, 313.3 502.4 Q 313.6 502.0, 313.6 501.1 Q 313.6 500.3, 313.3 499.9 Q 312.9 499.5, 312.3 499.5 Q 311.6 499.5, 311.3 499.9 Q 310.9 500.3, 310.9 501.1 Q 310.9 502.0, 311.3 502.4 Q 311.6 502.9, 312.3 502.9 \" fill=\"#FF0000\"/>\n<path class=\"atom-10\" d=\"M 305.9 524.5 L 306.5 524.5 L 306.5 526.3 L 308.6 526.3 L 308.6 524.5 L 309.2 524.5 L 309.2 528.7 L 308.6 528.7 L 308.6 526.8 L 306.5 526.8 L 306.5 528.7 L 305.9 528.7 L 305.9 524.5 \" fill=\"#0000FF\"/>\n<path class=\"atom-10\" d=\"M 310.4 524.5 L 311.8 526.7 Q 311.9 526.9, 312.1 527.3 Q 312.4 527.7, 312.4 527.8 L 312.4 524.5 L 312.9 524.5 L 312.9 528.7 L 312.4 528.7 L 310.9 526.3 Q 310.7 526.0, 310.5 525.6 Q 310.3 525.3, 310.3 525.2 L 310.3 528.7 L 309.7 528.7 L 309.7 524.5 L 310.4 524.5 \" fill=\"#0000FF\"/>\n<path class=\"atom-19\" d=\"M 322.9 501.8 Q 322.9 500.8, 323.4 500.2 Q 323.9 499.7, 324.9 499.7 Q 325.7 499.7, 326.2 500.3 L 325.8 500.6 Q 325.5 500.2, 324.9 500.2 Q 324.2 500.2, 323.9 500.6 Q 323.5 501.0, 323.5 501.8 Q 323.5 502.7, 323.9 503.1 Q 324.2 503.5, 324.9 503.5 Q 325.4 503.5, 325.9 503.3 L 326.1 503.7 Q 325.9 503.8, 325.5 503.9 Q 325.2 504.0, 324.8 504.0 Q 323.9 504.0, 323.4 503.5 Q 322.9 502.9, 322.9 501.8 \" fill=\"#00CC00\"/>\n<path class=\"atom-19\" d=\"M 326.7 499.4 L 327.3 499.4 L 327.3 504.0 L 326.7 504.0 L 326.7 499.4 \" fill=\"#00CC00\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 587.0,534.3 L 580.7,533.5\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 580.7,533.5 L 574.4,532.6\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 587.3,531.4 L 582.0,530.7\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 582.0,530.7 L 576.6,530.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 586.6,537.2 L 581.2,536.5\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 581.2,536.5 L 575.9,535.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-1 atom-1 atom-2\" d=\"M 574.4,532.6 L 559.8,530.7\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-2 atom-2 atom-3\" d=\"M 559.8,530.7 L 550.8,542.3\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-2 atom-2 atom-3\" d=\"M 556.1,530.6 L 549.8,538.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-21 atom-21 atom-2\" d=\"M 554.2,517.1 L 559.8,530.7\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-3 atom-3 atom-4\" d=\"M 550.8,542.3 L 536.2,540.4\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-4 atom-4 atom-5\" d=\"M 536.2,540.4 L 530.6,526.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-4 atom-4 atom-5\" d=\"M 538.1,537.2 L 534.2,527.7\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-5 atom-5 atom-6\" d=\"M 530.6,526.8 L 524.3,526.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-5 atom-5 atom-6\" d=\"M 524.3,526.0 L 518.0,525.1\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-19 atom-5 atom-20\" d=\"M 530.6,526.8 L 539.6,515.1\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-6 atom-6 atom-7\" d=\"M 515.0,522.4 L 512.7,516.8\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-6 atom-6 atom-7\" d=\"M 512.7,516.8 L 510.4,511.3\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-7 atom-7 atom-8\" d=\"M 511.6,512.2 L 515.1,507.6\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-7 atom-7 atom-8\" d=\"M 515.1,507.6 L 518.6,503.1\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-7 atom-7 atom-8\" d=\"M 509.2,510.4 L 512.7,505.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-7 atom-7 atom-8\" d=\"M 512.7,505.8 L 516.2,501.3\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-8 atom-7 atom-9\" d=\"M 510.4,511.3 L 504.1,510.4\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-8 atom-7 atom-9\" d=\"M 504.1,510.4 L 497.8,509.6\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-9 atom-9 atom-10\" d=\"M 494.8,506.8 L 492.5,501.3\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-9 atom-9 atom-10\" d=\"M 492.5,501.3 L 490.2,495.7\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-22 atom-19 atom-9\" d=\"M 486.9,521.0 L 490.4,516.4\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-22 atom-19 atom-9\" d=\"M 490.4,516.4 L 493.9,511.8\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-10 atom-10 atom-11\" d=\"M 490.2,495.7 L 475.6,493.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-11 atom-11 atom-12\" d=\"M 475.6,493.8 L 466.7,505.5\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-12 atom-12 atom-13\" d=\"M 466.7,505.5 L 472.3,519.1\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-13 atom-13 atom-14\" d=\"M 472.3,519.1 L 463.3,530.7\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-18 atom-13 atom-19\" d=\"M 472.3,519.1 L 486.9,521.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-14 atom-14 atom-15\" d=\"M 463.3,530.7 L 457.0,529.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-14 atom-14 atom-15\" d=\"M 457.0,529.9 L 450.7,529.0\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-15 atom-15 atom-16\" d=\"M 446.8,531.3 L 443.3,535.9\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-15 atom-15 atom-16\" d=\"M 443.3,535.9 L 439.8,540.4\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-16 atom-16 atom-17\" d=\"M 439.8,540.4 L 433.4,539.6\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-16 atom-16 atom-17\" d=\"M 433.4,539.6 L 427.1,538.8\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-17 atom-16 atom-18\" d=\"M 438.4,541.0 L 440.7,546.5\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-17 atom-16 atom-18\" d=\"M 440.7,546.5 L 443.0,552.1\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-17 atom-16 atom-18\" d=\"M 441.1,539.9 L 443.4,545.4\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-17 atom-16 atom-18\" d=\"M 443.4,545.4 L 445.7,551.0\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-20 atom-20 atom-21\" d=\"M 539.6,515.1 L 554.2,517.1\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-20 atom-20 atom-21\" d=\"M 541.4,518.4 L 551.6,519.7\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"atom-0\" d=\"M 588.0 532.4 L 589.4 534.7 Q 589.5 534.9, 589.8 535.3 Q 590.0 535.7, 590.0 535.7 L 590.0 532.4 L 590.5 532.4 L 590.5 536.7 L 590.0 536.7 L 588.5 534.2 Q 588.3 533.9, 588.1 533.6 Q 587.9 533.3, 587.9 533.2 L 587.9 536.7 L 587.3 536.7 L 587.3 532.4 L 588.0 532.4 \" fill=\"#0000FF\"/>\n<path class=\"atom-6\" d=\"M 510.6 522.7 L 511.2 522.7 L 511.2 524.5 L 513.3 524.5 L 513.3 522.7 L 513.9 522.7 L 513.9 527.0 L 513.3 527.0 L 513.3 525.0 L 511.2 525.0 L 511.2 527.0 L 510.6 527.0 L 510.6 522.7 \" fill=\"#0000FF\"/>\n<path class=\"atom-6\" d=\"M 515.1 522.7 L 516.5 525.0 Q 516.6 525.2, 516.8 525.6 Q 517.1 526.0, 517.1 526.0 L 517.1 522.7 L 517.6 522.7 L 517.6 527.0 L 517.1 527.0 L 515.6 524.5 Q 515.4 524.2, 515.2 523.9 Q 515.0 523.6, 515.0 523.5 L 515.0 527.0 L 514.4 527.0 L 514.4 522.7 L 515.1 522.7 \" fill=\"#0000FF\"/>\n<path class=\"atom-8\" d=\"M 517.4 499.6 Q 517.4 498.6, 517.9 498.0 Q 518.4 497.5, 519.4 497.5 Q 520.3 497.5, 520.8 498.0 Q 521.3 498.6, 521.3 499.6 Q 521.3 500.7, 520.8 501.2 Q 520.3 501.8, 519.4 501.8 Q 518.4 501.8, 517.9 501.2 Q 517.4 500.7, 517.4 499.6 M 519.4 501.3 Q 520.0 501.3, 520.4 500.9 Q 520.7 500.5, 520.7 499.6 Q 520.7 498.8, 520.4 498.4 Q 520.0 497.9, 519.4 497.9 Q 518.7 497.9, 518.4 498.4 Q 518.0 498.8, 518.0 499.6 Q 518.0 500.5, 518.4 500.9 Q 518.7 501.3, 519.4 501.3 \" fill=\"#FF0000\"/>\n<path class=\"atom-9\" d=\"M 494.9 507.2 L 496.3 509.5 Q 496.4 509.7, 496.6 510.1 Q 496.9 510.5, 496.9 510.5 L 496.9 507.2 L 497.4 507.2 L 497.4 511.5 L 496.9 511.5 L 495.4 509.0 Q 495.2 508.7, 495.0 508.4 Q 494.8 508.0, 494.8 507.9 L 494.8 511.5 L 494.2 511.5 L 494.2 507.2 L 494.9 507.2 \" fill=\"#0000FF\"/>\n<path class=\"atom-15\" d=\"M 443.3 526.7 L 443.9 526.7 L 443.9 528.5 L 446.0 528.5 L 446.0 526.7 L 446.6 526.7 L 446.6 530.9 L 446.0 530.9 L 446.0 528.9 L 443.9 528.9 L 443.9 530.9 L 443.3 530.9 L 443.3 526.7 \" fill=\"#0000FF\"/>\n<path class=\"atom-15\" d=\"M 447.8 526.7 L 449.2 528.9 Q 449.3 529.1, 449.5 529.5 Q 449.8 529.9, 449.8 530.0 L 449.8 526.7 L 450.3 526.7 L 450.3 530.9 L 449.7 530.9 L 448.3 528.4 Q 448.1 528.2, 447.9 527.8 Q 447.7 527.5, 447.7 527.4 L 447.7 530.9 L 447.1 530.9 L 447.1 526.7 L 447.8 526.7 \" fill=\"#0000FF\"/>\n<path class=\"atom-17\" d=\"M 417.6 536.4 L 418.2 536.4 L 418.2 538.2 L 420.4 538.2 L 420.4 536.4 L 421.0 536.4 L 421.0 540.6 L 420.4 540.6 L 420.4 538.7 L 418.2 538.7 L 418.2 540.6 L 417.6 540.6 L 417.6 536.4 \" fill=\"#0000FF\"/>\n<path class=\"atom-17\" d=\"M 421.2 540.5 Q 421.3 540.2, 421.5 540.1 Q 421.8 539.9, 422.1 539.9 Q 422.5 539.9, 422.8 540.1 Q 423.0 540.4, 423.0 540.8 Q 423.0 541.2, 422.7 541.6 Q 422.4 542.0, 421.8 542.4 L 423.1 542.4 L 423.1 542.7 L 421.2 542.7 L 421.2 542.5 Q 421.7 542.1, 422.0 541.8 Q 422.3 541.6, 422.5 541.3 Q 422.6 541.1, 422.6 540.8 Q 422.6 540.5, 422.5 540.4 Q 422.3 540.2, 422.1 540.2 Q 421.9 540.2, 421.7 540.3 Q 421.6 540.4, 421.5 540.6 L 421.2 540.5 \" fill=\"#0000FF\"/>\n<path class=\"atom-17\" d=\"M 424.2 536.4 L 425.6 538.6 Q 425.8 538.8, 426.0 539.2 Q 426.2 539.7, 426.2 539.7 L 426.2 536.4 L 426.8 536.4 L 426.8 540.6 L 426.2 540.6 L 424.7 538.2 Q 424.5 537.9, 424.3 537.5 Q 424.2 537.2, 424.1 537.1 L 424.1 540.6 L 423.6 540.6 L 423.6 536.4 L 424.2 536.4 \" fill=\"#0000FF\"/>\n<path class=\"atom-18\" d=\"M 443.4 554.0 Q 443.4 553.0, 443.9 552.5 Q 444.4 551.9, 445.4 551.9 Q 446.3 551.9, 446.8 552.5 Q 447.3 553.0, 447.3 554.0 Q 447.3 555.1, 446.8 555.7 Q 446.3 556.2, 445.4 556.2 Q 444.4 556.2, 443.9 555.7 Q 443.4 555.1, 443.4 554.0 M 445.4 555.8 Q 446.0 555.8, 446.4 555.3 Q 446.7 554.9, 446.7 554.0 Q 446.7 553.2, 446.4 552.8 Q 446.0 552.4, 445.4 552.4 Q 444.7 552.4, 444.4 552.8 Q 444.0 553.2, 444.0 554.0 Q 444.0 554.9, 444.4 555.3 Q 444.7 555.8, 445.4 555.8 \" fill=\"#FF0000\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 631.1,506.1 L 634.4,520.4\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-1 atom-1 atom-2\" d=\"M 634.4,520.4 L 640.5,522.3\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-1 atom-1 atom-2\" d=\"M 640.5,522.3 L 646.5,524.1\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-2 atom-2 atom-3\" d=\"M 649.4,527.2 L 651.4,532.9\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-2 atom-2 atom-3\" d=\"M 651.4,532.9 L 653.3,538.6\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-18 atom-18 atom-2\" d=\"M 660.2,515.8 L 655.3,519.5\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-18 atom-18 atom-2\" d=\"M 655.3,519.5 L 650.5,523.2\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-3 atom-3 atom-4\" d=\"M 653.3,538.6 L 668.0,538.3\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-4 atom-4 atom-5\" d=\"M 668.0,538.3 L 672.3,524.2\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-5 atom-5 atom-6\" d=\"M 672.3,524.2 L 686.2,519.3\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-17 atom-5 atom-18\" d=\"M 672.3,524.2 L 660.2,515.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-6 atom-6 atom-7\" d=\"M 686.2,519.3 L 690.8,523.3\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-6 atom-6 atom-7\" d=\"M 690.8,523.3 L 695.3,527.2\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-7 atom-7 atom-8\" d=\"M 699.3,528.3 L 705.3,526.2\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-7 atom-7 atom-8\" d=\"M 705.3,526.2 L 711.2,524.1\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-8 atom-8 atom-9\" d=\"M 712.7,524.4 L 713.8,518.4\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-8 atom-8 atom-9\" d=\"M 713.8,518.4 L 714.9,512.5\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-8 atom-8 atom-9\" d=\"M 709.8,523.8 L 710.9,517.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-8 atom-8 atom-9\" d=\"M 710.9,517.9 L 712.0,512.0\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-9 atom-8 atom-10\" d=\"M 711.2,524.1 L 715.8,528.1\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-9 atom-8 atom-10\" d=\"M 715.8,528.1 L 720.4,532.0\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-10 atom-10 atom-11\" d=\"M 724.3,533.0 L 730.3,530.9\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-10 atom-10 atom-11\" d=\"M 730.3,530.9 L 736.3,528.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-11 atom-11 atom-12\" d=\"M 736.3,528.9 L 747.4,538.5\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-11 atom-11 atom-12\" d=\"M 739.8,528.1 L 747.6,534.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-19 atom-17 atom-11\" d=\"M 739.0,514.4 L 736.3,528.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-12 atom-12 atom-13\" d=\"M 747.4,538.5 L 761.3,533.6\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-13 atom-13 atom-14\" d=\"M 761.3,533.6 L 764.0,519.2\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-13 atom-13 atom-14\" d=\"M 758.8,530.9 L 760.7,520.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-14 atom-14 atom-15\" d=\"M 764.0,519.2 L 770.0,517.1\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-14 atom-14 atom-15\" d=\"M 770.0,517.1 L 775.9,515.0\" style=\"fill:none;fill-rule:evenodd;stroke:#00CC00;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-15 atom-14 atom-16\" d=\"M 764.0,519.2 L 752.9,509.6\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-16 atom-16 atom-17\" d=\"M 752.9,509.6 L 739.0,514.4\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-16 atom-16 atom-17\" d=\"M 751.8,513.1 L 742.1,516.5\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"atom-2\" d=\"M 647.6 522.6 L 649.0 524.8 Q 649.1 525.0, 649.3 525.4 Q 649.5 525.8, 649.5 525.9 L 649.5 522.6 L 650.1 522.6 L 650.1 526.8 L 649.5 526.8 L 648.0 524.3 Q 647.9 524.1, 647.7 523.7 Q 647.5 523.4, 647.4 523.3 L 647.4 526.8 L 646.9 526.8 L 646.9 522.6 L 647.6 522.6 \" fill=\"#0000FF\"/>\n<path class=\"atom-7\" d=\"M 696.4 526.8 L 697.8 529.1 Q 697.9 529.3, 698.1 529.7 Q 698.4 530.1, 698.4 530.1 L 698.4 526.8 L 698.9 526.8 L 698.9 531.1 L 698.4 531.1 L 696.9 528.6 Q 696.7 528.3, 696.5 528.0 Q 696.3 527.7, 696.3 527.6 L 696.3 531.1 L 695.7 531.1 L 695.7 526.8 L 696.4 526.8 \" fill=\"#0000FF\"/>\n<path class=\"atom-7\" d=\"M 695.7 531.5 L 696.2 531.5 L 696.2 533.3 L 698.4 533.3 L 698.4 531.5 L 699.0 531.5 L 699.0 535.7 L 698.4 535.7 L 698.4 533.8 L 696.2 533.8 L 696.2 535.7 L 695.7 535.7 L 695.7 531.5 \" fill=\"#0000FF\"/>\n<path class=\"atom-9\" d=\"M 712.0 509.7 Q 712.0 508.6, 712.5 508.1 Q 713.0 507.5, 714.0 507.5 Q 714.9 507.5, 715.4 508.1 Q 715.9 508.6, 715.9 509.7 Q 715.9 510.7, 715.4 511.3 Q 714.9 511.9, 714.0 511.9 Q 713.0 511.9, 712.5 511.3 Q 712.0 510.7, 712.0 509.7 M 714.0 511.4 Q 714.6 511.4, 715.0 511.0 Q 715.3 510.5, 715.3 509.7 Q 715.3 508.8, 715.0 508.4 Q 714.6 508.0, 714.0 508.0 Q 713.3 508.0, 713.0 508.4 Q 712.6 508.8, 712.6 509.7 Q 712.6 510.5, 713.0 511.0 Q 713.3 511.4, 714.0 511.4 \" fill=\"#FF0000\"/>\n<path class=\"atom-10\" d=\"M 721.4 531.6 L 722.8 533.8 Q 723.0 534.1, 723.2 534.5 Q 723.4 534.9, 723.4 534.9 L 723.4 531.6 L 724.0 531.6 L 724.0 535.8 L 723.4 535.8 L 721.9 533.4 Q 721.7 533.1, 721.5 532.8 Q 721.4 532.4, 721.3 532.3 L 721.3 535.8 L 720.7 535.8 L 720.7 531.6 L 721.4 531.6 \" fill=\"#0000FF\"/>\n<path class=\"atom-10\" d=\"M 720.7 536.3 L 721.3 536.3 L 721.3 538.1 L 723.4 538.1 L 723.4 536.3 L 724.0 536.3 L 724.0 540.5 L 723.4 540.5 L 723.4 538.5 L 721.3 538.5 L 721.3 540.5 L 720.7 540.5 L 720.7 536.3 \" fill=\"#0000FF\"/>\n<path class=\"atom-15\" d=\"M 776.3 514.5 Q 776.3 513.4, 776.8 512.9 Q 777.3 512.3, 778.2 512.3 Q 779.1 512.3, 779.6 512.9 L 779.2 513.3 Q 778.8 512.8, 778.2 512.8 Q 777.6 512.8, 777.2 513.3 Q 776.9 513.7, 776.9 514.5 Q 776.9 515.3, 777.2 515.8 Q 777.6 516.2, 778.3 516.2 Q 778.8 516.2, 779.3 515.9 L 779.5 516.4 Q 779.2 516.5, 778.9 516.6 Q 778.6 516.7, 778.2 516.7 Q 777.3 516.7, 776.8 516.1 Q 776.3 515.6, 776.3 514.5 \" fill=\"#00CC00\"/>\n<path class=\"atom-15\" d=\"M 780.1 512.1 L 780.6 512.1 L 780.6 516.6 L 780.1 516.6 L 780.1 512.1 \" fill=\"#00CC00\"/>\n</svg>",
"text/plain": [
"<IPython.core.display.SVG object>"
]
},
"metadata": {},
"output_type": "display_data"
},
{
"data": {
"image/svg+xml": "<svg baseProfile=\"full\" height=\"600px\" version=\"1.1\" viewBox=\"0 0 800 600\" width=\"800px\" xml:space=\"preserve\" xmlns=\"http://www.w3.org/2000/svg\" xmlns:rdkit=\"http://www.rdkit.org/xml\" xmlns:xlink=\"http://www.w3.org/1999/xlink\">\n<!-- END OF HEADER -->\n<rect height=\"600.0\" style=\"opacity:1.0;fill:#FFFFFF;stroke:none\" width=\"800.0\" x=\"0.0\" y=\"0.0\"> </rect>\n<rect height=\"600.0\" style=\"opacity:1.0;fill:#FFFFFF;stroke:none\" width=\"800.0\" x=\"0.0\" y=\"0.0\"> </rect>\n<rect height=\"600.0\" style=\"opacity:1.0;fill:#FFFFFF;stroke:none\" width=\"800.0\" x=\"0.0\" y=\"0.0\"> </rect>\n<rect height=\"600.0\" style=\"opacity:1.0;fill:#FFFFFF;stroke:none\" width=\"800.0\" x=\"0.0\" y=\"0.0\"> </rect>\n<rect height=\"600.0\" style=\"opacity:1.0;fill:#FFFFFF;stroke:none\" width=\"800.0\" x=\"0.0\" y=\"0.0\"> </rect>\n<rect height=\"600.0\" style=\"opacity:1.0;fill:#FFFFFF;stroke:none\" width=\"800.0\" x=\"0.0\" y=\"0.0\"> </rect>\n<rect height=\"600.0\" style=\"opacity:1.0;fill:#FFFFFF;stroke:none\" width=\"800.0\" x=\"0.0\" y=\"0.0\"> </rect>\n<rect height=\"600.0\" style=\"opacity:1.0;fill:#FFFFFF;stroke:none\" width=\"800.0\" x=\"0.0\" y=\"0.0\"> </rect>\n<rect height=\"600.0\" style=\"opacity:1.0;fill:#FFFFFF;stroke:none\" width=\"800.0\" x=\"0.0\" y=\"0.0\"> </rect>\n<rect height=\"600.0\" style=\"opacity:1.0;fill:#FFFFFF;stroke:none\" width=\"800.0\" x=\"0.0\" y=\"0.0\"> </rect>\n<rect height=\"600.0\" style=\"opacity:1.0;fill:#FFFFFF;stroke:none\" width=\"800.0\" x=\"0.0\" y=\"0.0\"> </rect>\n<rect height=\"600.0\" style=\"opacity:1.0;fill:#FFFFFF;stroke:none\" width=\"800.0\" x=\"0.0\" y=\"0.0\"> </rect>\n<rect height=\"600.0\" style=\"opacity:1.0;fill:#FFFFFF;stroke:none\" width=\"800.0\" x=\"0.0\" y=\"0.0\"> </rect>\n<rect height=\"600.0\" style=\"opacity:1.0;fill:#FFFFFF;stroke:none\" width=\"800.0\" x=\"0.0\" y=\"0.0\"> </rect>\n<rect height=\"600.0\" style=\"opacity:1.0;fill:#FFFFFF;stroke:none\" width=\"800.0\" x=\"0.0\" y=\"0.0\"> </rect>\n<rect height=\"600.0\" style=\"opacity:1.0;fill:#FFFFFF;stroke:none\" width=\"800.0\" x=\"0.0\" y=\"0.0\"> </rect>\n<rect height=\"600.0\" style=\"opacity:1.0;fill:#FFFFFF;stroke:none\" width=\"800.0\" x=\"0.0\" y=\"0.0\"> </rect>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 69.6,93.5 L 69.6,88.9\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 69.6,88.9 L 69.6,84.3\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 67.3,93.5 L 67.3,88.9\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 67.3,88.9 L 67.3,84.3\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-1 atom-1 atom-2\" d=\"M 68.5,84.3 L 64.4,81.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-1 atom-1 atom-2\" d=\"M 64.4,81.9 L 60.3,79.6\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-9 atom-1 atom-10\" d=\"M 68.5,84.3 L 72.6,81.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-9 atom-1 atom-10\" d=\"M 72.6,81.9 L 76.7,79.6\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-2 atom-2 atom-3\" d=\"M 56.5,79.6 L 52.4,81.9\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-2 atom-2 atom-3\" d=\"M 52.4,81.9 L 48.3,84.3\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-3 atom-3 atom-4\" d=\"M 48.3,84.3 L 38.2,78.5\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-3 atom-3 atom-4\" d=\"M 45.6,85.4 L 38.6,81.4\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-22 atom-8 atom-3\" d=\"M 48.3,95.9 L 48.3,84.3\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-4 atom-4 atom-5\" d=\"M 38.2,78.5 L 28.1,84.3\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-5 atom-5 atom-6\" d=\"M 28.1,84.3 L 28.1,95.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-5 atom-5 atom-6\" d=\"M 30.4,86.0 L 30.4,94.2\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-6 atom-6 atom-7\" d=\"M 28.1,95.9 L 38.2,101.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-7 atom-7 atom-8\" d=\"M 38.2,101.8 L 48.3,95.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-7 atom-7 atom-8\" d=\"M 38.6,98.9 L 45.6,94.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-8 atom-8 atom-9\" d=\"M 48.3,95.9 L 52.4,98.3\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-8 atom-8 atom-9\" d=\"M 52.4,98.3 L 56.5,100.6\" style=\"fill:none;fill-rule:evenodd;stroke:#00CC00;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-10 atom-10 atom-11\" d=\"M 78.6,76.0 L 78.6,71.4\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-10 atom-10 atom-11\" d=\"M 78.6,71.4 L 78.6,66.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-23 atom-22 atom-10\" d=\"M 88.6,84.3 L 84.5,81.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-23 atom-22 atom-10\" d=\"M 84.5,81.9 L 80.5,79.6\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-11 atom-11 atom-12\" d=\"M 78.6,66.8 L 88.6,61.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-12 atom-12 atom-13\" d=\"M 88.6,61.0 L 98.7,66.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-13 atom-13 atom-14\" d=\"M 98.7,66.8 L 108.8,61.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-20 atom-13 atom-21\" d=\"M 98.7,66.8 L 98.7,78.5\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-14 atom-14 atom-15\" d=\"M 108.8,61.0 L 112.9,63.4\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-14 atom-14 atom-15\" d=\"M 112.9,63.4 L 117.0,65.7\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-15 atom-15 atom-16\" d=\"M 118.9,69.2 L 118.9,73.8\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-15 atom-15 atom-16\" d=\"M 118.9,73.8 L 118.9,78.5\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-24 atom-20 atom-15\" d=\"M 129.0,61.0 L 124.9,63.4\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-24 atom-20 atom-15\" d=\"M 124.9,63.4 L 120.8,65.7\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-16 atom-16 atom-17\" d=\"M 118.9,78.5 L 129.0,84.3\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-17 atom-17 atom-18\" d=\"M 129.0,84.3 L 132.9,82.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-17 atom-17 atom-18\" d=\"M 132.9,82.0 L 136.8,79.8\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-18 atom-18 atom-19\" d=\"M 139.1,76.0 L 139.1,71.4\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-18 atom-18 atom-19\" d=\"M 139.1,71.4 L 139.1,66.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-19 atom-19 atom-20\" d=\"M 139.1,66.8 L 129.0,61.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-21 atom-21 atom-22\" d=\"M 98.7,78.5 L 88.6,84.3\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"atom-0\" d=\"M 66.5 95.9 Q 66.5 94.9, 67.0 94.4 Q 67.5 93.8, 68.5 93.8 Q 69.4 93.8, 69.9 94.4 Q 70.4 94.9, 70.4 95.9 Q 70.4 97.0, 69.9 97.6 Q 69.4 98.1, 68.5 98.1 Q 67.5 98.1, 67.0 97.6 Q 66.5 97.0, 66.5 95.9 M 68.5 97.7 Q 69.1 97.7, 69.5 97.2 Q 69.8 96.8, 69.8 95.9 Q 69.8 95.1, 69.5 94.7 Q 69.1 94.3, 68.5 94.3 Q 67.8 94.3, 67.5 94.7 Q 67.1 95.1, 67.1 95.9 Q 67.1 96.8, 67.5 97.2 Q 67.8 97.7, 68.5 97.7 \" fill=\"#FF0000\"/>\n<path class=\"atom-2\" d=\"M 57.4 76.3 L 58.8 78.6 Q 59.0 78.8, 59.2 79.2 Q 59.4 79.6, 59.4 79.6 L 59.4 76.3 L 60.0 76.3 L 60.0 80.6 L 59.4 80.6 L 57.9 78.1 Q 57.7 77.8, 57.6 77.5 Q 57.4 77.2, 57.3 77.1 L 57.3 80.6 L 56.8 80.6 L 56.8 76.3 L 57.4 76.3 \" fill=\"#0000FF\"/>\n<path class=\"atom-2\" d=\"M 56.7 71.7 L 57.3 71.7 L 57.3 73.5 L 59.5 73.5 L 59.5 71.7 L 60.0 71.7 L 60.0 75.9 L 59.5 75.9 L 59.5 73.9 L 57.3 73.9 L 57.3 75.9 L 56.7 75.9 L 56.7 71.7 \" fill=\"#0000FF\"/>\n<path class=\"atom-9\" d=\"M 56.7 101.9 Q 56.7 100.8, 57.2 100.3 Q 57.7 99.7, 58.7 99.7 Q 59.6 99.7, 60.0 100.4 L 59.6 100.7 Q 59.3 100.2, 58.7 100.2 Q 58.0 100.2, 57.7 100.7 Q 57.4 101.1, 57.4 101.9 Q 57.4 102.7, 57.7 103.2 Q 58.1 103.6, 58.7 103.6 Q 59.2 103.6, 59.8 103.3 L 59.9 103.8 Q 59.7 103.9, 59.4 104.0 Q 59.0 104.1, 58.7 104.1 Q 57.7 104.1, 57.2 103.5 Q 56.7 103.0, 56.7 101.9 \" fill=\"#00CC00\"/>\n<path class=\"atom-9\" d=\"M 60.5 99.5 L 61.1 99.5 L 61.1 104.0 L 60.5 104.0 L 60.5 99.5 \" fill=\"#00CC00\"/>\n<path class=\"atom-10\" d=\"M 77.6 76.3 L 79.0 78.6 Q 79.1 78.8, 79.4 79.2 Q 79.6 79.6, 79.6 79.6 L 79.6 76.3 L 80.2 76.3 L 80.2 80.6 L 79.6 80.6 L 78.1 78.1 Q 77.9 77.8, 77.7 77.5 Q 77.5 77.2, 77.5 77.1 L 77.5 80.6 L 76.9 80.6 L 76.9 76.3 L 77.6 76.3 \" fill=\"#0000FF\"/>\n<path class=\"atom-15\" d=\"M 118.0 64.7 L 119.4 66.9 Q 119.5 67.2, 119.7 67.6 Q 119.9 68.0, 119.9 68.0 L 119.9 64.7 L 120.5 64.7 L 120.5 68.9 L 119.9 68.9 L 118.4 66.5 Q 118.3 66.2, 118.1 65.9 Q 117.9 65.5, 117.8 65.4 L 117.8 68.9 L 117.3 68.9 L 117.3 64.7 L 118.0 64.7 \" fill=\"#0000FF\"/>\n<path class=\"atom-18\" d=\"M 137.1 78.5 Q 137.1 77.5, 137.6 76.9 Q 138.1 76.3, 139.1 76.3 Q 140.0 76.3, 140.5 76.9 Q 141.0 77.5, 141.0 78.5 Q 141.0 79.5, 140.5 80.1 Q 140.0 80.7, 139.1 80.7 Q 138.1 80.7, 137.6 80.1 Q 137.1 79.5, 137.1 78.5 M 139.1 80.2 Q 139.7 80.2, 140.1 79.8 Q 140.4 79.3, 140.4 78.5 Q 140.4 77.6, 140.1 77.2 Q 139.7 76.8, 139.1 76.8 Q 138.4 76.8, 138.1 77.2 Q 137.7 77.6, 137.7 78.5 Q 137.7 79.3, 138.1 79.8 Q 138.4 80.2, 139.1 80.2 \" fill=\"#FF0000\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 269.6,93.5 L 269.6,88.9\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 269.6,88.9 L 269.6,84.3\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 267.3,93.5 L 267.3,88.9\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 267.3,88.9 L 267.3,84.3\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-1 atom-1 atom-2\" d=\"M 268.5,84.3 L 264.4,81.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-1 atom-1 atom-2\" d=\"M 264.4,81.9 L 260.3,79.6\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-9 atom-1 atom-10\" d=\"M 268.5,84.3 L 272.6,81.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-9 atom-1 atom-10\" d=\"M 272.6,81.9 L 276.7,79.6\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-2 atom-2 atom-3\" d=\"M 256.5,79.6 L 252.4,81.9\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-2 atom-2 atom-3\" d=\"M 252.4,81.9 L 248.3,84.3\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-3 atom-3 atom-4\" d=\"M 248.3,84.3 L 238.2,78.5\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-3 atom-3 atom-4\" d=\"M 245.6,85.4 L 238.6,81.4\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-22 atom-9 atom-3\" d=\"M 248.3,95.9 L 248.3,84.3\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-4 atom-4 atom-5\" d=\"M 238.2,78.5 L 228.1,84.3\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-5 atom-5 atom-6\" d=\"M 228.1,84.3 L 228.1,95.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-5 atom-5 atom-6\" d=\"M 230.4,86.0 L 230.4,94.2\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-6 atom-6 atom-7\" d=\"M 228.1,95.9 L 223.9,98.4\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-6 atom-6 atom-7\" d=\"M 223.9,98.4 L 219.6,100.9\" style=\"fill:none;fill-rule:evenodd;stroke:#33CCCC;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-7 atom-6 atom-8\" d=\"M 228.1,95.9 L 238.2,101.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-8 atom-8 atom-9\" d=\"M 238.2,101.8 L 248.3,95.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-8 atom-8 atom-9\" d=\"M 238.6,98.9 L 245.6,94.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-10 atom-10 atom-11\" d=\"M 278.6,76.0 L 278.6,71.4\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-10 atom-10 atom-11\" d=\"M 278.6,71.4 L 278.6,66.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-23 atom-22 atom-10\" d=\"M 288.6,84.3 L 284.5,81.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-23 atom-22 atom-10\" d=\"M 284.5,81.9 L 280.5,79.6\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-11 atom-11 atom-12\" d=\"M 278.6,66.8 L 288.6,61.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-12 atom-12 atom-13\" d=\"M 288.6,61.0 L 298.7,66.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-13 atom-13 atom-14\" d=\"M 298.7,66.8 L 308.8,61.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-20 atom-13 atom-21\" d=\"M 298.7,66.8 L 298.7,78.5\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-14 atom-14 atom-15\" d=\"M 308.8,61.0 L 312.9,63.4\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-14 atom-14 atom-15\" d=\"M 312.9,63.4 L 317.0,65.7\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-15 atom-15 atom-16\" d=\"M 318.9,69.2 L 318.9,73.8\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-15 atom-15 atom-16\" d=\"M 318.9,73.8 L 318.9,78.5\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-24 atom-20 atom-15\" d=\"M 329.0,61.0 L 324.9,63.4\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-24 atom-20 atom-15\" d=\"M 324.9,63.4 L 320.8,65.7\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-16 atom-16 atom-17\" d=\"M 318.9,78.5 L 329.0,84.3\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-17 atom-17 atom-18\" d=\"M 329.0,84.3 L 332.9,82.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-17 atom-17 atom-18\" d=\"M 332.9,82.0 L 336.8,79.8\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-18 atom-18 atom-19\" d=\"M 339.1,76.0 L 339.1,71.4\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-18 atom-18 atom-19\" d=\"M 339.1,71.4 L 339.1,66.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-19 atom-19 atom-20\" d=\"M 339.1,66.8 L 329.0,61.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-21 atom-21 atom-22\" d=\"M 298.7,78.5 L 288.6,84.3\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"atom-0\" d=\"M 266.5 95.9 Q 266.5 94.9, 267.0 94.4 Q 267.5 93.8, 268.5 93.8 Q 269.4 93.8, 269.9 94.4 Q 270.4 94.9, 270.4 95.9 Q 270.4 97.0, 269.9 97.6 Q 269.4 98.1, 268.5 98.1 Q 267.5 98.1, 267.0 97.6 Q 266.5 97.0, 266.5 95.9 M 268.5 97.7 Q 269.1 97.7, 269.5 97.2 Q 269.8 96.8, 269.8 95.9 Q 269.8 95.1, 269.5 94.7 Q 269.1 94.3, 268.5 94.3 Q 267.8 94.3, 267.5 94.7 Q 267.1 95.1, 267.1 95.9 Q 267.1 96.8, 267.5 97.2 Q 267.8 97.7, 268.5 97.7 \" fill=\"#FF0000\"/>\n<path class=\"atom-2\" d=\"M 257.4 76.3 L 258.8 78.6 Q 259.0 78.8, 259.2 79.2 Q 259.4 79.6, 259.4 79.6 L 259.4 76.3 L 260.0 76.3 L 260.0 80.6 L 259.4 80.6 L 257.9 78.1 Q 257.7 77.8, 257.6 77.5 Q 257.4 77.2, 257.3 77.1 L 257.3 80.6 L 256.8 80.6 L 256.8 76.3 L 257.4 76.3 \" fill=\"#0000FF\"/>\n<path class=\"atom-2\" d=\"M 256.7 71.7 L 257.3 71.7 L 257.3 73.5 L 259.5 73.5 L 259.5 71.7 L 260.0 71.7 L 260.0 75.9 L 259.5 75.9 L 259.5 73.9 L 257.3 73.9 L 257.3 75.9 L 256.7 75.9 L 256.7 71.7 \" fill=\"#0000FF\"/>\n<path class=\"atom-7\" d=\"M 216.8 99.6 L 219.3 99.6 L 219.3 100.1 L 217.3 100.1 L 217.3 101.4 L 219.1 101.4 L 219.1 101.9 L 217.3 101.9 L 217.3 103.9 L 216.8 103.9 L 216.8 99.6 \" fill=\"#33CCCC\"/>\n<path class=\"atom-10\" d=\"M 277.6 76.3 L 279.0 78.6 Q 279.1 78.8, 279.4 79.2 Q 279.6 79.6, 279.6 79.6 L 279.6 76.3 L 280.2 76.3 L 280.2 80.6 L 279.6 80.6 L 278.1 78.1 Q 277.9 77.8, 277.7 77.5 Q 277.5 77.2, 277.5 77.1 L 277.5 80.6 L 276.9 80.6 L 276.9 76.3 L 277.6 76.3 \" fill=\"#0000FF\"/>\n<path class=\"atom-15\" d=\"M 318.0 64.7 L 319.4 66.9 Q 319.5 67.2, 319.7 67.6 Q 319.9 68.0, 319.9 68.0 L 319.9 64.7 L 320.5 64.7 L 320.5 68.9 L 319.9 68.9 L 318.4 66.5 Q 318.3 66.2, 318.1 65.9 Q 317.9 65.5, 317.8 65.4 L 317.8 68.9 L 317.3 68.9 L 317.3 64.7 L 318.0 64.7 \" fill=\"#0000FF\"/>\n<path class=\"atom-18\" d=\"M 337.1 78.5 Q 337.1 77.5, 337.6 76.9 Q 338.1 76.3, 339.1 76.3 Q 340.0 76.3, 340.5 76.9 Q 341.0 77.5, 341.0 78.5 Q 341.0 79.5, 340.5 80.1 Q 340.0 80.7, 339.1 80.7 Q 338.1 80.7, 337.6 80.1 Q 337.1 79.5, 337.1 78.5 M 339.1 80.2 Q 339.7 80.2, 340.1 79.8 Q 340.4 79.3, 340.4 78.5 Q 340.4 77.6, 340.1 77.2 Q 339.7 76.8, 339.1 76.8 Q 338.4 76.8, 338.1 77.2 Q 337.7 77.6, 337.7 78.5 Q 337.7 79.3, 338.1 79.8 Q 338.4 80.2, 339.1 80.2 \" fill=\"#FF0000\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 409.8,106.5 L 413.9,104.1\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 413.9,104.1 L 418.0,101.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 411.0,108.5 L 414.5,106.5\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 414.5,106.5 L 418.0,104.5\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 408.7,104.5 L 412.2,102.5\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 412.2,102.5 L 415.6,100.4\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-1 atom-1 atom-2\" d=\"M 418.0,101.8 L 428.1,95.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-2 atom-2 atom-3\" d=\"M 428.1,95.9 L 428.1,84.3\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-2 atom-2 atom-3\" d=\"M 430.4,94.2 L 430.4,86.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-23 atom-23 atom-2\" d=\"M 438.2,101.8 L 428.1,95.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-3 atom-3 atom-4\" d=\"M 428.1,84.3 L 438.2,78.5\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-4 atom-4 atom-5\" d=\"M 438.2,78.5 L 448.3,84.3\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-4 atom-4 atom-5\" d=\"M 438.6,81.4 L 445.6,85.4\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-5 atom-5 atom-6\" d=\"M 448.3,84.3 L 452.4,81.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-5 atom-5 atom-6\" d=\"M 452.4,81.9 L 456.5,79.6\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-21 atom-5 atom-22\" d=\"M 448.3,84.3 L 448.3,95.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-6 atom-6 atom-7\" d=\"M 460.3,79.6 L 464.4,81.9\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-6 atom-6 atom-7\" d=\"M 464.4,81.9 L 468.5,84.3\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-7 atom-7 atom-8\" d=\"M 467.3,84.3 L 467.3,88.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-7 atom-7 atom-8\" d=\"M 467.3,88.9 L 467.3,93.5\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-7 atom-7 atom-8\" d=\"M 469.6,84.3 L 469.6,88.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-7 atom-7 atom-8\" d=\"M 469.6,88.9 L 469.6,93.5\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-8 atom-7 atom-9\" d=\"M 468.5,84.3 L 472.6,81.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-8 atom-7 atom-9\" d=\"M 472.6,81.9 L 476.7,79.6\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-9 atom-9 atom-10\" d=\"M 478.6,76.0 L 478.6,71.4\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-9 atom-9 atom-10\" d=\"M 478.6,71.4 L 478.6,66.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-24 atom-21 atom-9\" d=\"M 488.6,84.3 L 484.5,81.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-24 atom-21 atom-9\" d=\"M 484.5,81.9 L 480.5,79.6\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-10 atom-10 atom-11\" d=\"M 478.6,66.8 L 488.6,61.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-11 atom-11 atom-12\" d=\"M 488.6,61.0 L 498.7,66.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-12 atom-12 atom-13\" d=\"M 498.7,66.8 L 508.8,61.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-19 atom-12 atom-20\" d=\"M 498.7,66.8 L 498.7,78.5\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-13 atom-13 atom-14\" d=\"M 508.8,61.0 L 512.9,63.4\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-13 atom-13 atom-14\" d=\"M 512.9,63.4 L 517.0,65.7\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-14 atom-14 atom-15\" d=\"M 518.9,69.2 L 518.9,73.8\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-14 atom-14 atom-15\" d=\"M 518.9,73.8 L 518.9,78.5\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-25 atom-19 atom-14\" d=\"M 529.0,61.0 L 524.9,63.4\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-25 atom-19 atom-14\" d=\"M 524.9,63.4 L 520.8,65.7\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-15 atom-15 atom-16\" d=\"M 518.9,78.5 L 529.0,84.3\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-16 atom-16 atom-17\" d=\"M 529.0,84.3 L 532.9,82.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-16 atom-16 atom-17\" d=\"M 532.9,82.0 L 536.8,79.8\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-17 atom-17 atom-18\" d=\"M 539.1,76.0 L 539.1,71.4\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-17 atom-17 atom-18\" d=\"M 539.1,71.4 L 539.1,66.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-18 atom-18 atom-19\" d=\"M 539.1,66.8 L 529.0,61.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-20 atom-20 atom-21\" d=\"M 498.7,78.5 L 488.6,84.3\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-22 atom-22 atom-23\" d=\"M 448.3,95.9 L 438.2,101.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-22 atom-22 atom-23\" d=\"M 445.6,94.8 L 438.6,98.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"atom-0\" d=\"M 407.0 105.5 L 408.4 107.7 Q 408.5 107.9, 408.8 108.3 Q 409.0 108.7, 409.0 108.8 L 409.0 105.5 L 409.6 105.5 L 409.6 109.7 L 409.0 109.7 L 407.5 107.2 Q 407.3 107.0, 407.1 106.6 Q 406.9 106.3, 406.9 106.2 L 406.9 109.7 L 406.3 109.7 L 406.3 105.5 L 407.0 105.5 \" fill=\"#0000FF\"/>\n<path class=\"atom-6\" d=\"M 457.4 76.3 L 458.8 78.6 Q 459.0 78.8, 459.2 79.2 Q 459.4 79.6, 459.4 79.6 L 459.4 76.3 L 460.0 76.3 L 460.0 80.6 L 459.4 80.6 L 457.9 78.1 Q 457.7 77.8, 457.6 77.5 Q 457.4 77.2, 457.3 77.1 L 457.3 80.6 L 456.8 80.6 L 456.8 76.3 L 457.4 76.3 \" fill=\"#0000FF\"/>\n<path class=\"atom-6\" d=\"M 456.7 71.7 L 457.3 71.7 L 457.3 73.5 L 459.5 73.5 L 459.5 71.7 L 460.0 71.7 L 460.0 75.9 L 459.5 75.9 L 459.5 73.9 L 457.3 73.9 L 457.3 75.9 L 456.7 75.9 L 456.7 71.7 \" fill=\"#0000FF\"/>\n<path class=\"atom-8\" d=\"M 466.5 95.9 Q 466.5 94.9, 467.0 94.4 Q 467.5 93.8, 468.5 93.8 Q 469.4 93.8, 469.9 94.4 Q 470.4 94.9, 470.4 95.9 Q 470.4 97.0, 469.9 97.6 Q 469.4 98.1, 468.5 98.1 Q 467.5 98.1, 467.0 97.6 Q 466.5 97.0, 466.5 95.9 M 468.5 97.7 Q 469.1 97.7, 469.5 97.2 Q 469.8 96.8, 469.8 95.9 Q 469.8 95.1, 469.5 94.7 Q 469.1 94.3, 468.5 94.3 Q 467.8 94.3, 467.5 94.7 Q 467.1 95.1, 467.1 95.9 Q 467.1 96.8, 467.5 97.2 Q 467.8 97.7, 468.5 97.7 \" fill=\"#FF0000\"/>\n<path class=\"atom-9\" d=\"M 477.6 76.3 L 479.0 78.6 Q 479.1 78.8, 479.4 79.2 Q 479.6 79.6, 479.6 79.6 L 479.6 76.3 L 480.2 76.3 L 480.2 80.6 L 479.6 80.6 L 478.1 78.1 Q 477.9 77.8, 477.7 77.5 Q 477.5 77.2, 477.5 77.1 L 477.5 80.6 L 476.9 80.6 L 476.9 76.3 L 477.6 76.3 \" fill=\"#0000FF\"/>\n<path class=\"atom-14\" d=\"M 518.0 64.7 L 519.4 66.9 Q 519.5 67.2, 519.7 67.6 Q 519.9 68.0, 519.9 68.0 L 519.9 64.7 L 520.5 64.7 L 520.5 68.9 L 519.9 68.9 L 518.4 66.5 Q 518.3 66.2, 518.1 65.9 Q 517.9 65.5, 517.8 65.4 L 517.8 68.9 L 517.3 68.9 L 517.3 64.7 L 518.0 64.7 \" fill=\"#0000FF\"/>\n<path class=\"atom-17\" d=\"M 537.1 78.5 Q 537.1 77.5, 537.6 76.9 Q 538.1 76.3, 539.1 76.3 Q 540.0 76.3, 540.5 76.9 Q 541.0 77.5, 541.0 78.5 Q 541.0 79.5, 540.5 80.1 Q 540.0 80.7, 539.1 80.7 Q 538.1 80.7, 537.6 80.1 Q 537.1 79.5, 537.1 78.5 M 539.1 80.2 Q 539.7 80.2, 540.1 79.8 Q 540.4 79.3, 540.4 78.5 Q 540.4 77.6, 540.1 77.2 Q 539.7 76.8, 539.1 76.8 Q 538.4 76.8, 538.1 77.2 Q 537.7 77.6, 537.7 78.5 Q 537.7 79.3, 538.1 79.8 Q 538.4 80.2, 539.1 80.2 \" fill=\"#FF0000\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 638.2,113.4 L 638.2,101.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-1 atom-1 atom-2\" d=\"M 638.2,101.8 L 628.1,95.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-1 atom-1 atom-2\" d=\"M 637.9,98.9 L 630.8,94.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-22 atom-22 atom-1\" d=\"M 648.3,95.9 L 638.2,101.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-2 atom-2 atom-3\" d=\"M 628.1,95.9 L 628.1,84.3\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-3 atom-3 atom-4\" d=\"M 628.1,84.3 L 638.2,78.5\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-3 atom-3 atom-4\" d=\"M 630.8,85.4 L 637.9,81.4\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-4 atom-4 atom-5\" d=\"M 638.2,78.5 L 648.3,84.3\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-5 atom-5 atom-6\" d=\"M 648.3,84.3 L 652.4,81.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-5 atom-5 atom-6\" d=\"M 652.4,81.9 L 656.5,79.6\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-21 atom-5 atom-22\" d=\"M 648.3,84.3 L 648.3,95.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-21 atom-5 atom-22\" d=\"M 646.0,86.0 L 646.0,94.2\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-6 atom-6 atom-7\" d=\"M 660.3,79.6 L 664.4,81.9\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-6 atom-6 atom-7\" d=\"M 664.4,81.9 L 668.5,84.3\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-7 atom-7 atom-8\" d=\"M 667.3,84.3 L 667.3,88.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-7 atom-7 atom-8\" d=\"M 667.3,88.9 L 667.3,93.5\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-7 atom-7 atom-8\" d=\"M 669.6,84.3 L 669.6,88.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-7 atom-7 atom-8\" d=\"M 669.6,88.9 L 669.6,93.5\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-8 atom-7 atom-9\" d=\"M 668.5,84.3 L 672.6,81.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-8 atom-7 atom-9\" d=\"M 672.6,81.9 L 676.7,79.6\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-9 atom-9 atom-10\" d=\"M 678.6,76.0 L 678.6,71.4\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-9 atom-9 atom-10\" d=\"M 678.6,71.4 L 678.6,66.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-23 atom-21 atom-9\" d=\"M 688.6,84.3 L 684.5,81.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-23 atom-21 atom-9\" d=\"M 684.5,81.9 L 680.5,79.6\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-10 atom-10 atom-11\" d=\"M 678.6,66.8 L 688.6,61.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-11 atom-11 atom-12\" d=\"M 688.6,61.0 L 698.7,66.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-12 atom-12 atom-13\" d=\"M 698.7,66.8 L 708.8,61.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-19 atom-12 atom-20\" d=\"M 698.7,66.8 L 698.7,78.5\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-13 atom-13 atom-14\" d=\"M 708.8,61.0 L 712.9,63.4\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-13 atom-13 atom-14\" d=\"M 712.9,63.4 L 717.0,65.7\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-14 atom-14 atom-15\" d=\"M 718.9,69.2 L 718.9,73.8\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-14 atom-14 atom-15\" d=\"M 718.9,73.8 L 718.9,78.5\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-24 atom-19 atom-14\" d=\"M 729.0,61.0 L 724.9,63.4\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-24 atom-19 atom-14\" d=\"M 724.9,63.4 L 720.8,65.7\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-15 atom-15 atom-16\" d=\"M 718.9,78.5 L 729.0,84.3\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-16 atom-16 atom-17\" d=\"M 729.0,84.3 L 732.9,82.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-16 atom-16 atom-17\" d=\"M 732.9,82.0 L 736.8,79.8\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-17 atom-17 atom-18\" d=\"M 739.1,76.0 L 739.1,71.4\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-17 atom-17 atom-18\" d=\"M 739.1,71.4 L 739.1,66.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-18 atom-18 atom-19\" d=\"M 739.1,66.8 L 729.0,61.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-20 atom-20 atom-21\" d=\"M 698.7,78.5 L 688.6,84.3\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"atom-6\" d=\"M 657.4 76.3 L 658.8 78.6 Q 659.0 78.8, 659.2 79.2 Q 659.4 79.6, 659.4 79.6 L 659.4 76.3 L 660.0 76.3 L 660.0 80.6 L 659.4 80.6 L 657.9 78.1 Q 657.7 77.8, 657.6 77.5 Q 657.4 77.2, 657.3 77.1 L 657.3 80.6 L 656.8 80.6 L 656.8 76.3 L 657.4 76.3 \" fill=\"#0000FF\"/>\n<path class=\"atom-6\" d=\"M 656.7 71.7 L 657.3 71.7 L 657.3 73.5 L 659.5 73.5 L 659.5 71.7 L 660.0 71.7 L 660.0 75.9 L 659.5 75.9 L 659.5 73.9 L 657.3 73.9 L 657.3 75.9 L 656.7 75.9 L 656.7 71.7 \" fill=\"#0000FF\"/>\n<path class=\"atom-8\" d=\"M 666.5 95.9 Q 666.5 94.9, 667.0 94.4 Q 667.5 93.8, 668.5 93.8 Q 669.4 93.8, 669.9 94.4 Q 670.4 94.9, 670.4 95.9 Q 670.4 97.0, 669.9 97.6 Q 669.4 98.1, 668.5 98.1 Q 667.5 98.1, 667.0 97.6 Q 666.5 97.0, 666.5 95.9 M 668.5 97.7 Q 669.1 97.7, 669.5 97.2 Q 669.8 96.8, 669.8 95.9 Q 669.8 95.1, 669.5 94.7 Q 669.1 94.3, 668.5 94.3 Q 667.8 94.3, 667.5 94.7 Q 667.1 95.1, 667.1 95.9 Q 667.1 96.8, 667.5 97.2 Q 667.8 97.7, 668.5 97.7 \" fill=\"#FF0000\"/>\n<path class=\"atom-9\" d=\"M 677.6 76.3 L 679.0 78.6 Q 679.1 78.8, 679.4 79.2 Q 679.6 79.6, 679.6 79.6 L 679.6 76.3 L 680.2 76.3 L 680.2 80.6 L 679.6 80.6 L 678.1 78.1 Q 677.9 77.8, 677.7 77.5 Q 677.5 77.2, 677.5 77.1 L 677.5 80.6 L 676.9 80.6 L 676.9 76.3 L 677.6 76.3 \" fill=\"#0000FF\"/>\n<path class=\"atom-14\" d=\"M 718.0 64.7 L 719.4 66.9 Q 719.5 67.2, 719.7 67.6 Q 719.9 68.0, 719.9 68.0 L 719.9 64.7 L 720.5 64.7 L 720.5 68.9 L 719.9 68.9 L 718.4 66.5 Q 718.3 66.2, 718.1 65.9 Q 717.9 65.5, 717.8 65.4 L 717.8 68.9 L 717.3 68.9 L 717.3 64.7 L 718.0 64.7 \" fill=\"#0000FF\"/>\n<path class=\"atom-17\" d=\"M 737.1 78.5 Q 737.1 77.5, 737.6 76.9 Q 738.1 76.3, 739.1 76.3 Q 740.0 76.3, 740.5 76.9 Q 741.0 77.5, 741.0 78.5 Q 741.0 79.5, 740.5 80.1 Q 740.0 80.7, 739.1 80.7 Q 738.1 80.7, 737.6 80.1 Q 737.1 79.5, 737.1 78.5 M 739.1 80.2 Q 739.7 80.2, 740.1 79.8 Q 740.4 79.3, 740.4 78.5 Q 740.4 77.6, 740.1 77.2 Q 739.7 76.8, 739.1 76.8 Q 738.4 76.8, 738.1 77.2 Q 737.7 77.6, 737.7 78.5 Q 737.7 79.3, 738.1 79.8 Q 738.4 80.2, 739.1 80.2 \" fill=\"#FF0000\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 69.6,243.5 L 69.6,238.9\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 69.6,238.9 L 69.6,234.3\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 67.3,243.5 L 67.3,238.9\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 67.3,238.9 L 67.3,234.3\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-1 atom-1 atom-2\" d=\"M 68.5,234.3 L 64.4,231.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-1 atom-1 atom-2\" d=\"M 64.4,231.9 L 60.3,229.6\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-9 atom-1 atom-10\" d=\"M 68.5,234.3 L 72.6,231.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-9 atom-1 atom-10\" d=\"M 72.6,231.9 L 76.7,229.6\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-2 atom-2 atom-3\" d=\"M 56.5,229.6 L 52.4,231.9\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-2 atom-2 atom-3\" d=\"M 52.4,231.9 L 48.3,234.3\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-3 atom-3 atom-4\" d=\"M 48.3,234.3 L 38.2,228.5\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-3 atom-3 atom-4\" d=\"M 45.6,235.4 L 38.6,231.4\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-22 atom-9 atom-3\" d=\"M 48.3,245.9 L 48.3,234.3\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-4 atom-4 atom-5\" d=\"M 38.2,228.5 L 28.1,234.3\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-5 atom-5 atom-6\" d=\"M 28.1,234.3 L 23.9,231.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-5 atom-5 atom-6\" d=\"M 23.9,231.8 L 19.6,229.4\" style=\"fill:none;fill-rule:evenodd;stroke:#33CCCC;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-6 atom-5 atom-7\" d=\"M 28.1,234.3 L 28.1,245.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-6 atom-5 atom-7\" d=\"M 30.4,236.0 L 30.4,244.2\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-7 atom-7 atom-8\" d=\"M 28.1,245.9 L 38.2,251.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-8 atom-8 atom-9\" d=\"M 38.2,251.8 L 48.3,245.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-8 atom-8 atom-9\" d=\"M 38.6,248.9 L 45.6,244.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-10 atom-10 atom-11\" d=\"M 78.6,226.0 L 78.6,221.4\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-10 atom-10 atom-11\" d=\"M 78.6,221.4 L 78.6,216.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-23 atom-22 atom-10\" d=\"M 88.6,234.3 L 84.5,231.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-23 atom-22 atom-10\" d=\"M 84.5,231.9 L 80.5,229.6\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-11 atom-11 atom-12\" d=\"M 78.6,216.8 L 88.6,211.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-12 atom-12 atom-13\" d=\"M 88.6,211.0 L 98.7,216.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-13 atom-13 atom-14\" d=\"M 98.7,216.8 L 108.8,211.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-20 atom-13 atom-21\" d=\"M 98.7,216.8 L 98.7,228.5\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-14 atom-14 atom-15\" d=\"M 108.8,211.0 L 112.9,213.4\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-14 atom-14 atom-15\" d=\"M 112.9,213.4 L 117.0,215.7\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-15 atom-15 atom-16\" d=\"M 118.9,219.2 L 118.9,223.8\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-15 atom-15 atom-16\" d=\"M 118.9,223.8 L 118.9,228.5\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-24 atom-20 atom-15\" d=\"M 129.0,211.0 L 124.9,213.4\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-24 atom-20 atom-15\" d=\"M 124.9,213.4 L 120.8,215.7\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-16 atom-16 atom-17\" d=\"M 118.9,228.5 L 129.0,234.3\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-17 atom-17 atom-18\" d=\"M 129.0,234.3 L 132.9,232.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-17 atom-17 atom-18\" d=\"M 132.9,232.0 L 136.8,229.8\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-18 atom-18 atom-19\" d=\"M 139.1,226.0 L 139.1,221.4\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-18 atom-18 atom-19\" d=\"M 139.1,221.4 L 139.1,216.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-19 atom-19 atom-20\" d=\"M 139.1,216.8 L 129.0,211.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-21 atom-21 atom-22\" d=\"M 98.7,228.5 L 88.6,234.3\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"atom-0\" d=\"M 66.5 245.9 Q 66.5 244.9, 67.0 244.4 Q 67.5 243.8, 68.5 243.8 Q 69.4 243.8, 69.9 244.4 Q 70.4 244.9, 70.4 245.9 Q 70.4 247.0, 69.9 247.6 Q 69.4 248.1, 68.5 248.1 Q 67.5 248.1, 67.0 247.6 Q 66.5 247.0, 66.5 245.9 M 68.5 247.7 Q 69.1 247.7, 69.5 247.2 Q 69.8 246.8, 69.8 245.9 Q 69.8 245.1, 69.5 244.7 Q 69.1 244.3, 68.5 244.3 Q 67.8 244.3, 67.5 244.7 Q 67.1 245.1, 67.1 245.9 Q 67.1 246.8, 67.5 247.2 Q 67.8 247.7, 68.5 247.7 \" fill=\"#FF0000\"/>\n<path class=\"atom-2\" d=\"M 57.4 226.3 L 58.8 228.6 Q 59.0 228.8, 59.2 229.2 Q 59.4 229.6, 59.4 229.6 L 59.4 226.3 L 60.0 226.3 L 60.0 230.6 L 59.4 230.6 L 57.9 228.1 Q 57.7 227.8, 57.6 227.5 Q 57.4 227.2, 57.3 227.1 L 57.3 230.6 L 56.8 230.6 L 56.8 226.3 L 57.4 226.3 \" fill=\"#0000FF\"/>\n<path class=\"atom-2\" d=\"M 56.7 221.7 L 57.3 221.7 L 57.3 223.5 L 59.5 223.5 L 59.5 221.7 L 60.0 221.7 L 60.0 225.9 L 59.5 225.9 L 59.5 223.9 L 57.3 223.9 L 57.3 225.9 L 56.7 225.9 L 56.7 221.7 \" fill=\"#0000FF\"/>\n<path class=\"atom-6\" d=\"M 16.8 226.3 L 19.3 226.3 L 19.3 226.8 L 17.3 226.8 L 17.3 228.1 L 19.1 228.1 L 19.1 228.6 L 17.3 228.6 L 17.3 230.6 L 16.8 230.6 L 16.8 226.3 \" fill=\"#33CCCC\"/>\n<path class=\"atom-10\" d=\"M 77.6 226.3 L 79.0 228.6 Q 79.1 228.8, 79.4 229.2 Q 79.6 229.6, 79.6 229.6 L 79.6 226.3 L 80.2 226.3 L 80.2 230.6 L 79.6 230.6 L 78.1 228.1 Q 77.9 227.8, 77.7 227.5 Q 77.5 227.2, 77.5 227.1 L 77.5 230.6 L 76.9 230.6 L 76.9 226.3 L 77.6 226.3 \" fill=\"#0000FF\"/>\n<path class=\"atom-15\" d=\"M 118.0 214.7 L 119.4 216.9 Q 119.5 217.2, 119.7 217.6 Q 119.9 218.0, 119.9 218.0 L 119.9 214.7 L 120.5 214.7 L 120.5 218.9 L 119.9 218.9 L 118.4 216.5 Q 118.3 216.2, 118.1 215.9 Q 117.9 215.5, 117.8 215.4 L 117.8 218.9 L 117.3 218.9 L 117.3 214.7 L 118.0 214.7 \" fill=\"#0000FF\"/>\n<path class=\"atom-18\" d=\"M 137.1 228.5 Q 137.1 227.5, 137.6 226.9 Q 138.1 226.3, 139.1 226.3 Q 140.0 226.3, 140.5 226.9 Q 141.0 227.5, 141.0 228.5 Q 141.0 229.5, 140.5 230.1 Q 140.0 230.7, 139.1 230.7 Q 138.1 230.7, 137.6 230.1 Q 137.1 229.5, 137.1 228.5 M 139.1 230.2 Q 139.7 230.2, 140.1 229.8 Q 140.4 229.3, 140.4 228.5 Q 140.4 227.6, 140.1 227.2 Q 139.7 226.8, 139.1 226.8 Q 138.4 226.8, 138.1 227.2 Q 137.7 227.6, 137.7 228.5 Q 137.7 229.3, 138.1 229.8 Q 138.4 230.2, 139.1 230.2 \" fill=\"#FF0000\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 269.6,243.5 L 269.6,238.9\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 269.6,238.9 L 269.6,234.3\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 267.3,243.5 L 267.3,238.9\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 267.3,238.9 L 267.3,234.3\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-1 atom-1 atom-2\" d=\"M 268.5,234.3 L 264.4,231.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-1 atom-1 atom-2\" d=\"M 264.4,231.9 L 260.3,229.6\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-9 atom-1 atom-10\" d=\"M 268.5,234.3 L 272.6,231.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-9 atom-1 atom-10\" d=\"M 272.6,231.9 L 276.7,229.6\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-2 atom-2 atom-3\" d=\"M 256.5,229.6 L 252.4,231.9\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-2 atom-2 atom-3\" d=\"M 252.4,231.9 L 248.3,234.3\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-3 atom-3 atom-4\" d=\"M 248.3,234.3 L 238.2,228.5\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-3 atom-3 atom-4\" d=\"M 245.6,235.4 L 238.6,231.4\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-22 atom-8 atom-3\" d=\"M 248.3,245.9 L 248.3,234.3\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-4 atom-4 atom-5\" d=\"M 238.2,228.5 L 228.1,234.3\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-5 atom-5 atom-6\" d=\"M 228.1,234.3 L 228.1,245.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-5 atom-5 atom-6\" d=\"M 230.4,236.0 L 230.4,244.2\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-6 atom-6 atom-7\" d=\"M 228.1,245.9 L 238.2,251.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-7 atom-7 atom-8\" d=\"M 238.2,251.8 L 248.3,245.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-7 atom-7 atom-8\" d=\"M 238.6,248.9 L 245.6,244.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-8 atom-8 atom-9\" d=\"M 248.3,245.9 L 252.6,248.4\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-8 atom-8 atom-9\" d=\"M 252.6,248.4 L 256.8,250.9\" style=\"fill:none;fill-rule:evenodd;stroke:#33CCCC;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-10 atom-10 atom-11\" d=\"M 278.6,226.0 L 278.6,221.4\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-10 atom-10 atom-11\" d=\"M 278.6,221.4 L 278.6,216.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-23 atom-22 atom-10\" d=\"M 288.6,234.3 L 284.5,231.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-23 atom-22 atom-10\" d=\"M 284.5,231.9 L 280.5,229.6\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-11 atom-11 atom-12\" d=\"M 278.6,216.8 L 288.6,211.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-12 atom-12 atom-13\" d=\"M 288.6,211.0 L 298.7,216.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-13 atom-13 atom-14\" d=\"M 298.7,216.8 L 308.8,211.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-20 atom-13 atom-21\" d=\"M 298.7,216.8 L 298.7,228.5\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-14 atom-14 atom-15\" d=\"M 308.8,211.0 L 312.9,213.4\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-14 atom-14 atom-15\" d=\"M 312.9,213.4 L 317.0,215.7\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-15 atom-15 atom-16\" d=\"M 318.9,219.2 L 318.9,223.8\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-15 atom-15 atom-16\" d=\"M 318.9,223.8 L 318.9,228.5\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-24 atom-20 atom-15\" d=\"M 329.0,211.0 L 324.9,213.4\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-24 atom-20 atom-15\" d=\"M 324.9,213.4 L 320.8,215.7\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-16 atom-16 atom-17\" d=\"M 318.9,228.5 L 329.0,234.3\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-17 atom-17 atom-18\" d=\"M 329.0,234.3 L 332.9,232.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-17 atom-17 atom-18\" d=\"M 332.9,232.0 L 336.8,229.8\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-18 atom-18 atom-19\" d=\"M 339.1,226.0 L 339.1,221.4\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-18 atom-18 atom-19\" d=\"M 339.1,221.4 L 339.1,216.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-19 atom-19 atom-20\" d=\"M 339.1,216.8 L 329.0,211.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-21 atom-21 atom-22\" d=\"M 298.7,228.5 L 288.6,234.3\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"atom-0\" d=\"M 266.5 245.9 Q 266.5 244.9, 267.0 244.4 Q 267.5 243.8, 268.5 243.8 Q 269.4 243.8, 269.9 244.4 Q 270.4 244.9, 270.4 245.9 Q 270.4 247.0, 269.9 247.6 Q 269.4 248.1, 268.5 248.1 Q 267.5 248.1, 267.0 247.6 Q 266.5 247.0, 266.5 245.9 M 268.5 247.7 Q 269.1 247.7, 269.5 247.2 Q 269.8 246.8, 269.8 245.9 Q 269.8 245.1, 269.5 244.7 Q 269.1 244.3, 268.5 244.3 Q 267.8 244.3, 267.5 244.7 Q 267.1 245.1, 267.1 245.9 Q 267.1 246.8, 267.5 247.2 Q 267.8 247.7, 268.5 247.7 \" fill=\"#FF0000\"/>\n<path class=\"atom-2\" d=\"M 257.4 226.3 L 258.8 228.6 Q 259.0 228.8, 259.2 229.2 Q 259.4 229.6, 259.4 229.6 L 259.4 226.3 L 260.0 226.3 L 260.0 230.6 L 259.4 230.6 L 257.9 228.1 Q 257.7 227.8, 257.6 227.5 Q 257.4 227.2, 257.3 227.1 L 257.3 230.6 L 256.8 230.6 L 256.8 226.3 L 257.4 226.3 \" fill=\"#0000FF\"/>\n<path class=\"atom-2\" d=\"M 256.7 221.7 L 257.3 221.7 L 257.3 223.5 L 259.5 223.5 L 259.5 221.7 L 260.0 221.7 L 260.0 225.9 L 259.5 225.9 L 259.5 223.9 L 257.3 223.9 L 257.3 225.9 L 256.7 225.9 L 256.7 221.7 \" fill=\"#0000FF\"/>\n<path class=\"atom-9\" d=\"M 257.1 249.6 L 259.6 249.6 L 259.6 250.1 L 257.7 250.1 L 257.7 251.4 L 259.4 251.4 L 259.4 251.9 L 257.7 251.9 L 257.7 253.9 L 257.1 253.9 L 257.1 249.6 \" fill=\"#33CCCC\"/>\n<path class=\"atom-10\" d=\"M 277.6 226.3 L 279.0 228.6 Q 279.1 228.8, 279.4 229.2 Q 279.6 229.6, 279.6 229.6 L 279.6 226.3 L 280.2 226.3 L 280.2 230.6 L 279.6 230.6 L 278.1 228.1 Q 277.9 227.8, 277.7 227.5 Q 277.5 227.2, 277.5 227.1 L 277.5 230.6 L 276.9 230.6 L 276.9 226.3 L 277.6 226.3 \" fill=\"#0000FF\"/>\n<path class=\"atom-15\" d=\"M 318.0 214.7 L 319.4 216.9 Q 319.5 217.2, 319.7 217.6 Q 319.9 218.0, 319.9 218.0 L 319.9 214.7 L 320.5 214.7 L 320.5 218.9 L 319.9 218.9 L 318.4 216.5 Q 318.3 216.2, 318.1 215.9 Q 317.9 215.5, 317.8 215.4 L 317.8 218.9 L 317.3 218.9 L 317.3 214.7 L 318.0 214.7 \" fill=\"#0000FF\"/>\n<path class=\"atom-18\" d=\"M 337.1 228.5 Q 337.1 227.5, 337.6 226.9 Q 338.1 226.3, 339.1 226.3 Q 340.0 226.3, 340.5 226.9 Q 341.0 227.5, 341.0 228.5 Q 341.0 229.5, 340.5 230.1 Q 340.0 230.7, 339.1 230.7 Q 338.1 230.7, 337.6 230.1 Q 337.1 229.5, 337.1 228.5 M 339.1 230.2 Q 339.7 230.2, 340.1 229.8 Q 340.4 229.3, 340.4 228.5 Q 340.4 227.6, 340.1 227.2 Q 339.7 226.8, 339.1 226.8 Q 338.4 226.8, 338.1 227.2 Q 337.7 227.6, 337.7 228.5 Q 337.7 229.3, 338.1 229.8 Q 338.4 230.2, 339.1 230.2 \" fill=\"#FF0000\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 584.5,252.0 L 579.8,252.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 579.8,252.0 L 575.1,252.0\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-1 atom-1 atom-2\" d=\"M 571.5,249.6 L 569.3,245.7\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-1 atom-1 atom-2\" d=\"M 569.3,245.7 L 567.1,241.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-2 atom-2 atom-3\" d=\"M 567.1,241.9 L 555.4,241.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-3 atom-3 atom-4\" d=\"M 555.4,241.9 L 553.2,238.1\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-3 atom-3 atom-4\" d=\"M 553.2,238.1 L 551.0,234.2\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-4 atom-4 atom-5\" d=\"M 551.0,229.4 L 553.2,225.6\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-4 atom-4 atom-5\" d=\"M 553.2,225.6 L 555.4,221.7\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-7 atom-4 atom-8\" d=\"M 547.7,231.8 L 542.8,231.8\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-7 atom-4 atom-8\" d=\"M 542.8,231.8 L 537.9,231.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-5 atom-5 atom-6\" d=\"M 555.4,221.7 L 567.1,221.7\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-6 atom-6 atom-7\" d=\"M 567.1,221.7 L 569.2,217.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-6 atom-6 atom-7\" d=\"M 569.2,217.9 L 571.4,214.2\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-8 atom-8 atom-9\" d=\"M 536.9,231.2 L 534.7,235.1\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-8 atom-8 atom-9\" d=\"M 534.7,235.1 L 532.5,238.9\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-8 atom-8 atom-9\" d=\"M 538.9,232.4 L 536.7,236.2\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-8 atom-8 atom-9\" d=\"M 536.7,236.2 L 534.5,240.1\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-9 atom-8 atom-10\" d=\"M 537.9,231.8 L 535.7,228.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-9 atom-8 atom-10\" d=\"M 535.7,228.0 L 533.5,224.2\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-10 atom-10 atom-11\" d=\"M 530.2,221.7 L 525.3,221.7\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-10 atom-10 atom-11\" d=\"M 525.3,221.7 L 520.5,221.7\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-11 atom-11 atom-12\" d=\"M 520.5,221.7 L 514.6,231.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-11 atom-11 atom-12\" d=\"M 517.6,222.1 L 513.5,229.1\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-17 atom-16 atom-11\" d=\"M 514.6,211.7 L 520.5,221.7\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-12 atom-12 atom-13\" d=\"M 514.6,231.8 L 503.0,231.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-13 atom-13 atom-14\" d=\"M 503.0,231.8 L 497.2,221.7\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-13 atom-13 atom-14\" d=\"M 504.1,229.1 L 500.1,222.1\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-14 atom-14 atom-15\" d=\"M 497.2,221.7 L 503.0,211.7\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-15 atom-15 atom-16\" d=\"M 503.0,211.7 L 514.6,211.7\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-15 atom-15 atom-16\" d=\"M 504.7,214.0 L 512.9,214.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-16 atom-16 atom-17\" d=\"M 514.6,211.7 L 516.8,207.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-16 atom-16 atom-17\" d=\"M 516.8,207.9 L 518.9,204.2\" style=\"fill:none;fill-rule:evenodd;stroke:#00CC00;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"atom-1\" d=\"M 570.9 252.0 Q 570.9 251.0, 571.4 250.4 Q 571.9 249.9, 572.9 249.9 Q 573.8 249.9, 574.3 250.4 Q 574.8 251.0, 574.8 252.0 Q 574.8 253.0, 574.3 253.6 Q 573.8 254.2, 572.9 254.2 Q 571.9 254.2, 571.4 253.6 Q 570.9 253.1, 570.9 252.0 M 572.9 253.7 Q 573.5 253.7, 573.9 253.3 Q 574.2 252.9, 574.2 252.0 Q 574.2 251.2, 573.9 250.8 Q 573.5 250.3, 572.9 250.3 Q 572.2 250.3, 571.9 250.8 Q 571.5 251.2, 571.5 252.0 Q 571.5 252.9, 571.9 253.3 Q 572.2 253.7, 572.9 253.7 \" fill=\"#FF0000\"/>\n<path class=\"atom-4\" d=\"M 548.6 229.7 L 550.0 232.0 Q 550.2 232.2, 550.4 232.6 Q 550.6 233.0, 550.6 233.0 L 550.6 229.7 L 551.2 229.7 L 551.2 234.0 L 550.6 234.0 L 549.1 231.5 Q 548.9 231.2, 548.8 230.9 Q 548.6 230.5, 548.5 230.4 L 548.5 234.0 L 548.0 234.0 L 548.0 229.7 L 548.6 229.7 \" fill=\"#0000FF\"/>\n<path class=\"atom-7\" d=\"M 570.9 211.7 Q 570.9 210.6, 571.4 210.1 Q 571.9 209.5, 572.9 209.5 Q 573.8 209.5, 574.3 210.1 Q 574.8 210.6, 574.8 211.7 Q 574.8 212.7, 574.3 213.3 Q 573.8 213.9, 572.9 213.9 Q 571.9 213.9, 571.4 213.3 Q 570.9 212.7, 570.9 211.7 M 572.9 213.4 Q 573.5 213.4, 573.9 213.0 Q 574.2 212.5, 574.2 211.7 Q 574.2 210.8, 573.9 210.4 Q 573.5 210.0, 572.9 210.0 Q 572.2 210.0, 571.9 210.4 Q 571.5 210.8, 571.5 211.7 Q 571.5 212.5, 571.9 213.0 Q 572.2 213.4, 572.9 213.4 \" fill=\"#FF0000\"/>\n<path class=\"atom-7\" d=\"M 575.3 209.6 L 575.9 209.6 L 575.9 211.4 L 578.1 211.4 L 578.1 209.6 L 578.7 209.6 L 578.7 213.8 L 578.1 213.8 L 578.1 211.8 L 575.9 211.8 L 575.9 213.8 L 575.3 213.8 L 575.3 209.6 \" fill=\"#FF0000\"/>\n<path class=\"atom-9\" d=\"M 530.2 241.9 Q 530.2 240.9, 530.7 240.3 Q 531.2 239.8, 532.1 239.8 Q 533.1 239.8, 533.6 240.3 Q 534.1 240.9, 534.1 241.9 Q 534.1 243.0, 533.5 243.5 Q 533.0 244.1, 532.1 244.1 Q 531.2 244.1, 530.7 243.5 Q 530.2 243.0, 530.2 241.9 M 532.1 243.6 Q 532.8 243.6, 533.1 243.2 Q 533.5 242.8, 533.5 241.9 Q 533.5 241.1, 533.1 240.7 Q 532.8 240.2, 532.1 240.2 Q 531.5 240.2, 531.1 240.7 Q 530.8 241.1, 530.8 241.9 Q 530.8 242.8, 531.1 243.2 Q 531.5 243.6, 532.1 243.6 \" fill=\"#FF0000\"/>\n<path class=\"atom-10\" d=\"M 531.2 219.6 L 532.6 221.9 Q 532.7 222.1, 532.9 222.5 Q 533.1 222.9, 533.2 222.9 L 533.2 219.6 L 533.7 219.6 L 533.7 223.9 L 533.1 223.9 L 531.6 221.4 Q 531.5 221.1, 531.3 220.8 Q 531.1 220.5, 531.1 220.4 L 531.1 223.9 L 530.5 223.9 L 530.5 219.6 L 531.2 219.6 \" fill=\"#0000FF\"/>\n<path class=\"atom-10\" d=\"M 534.2 219.6 L 534.8 219.6 L 534.8 221.4 L 537.0 221.4 L 537.0 219.6 L 537.6 219.6 L 537.6 223.9 L 537.0 223.9 L 537.0 221.9 L 534.8 221.9 L 534.8 223.9 L 534.2 223.9 L 534.2 219.6 \" fill=\"#0000FF\"/>\n<path class=\"atom-17\" d=\"M 518.8 201.7 Q 518.8 200.7, 519.3 200.1 Q 519.8 199.5, 520.8 199.5 Q 521.6 199.5, 522.1 200.2 L 521.7 200.5 Q 521.4 200.0, 520.8 200.0 Q 520.1 200.0, 519.8 200.5 Q 519.4 200.9, 519.4 201.7 Q 519.4 202.6, 519.8 203.0 Q 520.1 203.4, 520.8 203.4 Q 521.3 203.4, 521.8 203.1 L 522.0 203.6 Q 521.8 203.7, 521.4 203.8 Q 521.1 203.9, 520.7 203.9 Q 519.8 203.9, 519.3 203.3 Q 518.8 202.8, 518.8 201.7 \" fill=\"#00CC00\"/>\n<path class=\"atom-17\" d=\"M 522.6 199.3 L 523.2 199.3 L 523.2 203.8 L 522.6 203.8 L 522.6 199.3 \" fill=\"#00CC00\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 609.8,223.7 L 613.9,226.1\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 613.9,226.1 L 618.0,228.5\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 608.7,225.8 L 612.2,227.8\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 612.2,227.8 L 615.6,229.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 611.0,221.7 L 614.5,223.7\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 614.5,223.7 L 618.0,225.7\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-1 atom-1 atom-2\" d=\"M 618.0,228.5 L 628.1,234.3\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-2 atom-2 atom-3\" d=\"M 628.1,234.3 L 638.2,228.5\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-2 atom-2 atom-3\" d=\"M 630.8,235.4 L 637.9,231.4\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-23 atom-23 atom-2\" d=\"M 628.1,245.9 L 628.1,234.3\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-3 atom-3 atom-4\" d=\"M 638.2,228.5 L 648.3,234.3\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-4 atom-4 atom-5\" d=\"M 648.3,234.3 L 652.4,231.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-4 atom-4 atom-5\" d=\"M 652.4,231.9 L 656.5,229.6\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-20 atom-4 atom-21\" d=\"M 648.3,234.3 L 648.3,245.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-20 atom-4 atom-21\" d=\"M 646.0,236.0 L 646.0,244.2\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-5 atom-5 atom-6\" d=\"M 660.3,229.6 L 664.4,231.9\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-5 atom-5 atom-6\" d=\"M 664.4,231.9 L 668.5,234.3\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-6 atom-6 atom-7\" d=\"M 667.3,234.3 L 667.3,238.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-6 atom-6 atom-7\" d=\"M 667.3,238.9 L 667.3,243.5\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-6 atom-6 atom-7\" d=\"M 669.6,234.3 L 669.6,238.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-6 atom-6 atom-7\" d=\"M 669.6,238.9 L 669.6,243.5\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-7 atom-6 atom-8\" d=\"M 668.5,234.3 L 672.6,231.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-7 atom-6 atom-8\" d=\"M 672.6,231.9 L 676.7,229.6\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-8 atom-8 atom-9\" d=\"M 678.6,226.0 L 678.6,221.4\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-8 atom-8 atom-9\" d=\"M 678.6,221.4 L 678.6,216.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-24 atom-20 atom-8\" d=\"M 688.6,234.3 L 684.5,231.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-24 atom-20 atom-8\" d=\"M 684.5,231.9 L 680.5,229.6\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-9 atom-9 atom-10\" d=\"M 678.6,216.8 L 688.6,211.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-10 atom-10 atom-11\" d=\"M 688.6,211.0 L 698.7,216.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-11 atom-11 atom-12\" d=\"M 698.7,216.8 L 708.8,211.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-18 atom-11 atom-19\" d=\"M 698.7,216.8 L 698.7,228.5\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-12 atom-12 atom-13\" d=\"M 708.8,211.0 L 712.9,213.4\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-12 atom-12 atom-13\" d=\"M 712.9,213.4 L 717.0,215.7\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-13 atom-13 atom-14\" d=\"M 718.9,219.2 L 718.9,223.8\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-13 atom-13 atom-14\" d=\"M 718.9,223.8 L 718.9,228.5\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-25 atom-18 atom-13\" d=\"M 729.0,211.0 L 724.9,213.4\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-25 atom-18 atom-13\" d=\"M 724.9,213.4 L 720.8,215.7\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-14 atom-14 atom-15\" d=\"M 718.9,228.5 L 729.0,234.3\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-15 atom-15 atom-16\" d=\"M 729.0,234.3 L 732.9,232.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-15 atom-15 atom-16\" d=\"M 732.9,232.0 L 736.8,229.8\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-16 atom-16 atom-17\" d=\"M 739.1,226.0 L 739.1,221.4\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-16 atom-16 atom-17\" d=\"M 739.1,221.4 L 739.1,216.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-17 atom-17 atom-18\" d=\"M 739.1,216.8 L 729.0,211.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-19 atom-19 atom-20\" d=\"M 698.7,228.5 L 688.6,234.3\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-21 atom-21 atom-22\" d=\"M 648.3,245.9 L 638.2,251.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-22 atom-22 atom-23\" d=\"M 638.2,251.8 L 628.1,245.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-22 atom-22 atom-23\" d=\"M 637.9,248.9 L 630.8,244.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"atom-0\" d=\"M 607.0 220.5 L 608.4 222.8 Q 608.5 223.0, 608.8 223.4 Q 609.0 223.8, 609.0 223.8 L 609.0 220.5 L 609.6 220.5 L 609.6 224.8 L 609.0 224.8 L 607.5 222.3 Q 607.3 222.0, 607.1 221.7 Q 606.9 221.4, 606.9 221.3 L 606.9 224.8 L 606.3 224.8 L 606.3 220.5 L 607.0 220.5 \" fill=\"#0000FF\"/>\n<path class=\"atom-5\" d=\"M 657.4 226.3 L 658.8 228.6 Q 659.0 228.8, 659.2 229.2 Q 659.4 229.6, 659.4 229.6 L 659.4 226.3 L 660.0 226.3 L 660.0 230.6 L 659.4 230.6 L 657.9 228.1 Q 657.7 227.8, 657.6 227.5 Q 657.4 227.2, 657.3 227.1 L 657.3 230.6 L 656.8 230.6 L 656.8 226.3 L 657.4 226.3 \" fill=\"#0000FF\"/>\n<path class=\"atom-5\" d=\"M 656.7 221.7 L 657.3 221.7 L 657.3 223.5 L 659.5 223.5 L 659.5 221.7 L 660.0 221.7 L 660.0 225.9 L 659.5 225.9 L 659.5 223.9 L 657.3 223.9 L 657.3 225.9 L 656.7 225.9 L 656.7 221.7 \" fill=\"#0000FF\"/>\n<path class=\"atom-7\" d=\"M 666.5 245.9 Q 666.5 244.9, 667.0 244.4 Q 667.5 243.8, 668.5 243.8 Q 669.4 243.8, 669.9 244.4 Q 670.4 244.9, 670.4 245.9 Q 670.4 247.0, 669.9 247.6 Q 669.4 248.1, 668.5 248.1 Q 667.5 248.1, 667.0 247.6 Q 666.5 247.0, 666.5 245.9 M 668.5 247.7 Q 669.1 247.7, 669.5 247.2 Q 669.8 246.8, 669.8 245.9 Q 669.8 245.1, 669.5 244.7 Q 669.1 244.3, 668.5 244.3 Q 667.8 244.3, 667.5 244.7 Q 667.1 245.1, 667.1 245.9 Q 667.1 246.8, 667.5 247.2 Q 667.8 247.7, 668.5 247.7 \" fill=\"#FF0000\"/>\n<path class=\"atom-8\" d=\"M 677.6 226.3 L 679.0 228.6 Q 679.1 228.8, 679.4 229.2 Q 679.6 229.6, 679.6 229.6 L 679.6 226.3 L 680.2 226.3 L 680.2 230.6 L 679.6 230.6 L 678.1 228.1 Q 677.9 227.8, 677.7 227.5 Q 677.5 227.2, 677.5 227.1 L 677.5 230.6 L 676.9 230.6 L 676.9 226.3 L 677.6 226.3 \" fill=\"#0000FF\"/>\n<path class=\"atom-13\" d=\"M 718.0 214.7 L 719.4 216.9 Q 719.5 217.2, 719.7 217.6 Q 719.9 218.0, 719.9 218.0 L 719.9 214.7 L 720.5 214.7 L 720.5 218.9 L 719.9 218.9 L 718.4 216.5 Q 718.3 216.2, 718.1 215.9 Q 717.9 215.5, 717.8 215.4 L 717.8 218.9 L 717.3 218.9 L 717.3 214.7 L 718.0 214.7 \" fill=\"#0000FF\"/>\n<path class=\"atom-16\" d=\"M 737.1 228.5 Q 737.1 227.5, 737.6 226.9 Q 738.1 226.3, 739.1 226.3 Q 740.0 226.3, 740.5 226.9 Q 741.0 227.5, 741.0 228.5 Q 741.0 229.5, 740.5 230.1 Q 740.0 230.7, 739.1 230.7 Q 738.1 230.7, 737.6 230.1 Q 737.1 229.5, 737.1 228.5 M 739.1 230.2 Q 739.7 230.2, 740.1 229.8 Q 740.4 229.3, 740.4 228.5 Q 740.4 227.6, 740.1 227.2 Q 739.7 226.8, 739.1 226.8 Q 738.4 226.8, 738.1 227.2 Q 737.7 227.6, 737.7 228.5 Q 737.7 229.3, 738.1 229.8 Q 738.4 230.2, 739.1 230.2 \" fill=\"#FF0000\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 68.0,361.7 L 72.9,361.7\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 72.9,361.7 L 77.8,361.7\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-1 atom-1 atom-2\" d=\"M 81.1,359.2 L 83.3,355.4\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-1 atom-1 atom-2\" d=\"M 83.3,355.4 L 85.5,351.6\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-2 atom-1 atom-3\" d=\"M 81.1,364.1 L 83.3,367.9\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-2 atom-1 atom-3\" d=\"M 83.3,367.9 L 85.5,371.7\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-3 atom-3 atom-4\" d=\"M 85.5,371.7 L 97.2,371.7\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-4 atom-4 atom-5\" d=\"M 97.2,371.7 L 103.0,381.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-20 atom-20 atom-4\" d=\"M 103.0,361.7 L 97.2,371.7\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-5 atom-5 atom-6\" d=\"M 103.0,381.8 L 114.6,381.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-6 atom-6 atom-7\" d=\"M 114.6,381.8 L 116.9,378.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-6 atom-6 atom-7\" d=\"M 116.9,378.0 L 119.1,374.2\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-7 atom-7 atom-8\" d=\"M 122.4,371.7 L 127.2,371.7\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-7 atom-7 atom-8\" d=\"M 127.2,371.7 L 132.1,371.7\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-18 atom-7 atom-19\" d=\"M 119.1,369.3 L 116.9,365.5\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-18 atom-7 atom-19\" d=\"M 116.9,365.5 L 114.6,361.7\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-8 atom-8 atom-9\" d=\"M 133.1,372.3 L 135.3,368.5\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-8 atom-8 atom-9\" d=\"M 135.3,368.5 L 137.5,364.7\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-8 atom-8 atom-9\" d=\"M 131.1,371.2 L 133.3,367.4\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-8 atom-8 atom-9\" d=\"M 133.3,367.4 L 135.5,363.6\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-9 atom-8 atom-10\" d=\"M 132.1,371.7 L 134.3,375.6\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-9 atom-8 atom-10\" d=\"M 134.3,375.6 L 136.5,379.4\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-10 atom-10 atom-11\" d=\"M 139.8,381.8 L 144.7,381.8\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-10 atom-10 atom-11\" d=\"M 144.7,381.8 L 149.6,381.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-11 atom-11 atom-12\" d=\"M 149.6,381.8 L 155.4,391.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-11 atom-11 atom-12\" d=\"M 152.5,382.2 L 156.5,389.2\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-21 atom-18 atom-11\" d=\"M 155.4,371.7 L 149.6,381.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-12 atom-12 atom-13\" d=\"M 155.4,391.9 L 167.1,391.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-13 atom-13 atom-14\" d=\"M 167.1,391.9 L 172.9,381.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-13 atom-13 atom-14\" d=\"M 165.9,389.2 L 170.0,382.2\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-14 atom-14 atom-15\" d=\"M 172.9,381.8 L 177.7,381.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-14 atom-14 atom-15\" d=\"M 177.7,381.8 L 182.6,381.8\" style=\"fill:none;fill-rule:evenodd;stroke:#00CC00;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-15 atom-14 atom-16\" d=\"M 172.9,381.8 L 167.1,371.7\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-16 atom-16 atom-17\" d=\"M 167.1,371.7 L 169.2,368.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-16 atom-16 atom-17\" d=\"M 169.2,368.0 L 171.4,364.3\" style=\"fill:none;fill-rule:evenodd;stroke:#00CC00;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-17 atom-16 atom-18\" d=\"M 167.1,371.7 L 155.4,371.7\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-17 atom-16 atom-18\" d=\"M 165.3,374.1 L 157.2,374.1\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-19 atom-19 atom-20\" d=\"M 114.6,361.7 L 103.0,361.7\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"atom-1\" d=\"M 78.8 359.5 L 80.1 361.8 Q 80.3 362.0, 80.5 362.4 Q 80.7 362.8, 80.7 362.8 L 80.7 359.5 L 81.3 359.5 L 81.3 363.8 L 80.7 363.8 L 79.2 361.3 Q 79.1 361.0, 78.9 360.7 Q 78.7 360.4, 78.6 360.3 L 78.6 363.8 L 78.1 363.8 L 78.1 359.5 L 78.8 359.5 \" fill=\"#0000FF\"/>\n<path class=\"atom-7\" d=\"M 119.5 369.6 L 120.9 371.9 Q 121.1 372.1, 121.3 372.5 Q 121.5 372.9, 121.5 372.9 L 121.5 369.6 L 122.1 369.6 L 122.1 373.9 L 121.5 373.9 L 120.0 371.4 Q 119.8 371.1, 119.6 370.8 Q 119.5 370.5, 119.4 370.4 L 119.4 373.9 L 118.9 373.9 L 118.9 369.6 L 119.5 369.6 \" fill=\"#0000FF\"/>\n<path class=\"atom-9\" d=\"M 136.0 361.7 Q 136.0 360.6, 136.5 360.1 Q 137.0 359.5, 137.9 359.5 Q 138.9 359.5, 139.4 360.1 Q 139.9 360.6, 139.9 361.7 Q 139.9 362.7, 139.4 363.3 Q 138.9 363.9, 137.9 363.9 Q 137.0 363.9, 136.5 363.3 Q 136.0 362.7, 136.0 361.7 M 137.9 363.4 Q 138.6 363.4, 138.9 363.0 Q 139.3 362.5, 139.3 361.7 Q 139.3 360.8, 138.9 360.4 Q 138.6 360.0, 137.9 360.0 Q 137.3 360.0, 136.9 360.4 Q 136.6 360.8, 136.6 361.7 Q 136.6 362.5, 136.9 363.0 Q 137.3 363.4, 137.9 363.4 \" fill=\"#FF0000\"/>\n<path class=\"atom-10\" d=\"M 132.5 379.7 L 133.1 379.7 L 133.1 381.5 L 135.2 381.5 L 135.2 379.7 L 135.8 379.7 L 135.8 384.0 L 135.2 384.0 L 135.2 382.0 L 133.1 382.0 L 133.1 384.0 L 132.5 384.0 L 132.5 379.7 \" fill=\"#0000FF\"/>\n<path class=\"atom-10\" d=\"M 137.0 379.7 L 138.4 382.0 Q 138.5 382.2, 138.7 382.6 Q 139.0 383.0, 139.0 383.0 L 139.0 379.7 L 139.5 379.7 L 139.5 384.0 L 139.0 384.0 L 137.5 381.5 Q 137.3 381.2, 137.1 380.9 Q 136.9 380.5, 136.9 380.4 L 136.9 384.0 L 136.3 384.0 L 136.3 379.7 L 137.0 379.7 \" fill=\"#0000FF\"/>\n<path class=\"atom-15\" d=\"M 182.9 382.0 Q 182.9 380.9, 183.4 380.4 Q 183.9 379.8, 184.8 379.8 Q 185.7 379.8, 186.2 380.4 L 185.8 380.8 Q 185.4 380.3, 184.8 380.3 Q 184.2 380.3, 183.8 380.7 Q 183.5 381.2, 183.5 382.0 Q 183.5 382.8, 183.8 383.2 Q 184.2 383.7, 184.9 383.7 Q 185.4 383.7, 185.9 383.4 L 186.1 383.8 Q 185.8 384.0, 185.5 384.1 Q 185.2 384.2, 184.8 384.2 Q 183.9 384.2, 183.4 383.6 Q 182.9 383.0, 182.9 382.0 \" fill=\"#00CC00\"/>\n<path class=\"atom-15\" d=\"M 186.7 379.6 L 187.2 379.6 L 187.2 384.1 L 186.7 384.1 L 186.7 379.6 \" fill=\"#00CC00\"/>\n<path class=\"atom-17\" d=\"M 171.2 361.8 Q 171.2 360.7, 171.7 360.2 Q 172.2 359.6, 173.2 359.6 Q 174.0 359.6, 174.5 360.3 L 174.1 360.6 Q 173.8 360.1, 173.2 360.1 Q 172.5 360.1, 172.2 360.6 Q 171.8 361.0, 171.8 361.8 Q 171.8 362.6, 172.2 363.1 Q 172.6 363.5, 173.2 363.5 Q 173.7 363.5, 174.2 363.2 L 174.4 363.7 Q 174.2 363.8, 173.9 363.9 Q 173.5 364.0, 173.2 364.0 Q 172.2 364.0, 171.7 363.4 Q 171.2 362.9, 171.2 361.8 \" fill=\"#00CC00\"/>\n<path class=\"atom-17\" d=\"M 175.0 359.4 L 175.6 359.4 L 175.6 363.9 L 175.0 363.9 L 175.0 359.4 \" fill=\"#00CC00\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 228.1,419.2 L 232.0,417.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 232.0,417.0 L 236.0,414.7\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-1 atom-1 atom-2\" d=\"M 238.2,411.0 L 238.2,406.4\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-1 atom-1 atom-2\" d=\"M 238.2,406.4 L 238.2,401.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-2 atom-2 atom-3\" d=\"M 238.2,401.8 L 228.1,395.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-2 atom-2 atom-3\" d=\"M 237.9,398.9 L 230.8,394.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-23 atom-23 atom-2\" d=\"M 248.3,395.9 L 238.2,401.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-3 atom-3 atom-4\" d=\"M 228.1,395.9 L 228.1,384.3\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-4 atom-4 atom-5\" d=\"M 228.1,384.3 L 238.2,378.5\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-4 atom-4 atom-5\" d=\"M 230.8,385.4 L 237.9,381.4\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-5 atom-5 atom-6\" d=\"M 238.2,378.5 L 248.3,384.3\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-6 atom-6 atom-7\" d=\"M 248.3,384.3 L 252.4,381.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-6 atom-6 atom-7\" d=\"M 252.4,381.9 L 256.5,379.6\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-22 atom-6 atom-23\" d=\"M 248.3,384.3 L 248.3,395.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-22 atom-6 atom-23\" d=\"M 246.0,386.0 L 246.0,394.2\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-7 atom-7 atom-8\" d=\"M 260.3,379.6 L 264.4,381.9\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-7 atom-7 atom-8\" d=\"M 264.4,381.9 L 268.5,384.3\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-8 atom-8 atom-9\" d=\"M 267.3,384.3 L 267.3,388.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-8 atom-8 atom-9\" d=\"M 267.3,388.9 L 267.3,393.5\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-8 atom-8 atom-9\" d=\"M 269.6,384.3 L 269.6,388.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-8 atom-8 atom-9\" d=\"M 269.6,388.9 L 269.6,393.5\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-9 atom-8 atom-10\" d=\"M 268.5,384.3 L 272.6,381.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-9 atom-8 atom-10\" d=\"M 272.6,381.9 L 276.7,379.6\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-10 atom-10 atom-11\" d=\"M 278.6,376.0 L 278.6,371.4\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-10 atom-10 atom-11\" d=\"M 278.6,371.4 L 278.6,366.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-24 atom-22 atom-10\" d=\"M 288.6,384.3 L 284.5,381.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-24 atom-22 atom-10\" d=\"M 284.5,381.9 L 280.5,379.6\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-11 atom-11 atom-12\" d=\"M 278.6,366.8 L 288.6,361.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-12 atom-12 atom-13\" d=\"M 288.6,361.0 L 298.7,366.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-13 atom-13 atom-14\" d=\"M 298.7,366.8 L 308.8,361.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-20 atom-13 atom-21\" d=\"M 298.7,366.8 L 298.7,378.5\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-14 atom-14 atom-15\" d=\"M 308.8,361.0 L 312.9,363.4\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-14 atom-14 atom-15\" d=\"M 312.9,363.4 L 317.0,365.7\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-15 atom-15 atom-16\" d=\"M 318.9,369.2 L 318.9,373.8\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-15 atom-15 atom-16\" d=\"M 318.9,373.8 L 318.9,378.5\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-25 atom-20 atom-15\" d=\"M 329.0,361.0 L 324.9,363.4\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-25 atom-20 atom-15\" d=\"M 324.9,363.4 L 320.8,365.7\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-16 atom-16 atom-17\" d=\"M 318.9,378.5 L 329.0,384.3\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-17 atom-17 atom-18\" d=\"M 329.0,384.3 L 332.9,382.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-17 atom-17 atom-18\" d=\"M 332.9,382.0 L 336.8,379.8\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-18 atom-18 atom-19\" d=\"M 339.1,376.0 L 339.1,371.4\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-18 atom-18 atom-19\" d=\"M 339.1,371.4 L 339.1,366.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-19 atom-19 atom-20\" d=\"M 339.1,366.8 L 329.0,361.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-21 atom-21 atom-22\" d=\"M 298.7,378.5 L 288.6,384.3\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"atom-1\" d=\"M 236.3 413.4 Q 236.3 412.4, 236.8 411.8 Q 237.3 411.3, 238.2 411.3 Q 239.1 411.3, 239.7 411.8 Q 240.2 412.4, 240.2 413.4 Q 240.2 414.4, 239.6 415.0 Q 239.1 415.6, 238.2 415.6 Q 237.3 415.6, 236.8 415.0 Q 236.3 414.5, 236.3 413.4 M 238.2 415.1 Q 238.9 415.1, 239.2 414.7 Q 239.6 414.3, 239.6 413.4 Q 239.6 412.6, 239.2 412.2 Q 238.9 411.7, 238.2 411.7 Q 237.6 411.7, 237.2 412.2 Q 236.9 412.6, 236.9 413.4 Q 236.9 414.3, 237.2 414.7 Q 237.6 415.1, 238.2 415.1 \" fill=\"#FF0000\"/>\n<path class=\"atom-7\" d=\"M 257.4 376.3 L 258.8 378.6 Q 259.0 378.8, 259.2 379.2 Q 259.4 379.6, 259.4 379.6 L 259.4 376.3 L 260.0 376.3 L 260.0 380.6 L 259.4 380.6 L 257.9 378.1 Q 257.7 377.8, 257.6 377.5 Q 257.4 377.2, 257.3 377.1 L 257.3 380.6 L 256.8 380.6 L 256.8 376.3 L 257.4 376.3 \" fill=\"#0000FF\"/>\n<path class=\"atom-7\" d=\"M 256.7 371.7 L 257.3 371.7 L 257.3 373.5 L 259.5 373.5 L 259.5 371.7 L 260.0 371.7 L 260.0 375.9 L 259.5 375.9 L 259.5 373.9 L 257.3 373.9 L 257.3 375.9 L 256.7 375.9 L 256.7 371.7 \" fill=\"#0000FF\"/>\n<path class=\"atom-9\" d=\"M 266.5 395.9 Q 266.5 394.9, 267.0 394.4 Q 267.5 393.8, 268.5 393.8 Q 269.4 393.8, 269.9 394.4 Q 270.4 394.9, 270.4 395.9 Q 270.4 397.0, 269.9 397.6 Q 269.4 398.1, 268.5 398.1 Q 267.5 398.1, 267.0 397.6 Q 266.5 397.0, 266.5 395.9 M 268.5 397.7 Q 269.1 397.7, 269.5 397.2 Q 269.8 396.8, 269.8 395.9 Q 269.8 395.1, 269.5 394.7 Q 269.1 394.3, 268.5 394.3 Q 267.8 394.3, 267.5 394.7 Q 267.1 395.1, 267.1 395.9 Q 267.1 396.8, 267.5 397.2 Q 267.8 397.7, 268.5 397.7 \" fill=\"#FF0000\"/>\n<path class=\"atom-10\" d=\"M 277.6 376.3 L 279.0 378.6 Q 279.1 378.8, 279.4 379.2 Q 279.6 379.6, 279.6 379.6 L 279.6 376.3 L 280.2 376.3 L 280.2 380.6 L 279.6 380.6 L 278.1 378.1 Q 277.9 377.8, 277.7 377.5 Q 277.5 377.2, 277.5 377.1 L 277.5 380.6 L 276.9 380.6 L 276.9 376.3 L 277.6 376.3 \" fill=\"#0000FF\"/>\n<path class=\"atom-15\" d=\"M 318.0 364.7 L 319.4 366.9 Q 319.5 367.2, 319.7 367.6 Q 319.9 368.0, 319.9 368.0 L 319.9 364.7 L 320.5 364.7 L 320.5 368.9 L 319.9 368.9 L 318.4 366.5 Q 318.3 366.2, 318.1 365.9 Q 317.9 365.5, 317.8 365.4 L 317.8 368.9 L 317.3 368.9 L 317.3 364.7 L 318.0 364.7 \" fill=\"#0000FF\"/>\n<path class=\"atom-18\" d=\"M 337.1 378.5 Q 337.1 377.5, 337.6 376.9 Q 338.1 376.3, 339.1 376.3 Q 340.0 376.3, 340.5 376.9 Q 341.0 377.5, 341.0 378.5 Q 341.0 379.5, 340.5 380.1 Q 340.0 380.7, 339.1 380.7 Q 338.1 380.7, 337.6 380.1 Q 337.1 379.5, 337.1 378.5 M 339.1 380.2 Q 339.7 380.2, 340.1 379.8 Q 340.4 379.3, 340.4 378.5 Q 340.4 377.6, 340.1 377.2 Q 339.7 376.8, 339.1 376.8 Q 338.4 376.8, 338.1 377.2 Q 337.7 377.6, 337.7 378.5 Q 337.7 379.3, 338.1 379.8 Q 338.4 380.2, 339.1 380.2 \" fill=\"#FF0000\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 418.0,401.8 L 428.1,395.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-1 atom-1 atom-2\" d=\"M 428.1,395.9 L 428.1,384.3\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-1 atom-1 atom-2\" d=\"M 430.4,394.2 L 430.4,386.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-23 atom-22 atom-1\" d=\"M 438.2,401.8 L 428.1,395.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-2 atom-2 atom-3\" d=\"M 428.1,384.3 L 438.2,378.5\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-3 atom-3 atom-4\" d=\"M 438.2,378.5 L 448.3,384.3\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-3 atom-3 atom-4\" d=\"M 438.6,381.4 L 445.6,385.4\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-4 atom-4 atom-5\" d=\"M 448.3,384.3 L 452.4,381.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-4 atom-4 atom-5\" d=\"M 452.4,381.9 L 456.5,379.6\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-20 atom-4 atom-21\" d=\"M 448.3,384.3 L 448.3,395.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-5 atom-5 atom-6\" d=\"M 460.3,379.6 L 464.4,381.9\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-5 atom-5 atom-6\" d=\"M 464.4,381.9 L 468.5,384.3\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-6 atom-6 atom-7\" d=\"M 467.3,384.3 L 467.3,388.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-6 atom-6 atom-7\" d=\"M 467.3,388.9 L 467.3,393.5\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-6 atom-6 atom-7\" d=\"M 469.6,384.3 L 469.6,388.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-6 atom-6 atom-7\" d=\"M 469.6,388.9 L 469.6,393.5\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-7 atom-6 atom-8\" d=\"M 468.5,384.3 L 472.6,381.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-7 atom-6 atom-8\" d=\"M 472.6,381.9 L 476.7,379.6\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-8 atom-8 atom-9\" d=\"M 478.6,376.0 L 478.6,371.4\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-8 atom-8 atom-9\" d=\"M 478.6,371.4 L 478.6,366.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-24 atom-20 atom-8\" d=\"M 488.6,384.3 L 484.5,381.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-24 atom-20 atom-8\" d=\"M 484.5,381.9 L 480.5,379.6\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-9 atom-9 atom-10\" d=\"M 478.6,366.8 L 488.6,361.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-10 atom-10 atom-11\" d=\"M 488.6,361.0 L 498.7,366.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-11 atom-11 atom-12\" d=\"M 498.7,366.8 L 508.8,361.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-18 atom-11 atom-19\" d=\"M 498.7,366.8 L 498.7,378.5\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-12 atom-12 atom-13\" d=\"M 508.8,361.0 L 512.9,363.4\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-12 atom-12 atom-13\" d=\"M 512.9,363.4 L 517.0,365.7\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-13 atom-13 atom-14\" d=\"M 518.9,369.2 L 518.9,373.8\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-13 atom-13 atom-14\" d=\"M 518.9,373.8 L 518.9,378.5\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-25 atom-18 atom-13\" d=\"M 529.0,361.0 L 524.9,363.4\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-25 atom-18 atom-13\" d=\"M 524.9,363.4 L 520.8,365.7\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-14 atom-14 atom-15\" d=\"M 518.9,378.5 L 529.0,384.3\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-15 atom-15 atom-16\" d=\"M 529.0,384.3 L 532.9,382.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-15 atom-15 atom-16\" d=\"M 532.9,382.0 L 536.8,379.8\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-16 atom-16 atom-17\" d=\"M 539.1,376.0 L 539.1,371.4\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-16 atom-16 atom-17\" d=\"M 539.1,371.4 L 539.1,366.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-17 atom-17 atom-18\" d=\"M 539.1,366.8 L 529.0,361.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-19 atom-19 atom-20\" d=\"M 498.7,378.5 L 488.6,384.3\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-21 atom-21 atom-22\" d=\"M 448.3,395.9 L 438.2,401.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-21 atom-21 atom-22\" d=\"M 445.6,394.8 L 438.6,398.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-22 atom-22 atom-23\" d=\"M 438.2,401.8 L 438.2,406.4\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-22 atom-22 atom-23\" d=\"M 438.2,406.4 L 438.2,411.0\" style=\"fill:none;fill-rule:evenodd;stroke:#33CCCC;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"atom-5\" d=\"M 457.4 376.3 L 458.8 378.6 Q 459.0 378.8, 459.2 379.2 Q 459.4 379.6, 459.4 379.6 L 459.4 376.3 L 460.0 376.3 L 460.0 380.6 L 459.4 380.6 L 457.9 378.1 Q 457.7 377.8, 457.6 377.5 Q 457.4 377.2, 457.3 377.1 L 457.3 380.6 L 456.8 380.6 L 456.8 376.3 L 457.4 376.3 \" fill=\"#0000FF\"/>\n<path class=\"atom-5\" d=\"M 456.7 371.7 L 457.3 371.7 L 457.3 373.5 L 459.5 373.5 L 459.5 371.7 L 460.0 371.7 L 460.0 375.9 L 459.5 375.9 L 459.5 373.9 L 457.3 373.9 L 457.3 375.9 L 456.7 375.9 L 456.7 371.7 \" fill=\"#0000FF\"/>\n<path class=\"atom-7\" d=\"M 466.5 395.9 Q 466.5 394.9, 467.0 394.4 Q 467.5 393.8, 468.5 393.8 Q 469.4 393.8, 469.9 394.4 Q 470.4 394.9, 470.4 395.9 Q 470.4 397.0, 469.9 397.6 Q 469.4 398.1, 468.5 398.1 Q 467.5 398.1, 467.0 397.6 Q 466.5 397.0, 466.5 395.9 M 468.5 397.7 Q 469.1 397.7, 469.5 397.2 Q 469.8 396.8, 469.8 395.9 Q 469.8 395.1, 469.5 394.7 Q 469.1 394.3, 468.5 394.3 Q 467.8 394.3, 467.5 394.7 Q 467.1 395.1, 467.1 395.9 Q 467.1 396.8, 467.5 397.2 Q 467.8 397.7, 468.5 397.7 \" fill=\"#FF0000\"/>\n<path class=\"atom-8\" d=\"M 477.6 376.3 L 479.0 378.6 Q 479.1 378.8, 479.4 379.2 Q 479.6 379.6, 479.6 379.6 L 479.6 376.3 L 480.2 376.3 L 480.2 380.6 L 479.6 380.6 L 478.1 378.1 Q 477.9 377.8, 477.7 377.5 Q 477.5 377.2, 477.5 377.1 L 477.5 380.6 L 476.9 380.6 L 476.9 376.3 L 477.6 376.3 \" fill=\"#0000FF\"/>\n<path class=\"atom-13\" d=\"M 518.0 364.7 L 519.4 366.9 Q 519.5 367.2, 519.7 367.6 Q 519.9 368.0, 519.9 368.0 L 519.9 364.7 L 520.5 364.7 L 520.5 368.9 L 519.9 368.9 L 518.4 366.5 Q 518.3 366.2, 518.1 365.9 Q 517.9 365.5, 517.8 365.4 L 517.8 368.9 L 517.3 368.9 L 517.3 364.7 L 518.0 364.7 \" fill=\"#0000FF\"/>\n<path class=\"atom-16\" d=\"M 537.1 378.5 Q 537.1 377.5, 537.6 376.9 Q 538.1 376.3, 539.1 376.3 Q 540.0 376.3, 540.5 376.9 Q 541.0 377.5, 541.0 378.5 Q 541.0 379.5, 540.5 380.1 Q 540.0 380.7, 539.1 380.7 Q 538.1 380.7, 537.6 380.1 Q 537.1 379.5, 537.1 378.5 M 539.1 380.2 Q 539.7 380.2, 540.1 379.8 Q 540.4 379.3, 540.4 378.5 Q 540.4 377.6, 540.1 377.2 Q 539.7 376.8, 539.1 376.8 Q 538.4 376.8, 538.1 377.2 Q 537.7 377.6, 537.7 378.5 Q 537.7 379.3, 538.1 379.8 Q 538.4 380.2, 539.1 380.2 \" fill=\"#FF0000\"/>\n<path class=\"atom-23\" d=\"M 436.9 411.3 L 439.5 411.3 L 439.5 411.8 L 437.5 411.8 L 437.5 413.1 L 439.3 413.1 L 439.3 413.5 L 437.5 413.5 L 437.5 415.5 L 436.9 415.5 L 436.9 411.3 \" fill=\"#33CCCC\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 732.1,371.7 L 720.5,371.7\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-1 atom-1 atom-2\" d=\"M 720.5,371.7 L 714.6,381.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-1 atom-1 atom-2\" d=\"M 717.6,372.1 L 713.5,379.1\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-20 atom-20 atom-1\" d=\"M 714.6,361.7 L 720.5,371.7\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-2 atom-2 atom-3\" d=\"M 714.6,381.8 L 703.0,381.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-3 atom-3 atom-4\" d=\"M 703.0,381.8 L 697.2,371.7\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-3 atom-3 atom-4\" d=\"M 704.1,379.1 L 700.1,372.1\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-4 atom-4 atom-5\" d=\"M 697.2,371.7 L 692.3,371.7\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-4 atom-4 atom-5\" d=\"M 692.3,371.7 L 687.4,371.7\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-18 atom-4 atom-19\" d=\"M 697.2,371.7 L 703.0,361.7\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-5 atom-5 atom-6\" d=\"M 684.1,369.3 L 681.9,365.5\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-5 atom-5 atom-6\" d=\"M 681.9,365.5 L 679.7,361.7\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-6 atom-6 atom-7\" d=\"M 680.7,362.2 L 682.9,358.4\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-6 atom-6 atom-7\" d=\"M 682.9,358.4 L 685.1,354.7\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-6 atom-6 atom-7\" d=\"M 678.7,361.1 L 680.9,357.3\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-6 atom-6 atom-7\" d=\"M 680.9,357.3 L 683.1,353.5\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-7 atom-6 atom-8\" d=\"M 679.7,361.7 L 674.8,361.7\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-7 atom-6 atom-8\" d=\"M 674.8,361.7 L 670.0,361.7\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-8 atom-8 atom-9\" d=\"M 666.7,359.2 L 664.4,355.4\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-8 atom-8 atom-9\" d=\"M 664.4,355.4 L 662.2,351.6\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-21 atom-18 atom-8\" d=\"M 662.2,371.7 L 664.4,367.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-21 atom-18 atom-8\" d=\"M 664.4,367.9 L 666.7,364.1\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-9 atom-9 atom-10\" d=\"M 662.2,351.6 L 650.6,351.6\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-10 atom-10 atom-11\" d=\"M 650.6,351.6 L 644.8,361.7\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-11 atom-11 atom-12\" d=\"M 644.8,361.7 L 633.1,361.7\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-16 atom-11 atom-17\" d=\"M 644.8,361.7 L 650.6,371.7\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-12 atom-12 atom-13\" d=\"M 632.1,361.1 L 629.9,364.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-12 atom-12 atom-13\" d=\"M 629.9,364.9 L 627.7,368.7\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-12 atom-12 atom-13\" d=\"M 634.1,362.2 L 631.9,366.1\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-12 atom-12 atom-13\" d=\"M 631.9,366.1 L 629.7,369.9\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-13 atom-12 atom-14\" d=\"M 633.1,361.7 L 630.9,357.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-13 atom-12 atom-14\" d=\"M 630.9,357.8 L 628.7,354.0\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-14 atom-14 atom-15\" d=\"M 625.4,351.6 L 620.5,351.6\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-14 atom-14 atom-15\" d=\"M 620.5,351.6 L 615.6,351.6\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-15 atom-14 atom-16\" d=\"M 628.7,349.2 L 630.9,345.3\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-15 atom-14 atom-16\" d=\"M 630.9,345.3 L 633.1,341.5\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-17 atom-17 atom-18\" d=\"M 650.6,371.7 L 662.2,371.7\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-19 atom-19 atom-20\" d=\"M 703.0,361.7 L 714.6,361.7\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-19 atom-19 atom-20\" d=\"M 704.7,364.0 L 712.9,364.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"atom-5\" d=\"M 680.1 369.6 L 680.7 369.6 L 680.7 371.4 L 682.8 371.4 L 682.8 369.6 L 683.4 369.6 L 683.4 373.9 L 682.8 373.9 L 682.8 371.9 L 680.7 371.9 L 680.7 373.9 L 680.1 373.9 L 680.1 369.6 \" fill=\"#0000FF\"/>\n<path class=\"atom-5\" d=\"M 684.6 369.6 L 686.0 371.9 Q 686.1 372.1, 686.3 372.5 Q 686.6 372.9, 686.6 372.9 L 686.6 369.6 L 687.1 369.6 L 687.1 373.9 L 686.5 373.9 L 685.1 371.4 Q 684.9 371.1, 684.7 370.8 Q 684.5 370.5, 684.5 370.4 L 684.5 373.9 L 683.9 373.9 L 683.9 369.6 L 684.6 369.6 \" fill=\"#0000FF\"/>\n<path class=\"atom-7\" d=\"M 683.6 351.6 Q 683.6 350.6, 684.1 350.0 Q 684.6 349.4, 685.5 349.4 Q 686.5 349.4, 687.0 350.0 Q 687.5 350.6, 687.5 351.6 Q 687.5 352.6, 687.0 353.2 Q 686.5 353.8, 685.5 353.8 Q 684.6 353.8, 684.1 353.2 Q 683.6 352.6, 683.6 351.6 M 685.5 353.3 Q 686.2 353.3, 686.5 352.9 Q 686.9 352.4, 686.9 351.6 Q 686.9 350.7, 686.5 350.3 Q 686.2 349.9, 685.5 349.9 Q 684.9 349.9, 684.5 350.3 Q 684.2 350.7, 684.2 351.6 Q 684.2 352.4, 684.5 352.9 Q 684.9 353.3, 685.5 353.3 \" fill=\"#FF0000\"/>\n<path class=\"atom-8\" d=\"M 667.1 359.5 L 668.5 361.8 Q 668.6 362.0, 668.9 362.4 Q 669.1 362.8, 669.1 362.8 L 669.1 359.5 L 669.7 359.5 L 669.7 363.8 L 669.1 363.8 L 667.6 361.3 Q 667.4 361.0, 667.2 360.7 Q 667.0 360.4, 667.0 360.3 L 667.0 363.8 L 666.4 363.8 L 666.4 359.5 L 667.1 359.5 \" fill=\"#0000FF\"/>\n<path class=\"atom-13\" d=\"M 625.3 371.8 Q 625.3 370.7, 625.8 370.2 Q 626.3 369.6, 627.3 369.6 Q 628.2 369.6, 628.7 370.2 Q 629.2 370.7, 629.2 371.8 Q 629.2 372.8, 628.7 373.4 Q 628.2 374.0, 627.3 374.0 Q 626.3 374.0, 625.8 373.4 Q 625.3 372.8, 625.3 371.8 M 627.3 373.5 Q 627.9 373.5, 628.3 373.0 Q 628.6 372.6, 628.6 371.8 Q 628.6 370.9, 628.3 370.5 Q 627.9 370.1, 627.3 370.1 Q 626.6 370.1, 626.3 370.5 Q 625.9 370.9, 625.9 371.8 Q 625.9 372.6, 626.3 373.0 Q 626.6 373.5, 627.3 373.5 \" fill=\"#FF0000\"/>\n<path class=\"atom-14\" d=\"M 626.3 349.4 L 627.7 351.7 Q 627.9 351.9, 628.1 352.3 Q 628.3 352.7, 628.3 352.7 L 628.3 349.4 L 628.9 349.4 L 628.9 353.7 L 628.3 353.7 L 626.8 351.2 Q 626.6 350.9, 626.5 350.6 Q 626.3 350.3, 626.2 350.2 L 626.2 353.7 L 625.7 353.7 L 625.7 349.4 L 626.3 349.4 \" fill=\"#0000FF\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 69.6,543.5 L 69.6,538.9\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 69.6,538.9 L 69.6,534.3\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 67.3,543.5 L 67.3,538.9\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 67.3,538.9 L 67.3,534.3\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-1 atom-1 atom-2\" d=\"M 68.5,534.3 L 64.4,531.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-1 atom-1 atom-2\" d=\"M 64.4,531.9 L 60.3,529.6\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-11 atom-1 atom-12\" d=\"M 68.5,534.3 L 72.6,531.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-11 atom-1 atom-12\" d=\"M 72.6,531.9 L 76.7,529.6\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-2 atom-2 atom-3\" d=\"M 56.5,529.6 L 52.4,531.9\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-2 atom-2 atom-3\" d=\"M 52.4,531.9 L 48.3,534.3\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-3 atom-3 atom-4\" d=\"M 48.3,534.3 L 48.3,545.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-3 atom-3 atom-4\" d=\"M 46.0,536.0 L 46.0,544.2\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-24 atom-11 atom-3\" d=\"M 38.2,528.5 L 48.3,534.3\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-4 atom-4 atom-5\" d=\"M 48.3,545.9 L 38.2,551.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-5 atom-5 atom-6\" d=\"M 38.2,551.8 L 28.1,545.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-5 atom-5 atom-6\" d=\"M 37.9,548.9 L 30.8,544.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-6 atom-6 atom-7\" d=\"M 28.1,545.9 L 23.7,547.4\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-6 atom-6 atom-7\" d=\"M 23.7,547.4 L 19.3,548.8\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-26 atom-10 atom-6\" d=\"M 28.1,534.3 L 28.1,545.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-7 atom-7 atom-8\" d=\"M 15.3,547.1 L 12.7,543.6\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-7 atom-7 atom-8\" d=\"M 12.7,543.6 L 10.2,540.1\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-8 atom-8 atom-9\" d=\"M 10.2,540.1 L 12.7,536.6\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-8 atom-8 atom-9\" d=\"M 12.7,536.6 L 15.2,533.2\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-9 atom-9 atom-10\" d=\"M 19.3,531.4 L 23.7,532.8\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-9 atom-9 atom-10\" d=\"M 23.7,532.8 L 28.1,534.3\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-10 atom-10 atom-11\" d=\"M 28.1,534.3 L 38.2,528.5\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-10 atom-10 atom-11\" d=\"M 30.8,535.4 L 37.9,531.4\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-12 atom-12 atom-13\" d=\"M 78.6,526.0 L 78.6,521.4\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-12 atom-12 atom-13\" d=\"M 78.6,521.4 L 78.6,516.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-25 atom-24 atom-12\" d=\"M 88.6,534.3 L 84.5,531.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-25 atom-24 atom-12\" d=\"M 84.5,531.9 L 80.5,529.6\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-13 atom-13 atom-14\" d=\"M 78.6,516.8 L 88.6,511.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-14 atom-14 atom-15\" d=\"M 88.6,511.0 L 98.7,516.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-15 atom-15 atom-16\" d=\"M 98.7,516.8 L 108.8,511.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-22 atom-15 atom-23\" d=\"M 98.7,516.8 L 98.7,528.5\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-16 atom-16 atom-17\" d=\"M 108.8,511.0 L 112.9,513.4\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-16 atom-16 atom-17\" d=\"M 112.9,513.4 L 117.0,515.7\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-17 atom-17 atom-18\" d=\"M 118.9,519.2 L 118.9,523.8\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-17 atom-17 atom-18\" d=\"M 118.9,523.8 L 118.9,528.5\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-27 atom-22 atom-17\" d=\"M 129.0,511.0 L 124.9,513.4\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-27 atom-22 atom-17\" d=\"M 124.9,513.4 L 120.8,515.7\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-18 atom-18 atom-19\" d=\"M 118.9,528.5 L 129.0,534.3\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-19 atom-19 atom-20\" d=\"M 129.0,534.3 L 132.9,532.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-19 atom-19 atom-20\" d=\"M 132.9,532.0 L 136.8,529.8\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-20 atom-20 atom-21\" d=\"M 139.1,526.0 L 139.1,521.4\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-20 atom-20 atom-21\" d=\"M 139.1,521.4 L 139.1,516.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-21 atom-21 atom-22\" d=\"M 139.1,516.8 L 129.0,511.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-23 atom-23 atom-24\" d=\"M 98.7,528.5 L 88.6,534.3\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"atom-0\" d=\"M 66.5 545.9 Q 66.5 544.9, 67.0 544.4 Q 67.5 543.8, 68.5 543.8 Q 69.4 543.8, 69.9 544.4 Q 70.4 544.9, 70.4 545.9 Q 70.4 547.0, 69.9 547.6 Q 69.4 548.1, 68.5 548.1 Q 67.5 548.1, 67.0 547.6 Q 66.5 547.0, 66.5 545.9 M 68.5 547.7 Q 69.1 547.7, 69.5 547.2 Q 69.8 546.8, 69.8 545.9 Q 69.8 545.1, 69.5 544.7 Q 69.1 544.3, 68.5 544.3 Q 67.8 544.3, 67.5 544.7 Q 67.1 545.1, 67.1 545.9 Q 67.1 546.8, 67.5 547.2 Q 67.8 547.7, 68.5 547.7 \" fill=\"#FF0000\"/>\n<path class=\"atom-2\" d=\"M 57.4 526.3 L 58.8 528.6 Q 59.0 528.8, 59.2 529.2 Q 59.4 529.6, 59.4 529.6 L 59.4 526.3 L 60.0 526.3 L 60.0 530.6 L 59.4 530.6 L 57.9 528.1 Q 57.7 527.8, 57.6 527.5 Q 57.4 527.2, 57.3 527.1 L 57.3 530.6 L 56.8 530.6 L 56.8 526.3 L 57.4 526.3 \" fill=\"#0000FF\"/>\n<path class=\"atom-2\" d=\"M 56.7 521.7 L 57.3 521.7 L 57.3 523.5 L 59.5 523.5 L 59.5 521.7 L 60.0 521.7 L 60.0 525.9 L 59.5 525.9 L 59.5 523.9 L 57.3 523.9 L 57.3 525.9 L 56.7 525.9 L 56.7 521.7 \" fill=\"#0000FF\"/>\n<path class=\"atom-7\" d=\"M 15.1 549.5 Q 15.1 548.5, 15.6 548.0 Q 16.1 547.4, 17.0 547.4 Q 18.0 547.4, 18.5 548.0 Q 19.0 548.5, 19.0 549.5 Q 19.0 550.6, 18.5 551.2 Q 18.0 551.7, 17.0 551.7 Q 16.1 551.7, 15.6 551.2 Q 15.1 550.6, 15.1 549.5 M 17.0 551.3 Q 17.7 551.3, 18.0 550.8 Q 18.4 550.4, 18.4 549.5 Q 18.4 548.7, 18.0 548.3 Q 17.7 547.9, 17.0 547.9 Q 16.4 547.9, 16.0 548.3 Q 15.7 548.7, 15.7 549.5 Q 15.7 550.4, 16.0 550.8 Q 16.4 551.3, 17.0 551.3 \" fill=\"#FF0000\"/>\n<path class=\"atom-9\" d=\"M 15.1 530.7 Q 15.1 529.7, 15.6 529.1 Q 16.1 528.5, 17.0 528.5 Q 18.0 528.5, 18.5 529.1 Q 19.0 529.7, 19.0 530.7 Q 19.0 531.7, 18.5 532.3 Q 18.0 532.9, 17.0 532.9 Q 16.1 532.9, 15.6 532.3 Q 15.1 531.7, 15.1 530.7 M 17.0 532.4 Q 17.7 532.4, 18.0 532.0 Q 18.4 531.5, 18.4 530.7 Q 18.4 529.9, 18.0 529.4 Q 17.7 529.0, 17.0 529.0 Q 16.4 529.0, 16.0 529.4 Q 15.7 529.9, 15.7 530.7 Q 15.7 531.6, 16.0 532.0 Q 16.4 532.4, 17.0 532.4 \" fill=\"#FF0000\"/>\n<path class=\"atom-12\" d=\"M 77.6 526.3 L 79.0 528.6 Q 79.1 528.8, 79.4 529.2 Q 79.6 529.6, 79.6 529.6 L 79.6 526.3 L 80.2 526.3 L 80.2 530.6 L 79.6 530.6 L 78.1 528.1 Q 77.9 527.8, 77.7 527.5 Q 77.5 527.2, 77.5 527.1 L 77.5 530.6 L 76.9 530.6 L 76.9 526.3 L 77.6 526.3 \" fill=\"#0000FF\"/>\n<path class=\"atom-17\" d=\"M 118.0 514.7 L 119.4 516.9 Q 119.5 517.2, 119.7 517.6 Q 119.9 518.0, 119.9 518.0 L 119.9 514.7 L 120.5 514.7 L 120.5 518.9 L 119.9 518.9 L 118.4 516.5 Q 118.3 516.2, 118.1 515.9 Q 117.9 515.5, 117.8 515.4 L 117.8 518.9 L 117.3 518.9 L 117.3 514.7 L 118.0 514.7 \" fill=\"#0000FF\"/>\n<path class=\"atom-20\" d=\"M 137.1 528.5 Q 137.1 527.5, 137.6 526.9 Q 138.1 526.3, 139.1 526.3 Q 140.0 526.3, 140.5 526.9 Q 141.0 527.5, 141.0 528.5 Q 141.0 529.5, 140.5 530.1 Q 140.0 530.7, 139.1 530.7 Q 138.1 530.7, 137.6 530.1 Q 137.1 529.5, 137.1 528.5 M 139.1 530.2 Q 139.7 530.2, 140.1 529.8 Q 140.4 529.3, 140.4 528.5 Q 140.4 527.6, 140.1 527.2 Q 139.7 526.8, 139.1 526.8 Q 138.4 526.8, 138.1 527.2 Q 137.7 527.6, 137.7 528.5 Q 137.7 529.3, 138.1 529.8 Q 138.4 530.2, 139.1 530.2 \" fill=\"#FF0000\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 297.2,481.4 L 303.0,491.5\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-1 atom-1 atom-2\" d=\"M 303.0,491.5 L 300.8,495.3\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-1 atom-1 atom-2\" d=\"M 300.8,495.3 L 298.6,499.1\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-2 atom-2 atom-3\" d=\"M 298.6,504.1 L 300.8,507.9\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-2 atom-2 atom-3\" d=\"M 300.8,507.9 L 303.0,511.7\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-3 atom-3 atom-4\" d=\"M 303.0,511.7 L 297.2,521.7\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-20 atom-20 atom-3\" d=\"M 314.6,511.7 L 303.0,511.7\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-4 atom-4 atom-5\" d=\"M 297.2,521.7 L 303.0,531.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-5 atom-5 atom-6\" d=\"M 303.0,531.8 L 314.6,531.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-6 atom-6 atom-7\" d=\"M 314.6,531.8 L 316.9,528.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-6 atom-6 atom-7\" d=\"M 316.9,528.0 L 319.1,524.2\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-7 atom-7 atom-8\" d=\"M 322.4,521.7 L 327.2,521.7\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-7 atom-7 atom-8\" d=\"M 327.2,521.7 L 332.1,521.7\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-19 atom-7 atom-20\" d=\"M 319.1,519.3 L 316.9,515.5\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-19 atom-7 atom-20\" d=\"M 316.9,515.5 L 314.6,511.7\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-8 atom-8 atom-9\" d=\"M 333.1,522.3 L 335.3,518.5\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-8 atom-8 atom-9\" d=\"M 335.3,518.5 L 337.5,514.7\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-8 atom-8 atom-9\" d=\"M 331.1,521.2 L 333.3,517.4\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-8 atom-8 atom-9\" d=\"M 333.3,517.4 L 335.5,513.6\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-9 atom-8 atom-10\" d=\"M 332.1,521.7 L 334.3,525.6\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-9 atom-8 atom-10\" d=\"M 334.3,525.6 L 336.5,529.4\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-10 atom-10 atom-11\" d=\"M 339.8,531.8 L 344.7,531.8\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-10 atom-10 atom-11\" d=\"M 344.7,531.8 L 349.6,531.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-11 atom-11 atom-12\" d=\"M 349.6,531.8 L 355.4,541.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-11 atom-11 atom-12\" d=\"M 352.5,532.2 L 356.5,539.2\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-21 atom-18 atom-11\" d=\"M 355.4,521.7 L 349.6,531.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-12 atom-12 atom-13\" d=\"M 355.4,541.9 L 349.6,552.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-13 atom-12 atom-14\" d=\"M 355.4,541.9 L 367.1,541.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-14 atom-14 atom-15\" d=\"M 367.1,541.9 L 372.9,531.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-14 atom-14 atom-15\" d=\"M 365.9,539.2 L 370.0,532.2\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-15 atom-15 atom-16\" d=\"M 372.9,531.8 L 384.5,531.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-16 atom-15 atom-17\" d=\"M 372.9,531.8 L 367.1,521.7\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-17 atom-17 atom-18\" d=\"M 367.1,521.7 L 355.4,521.7\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-17 atom-17 atom-18\" d=\"M 365.3,524.1 L 357.2,524.1\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-18 atom-18 atom-19\" d=\"M 355.4,521.7 L 352.8,517.2\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-18 atom-18 atom-19\" d=\"M 352.8,517.2 L 350.1,512.6\" style=\"fill:none;fill-rule:evenodd;stroke:#00CC00;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"atom-2\" d=\"M 295.2 501.6 Q 295.2 500.6, 295.7 500.0 Q 296.2 499.4, 297.2 499.4 Q 298.1 499.4, 298.6 500.0 Q 299.1 500.6, 299.1 501.6 Q 299.1 502.6, 298.6 503.2 Q 298.1 503.8, 297.2 503.8 Q 296.2 503.8, 295.7 503.2 Q 295.2 502.6, 295.2 501.6 M 297.2 503.3 Q 297.8 503.3, 298.2 502.9 Q 298.5 502.4, 298.5 501.6 Q 298.5 500.7, 298.2 500.3 Q 297.8 499.9, 297.2 499.9 Q 296.5 499.9, 296.2 500.3 Q 295.8 500.7, 295.8 501.6 Q 295.8 502.4, 296.2 502.9 Q 296.5 503.3, 297.2 503.3 \" fill=\"#FF0000\"/>\n<path class=\"atom-7\" d=\"M 319.5 519.6 L 320.9 521.9 Q 321.1 522.1, 321.3 522.5 Q 321.5 522.9, 321.5 522.9 L 321.5 519.6 L 322.1 519.6 L 322.1 523.9 L 321.5 523.9 L 320.0 521.4 Q 319.8 521.1, 319.6 520.8 Q 319.5 520.5, 319.4 520.4 L 319.4 523.9 L 318.9 523.9 L 318.9 519.6 L 319.5 519.6 \" fill=\"#0000FF\"/>\n<path class=\"atom-9\" d=\"M 336.0 511.7 Q 336.0 510.6, 336.5 510.1 Q 337.0 509.5, 337.9 509.5 Q 338.9 509.5, 339.4 510.1 Q 339.9 510.6, 339.9 511.7 Q 339.9 512.7, 339.4 513.3 Q 338.9 513.9, 337.9 513.9 Q 337.0 513.9, 336.5 513.3 Q 336.0 512.7, 336.0 511.7 M 337.9 513.4 Q 338.6 513.4, 338.9 513.0 Q 339.3 512.5, 339.3 511.7 Q 339.3 510.8, 338.9 510.4 Q 338.6 510.0, 337.9 510.0 Q 337.3 510.0, 336.9 510.4 Q 336.6 510.8, 336.6 511.7 Q 336.6 512.5, 336.9 513.0 Q 337.3 513.4, 337.9 513.4 \" fill=\"#FF0000\"/>\n<path class=\"atom-10\" d=\"M 332.5 529.7 L 333.1 529.7 L 333.1 531.5 L 335.2 531.5 L 335.2 529.7 L 335.8 529.7 L 335.8 534.0 L 335.2 534.0 L 335.2 532.0 L 333.1 532.0 L 333.1 534.0 L 332.5 534.0 L 332.5 529.7 \" fill=\"#0000FF\"/>\n<path class=\"atom-10\" d=\"M 337.0 529.7 L 338.4 532.0 Q 338.5 532.2, 338.7 532.6 Q 339.0 533.0, 339.0 533.0 L 339.0 529.7 L 339.5 529.7 L 339.5 534.0 L 339.0 534.0 L 337.5 531.5 Q 337.3 531.2, 337.1 530.9 Q 336.9 530.5, 336.9 530.4 L 336.9 534.0 L 336.3 534.0 L 336.3 529.7 L 337.0 529.7 \" fill=\"#0000FF\"/>\n<path class=\"atom-19\" d=\"M 345.5 511.8 Q 345.5 510.7, 346.0 510.2 Q 346.5 509.6, 347.4 509.6 Q 348.3 509.6, 348.8 510.3 L 348.4 510.6 Q 348.1 510.1, 347.4 510.1 Q 346.8 510.1, 346.5 510.6 Q 346.1 511.0, 346.1 511.8 Q 346.1 512.6, 346.5 513.1 Q 346.8 513.5, 347.5 513.5 Q 348.0 513.5, 348.5 513.2 L 348.7 513.7 Q 348.5 513.8, 348.1 513.9 Q 347.8 514.0, 347.4 514.0 Q 346.5 514.0, 346.0 513.4 Q 345.5 512.9, 345.5 511.8 \" fill=\"#00CC00\"/>\n<path class=\"atom-19\" d=\"M 349.3 509.4 L 349.9 509.4 L 349.9 513.9 L 349.3 513.9 L 349.3 509.4 \" fill=\"#00CC00\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 541.9,521.7 L 537.0,521.7\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 537.0,521.7 L 532.1,521.7\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 541.9,519.4 L 537.7,519.4\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 537.7,519.4 L 533.6,519.4\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 541.9,524.1 L 537.7,524.1\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 537.7,524.1 L 533.6,524.1\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-1 atom-1 atom-2\" d=\"M 532.1,521.7 L 520.5,521.7\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-2 atom-2 atom-3\" d=\"M 520.5,521.7 L 514.6,531.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-2 atom-2 atom-3\" d=\"M 517.6,522.1 L 513.5,529.1\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-21 atom-21 atom-2\" d=\"M 514.6,511.7 L 520.5,521.7\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-3 atom-3 atom-4\" d=\"M 514.6,531.8 L 503.0,531.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-4 atom-4 atom-5\" d=\"M 503.0,531.8 L 497.2,521.7\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-4 atom-4 atom-5\" d=\"M 504.1,529.1 L 500.1,522.1\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-5 atom-5 atom-6\" d=\"M 497.2,521.7 L 492.3,521.7\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-5 atom-5 atom-6\" d=\"M 492.3,521.7 L 487.4,521.7\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-19 atom-5 atom-20\" d=\"M 497.2,521.7 L 503.0,511.7\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-6 atom-6 atom-7\" d=\"M 484.1,519.3 L 481.9,515.5\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-6 atom-6 atom-7\" d=\"M 481.9,515.5 L 479.7,511.7\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-7 atom-7 atom-8\" d=\"M 480.7,512.2 L 482.9,508.4\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-7 atom-7 atom-8\" d=\"M 482.9,508.4 L 485.1,504.7\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-7 atom-7 atom-8\" d=\"M 478.7,511.1 L 480.9,507.3\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-7 atom-7 atom-8\" d=\"M 480.9,507.3 L 483.1,503.5\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-8 atom-7 atom-9\" d=\"M 479.7,511.7 L 474.8,511.7\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-8 atom-7 atom-9\" d=\"M 474.8,511.7 L 470.0,511.7\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-9 atom-9 atom-10\" d=\"M 466.7,509.2 L 464.4,505.4\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-9 atom-9 atom-10\" d=\"M 464.4,505.4 L 462.2,501.6\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-22 atom-19 atom-9\" d=\"M 462.2,521.7 L 464.4,517.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-22 atom-19 atom-9\" d=\"M 464.4,517.9 L 466.7,514.1\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-10 atom-10 atom-11\" d=\"M 462.2,501.6 L 450.6,501.6\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-11 atom-11 atom-12\" d=\"M 450.6,501.6 L 444.8,511.7\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-12 atom-12 atom-13\" d=\"M 444.8,511.7 L 450.6,521.7\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-13 atom-13 atom-14\" d=\"M 450.6,521.7 L 444.8,531.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-18 atom-13 atom-19\" d=\"M 450.6,521.7 L 462.2,521.7\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-14 atom-14 atom-15\" d=\"M 444.8,531.8 L 439.9,531.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-14 atom-14 atom-15\" d=\"M 439.9,531.8 L 435.0,531.8\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-15 atom-15 atom-16\" d=\"M 431.7,534.2 L 429.5,538.1\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-15 atom-15 atom-16\" d=\"M 429.5,538.1 L 427.3,541.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-16 atom-16 atom-17\" d=\"M 427.3,541.9 L 422.4,541.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-16 atom-16 atom-17\" d=\"M 422.4,541.9 L 417.5,541.9\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-17 atom-16 atom-18\" d=\"M 426.3,542.5 L 428.5,546.3\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-17 atom-16 atom-18\" d=\"M 428.5,546.3 L 430.7,550.1\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-17 atom-16 atom-18\" d=\"M 428.3,541.3 L 430.5,545.2\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-17 atom-16 atom-18\" d=\"M 430.5,545.2 L 432.7,549.0\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-20 atom-20 atom-21\" d=\"M 503.0,511.7 L 514.6,511.7\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-20 atom-20 atom-21\" d=\"M 504.7,514.0 L 512.9,514.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"atom-0\" d=\"M 542.8 519.6 L 544.2 521.9 Q 544.3 522.1, 544.6 522.5 Q 544.8 522.9, 544.8 522.9 L 544.8 519.6 L 545.4 519.6 L 545.4 523.9 L 544.8 523.9 L 543.3 521.4 Q 543.1 521.1, 542.9 520.8 Q 542.8 520.5, 542.7 520.4 L 542.7 523.9 L 542.1 523.9 L 542.1 519.6 L 542.8 519.6 \" fill=\"#0000FF\"/>\n<path class=\"atom-6\" d=\"M 480.1 519.6 L 480.7 519.6 L 480.7 521.4 L 482.8 521.4 L 482.8 519.6 L 483.4 519.6 L 483.4 523.9 L 482.8 523.9 L 482.8 521.9 L 480.7 521.9 L 480.7 523.9 L 480.1 523.9 L 480.1 519.6 \" fill=\"#0000FF\"/>\n<path class=\"atom-6\" d=\"M 484.6 519.6 L 486.0 521.9 Q 486.1 522.1, 486.3 522.5 Q 486.6 522.9, 486.6 522.9 L 486.6 519.6 L 487.1 519.6 L 487.1 523.9 L 486.5 523.9 L 485.1 521.4 Q 484.9 521.1, 484.7 520.8 Q 484.5 520.5, 484.5 520.4 L 484.5 523.9 L 483.9 523.9 L 483.9 519.6 L 484.6 519.6 \" fill=\"#0000FF\"/>\n<path class=\"atom-8\" d=\"M 483.6 501.6 Q 483.6 500.6, 484.1 500.0 Q 484.6 499.4, 485.5 499.4 Q 486.5 499.4, 487.0 500.0 Q 487.5 500.6, 487.5 501.6 Q 487.5 502.6, 487.0 503.2 Q 486.5 503.8, 485.5 503.8 Q 484.6 503.8, 484.1 503.2 Q 483.6 502.6, 483.6 501.6 M 485.5 503.3 Q 486.2 503.3, 486.5 502.9 Q 486.9 502.4, 486.9 501.6 Q 486.9 500.7, 486.5 500.3 Q 486.2 499.9, 485.5 499.9 Q 484.9 499.9, 484.5 500.3 Q 484.2 500.7, 484.2 501.6 Q 484.2 502.4, 484.5 502.9 Q 484.9 503.3, 485.5 503.3 \" fill=\"#FF0000\"/>\n<path class=\"atom-9\" d=\"M 467.1 509.5 L 468.5 511.8 Q 468.6 512.0, 468.9 512.4 Q 469.1 512.8, 469.1 512.8 L 469.1 509.5 L 469.7 509.5 L 469.7 513.8 L 469.1 513.8 L 467.6 511.3 Q 467.4 511.0, 467.2 510.7 Q 467.0 510.4, 467.0 510.3 L 467.0 513.8 L 466.4 513.8 L 466.4 509.5 L 467.1 509.5 \" fill=\"#0000FF\"/>\n<path class=\"atom-15\" d=\"M 427.7 529.7 L 428.2 529.7 L 428.2 531.5 L 430.4 531.5 L 430.4 529.7 L 431.0 529.7 L 431.0 534.0 L 430.4 534.0 L 430.4 532.0 L 428.2 532.0 L 428.2 534.0 L 427.7 534.0 L 427.7 529.7 \" fill=\"#0000FF\"/>\n<path class=\"atom-15\" d=\"M 432.2 529.7 L 433.6 532.0 Q 433.7 532.2, 433.9 532.6 Q 434.1 533.0, 434.2 533.0 L 434.2 529.7 L 434.7 529.7 L 434.7 534.0 L 434.1 534.0 L 432.6 531.5 Q 432.5 531.2, 432.3 530.9 Q 432.1 530.5, 432.0 530.4 L 432.0 534.0 L 431.5 534.0 L 431.5 529.7 L 432.2 529.7 \" fill=\"#0000FF\"/>\n<path class=\"atom-17\" d=\"M 408.1 539.8 L 408.7 539.8 L 408.7 541.6 L 410.9 541.6 L 410.9 539.8 L 411.4 539.8 L 411.4 544.0 L 410.9 544.0 L 410.9 542.1 L 408.7 542.1 L 408.7 544.0 L 408.1 544.0 L 408.1 539.8 \" fill=\"#0000FF\"/>\n<path class=\"atom-17\" d=\"M 411.6 543.9 Q 411.7 543.6, 412.0 543.5 Q 412.2 543.3, 412.6 543.3 Q 413.0 543.3, 413.2 543.6 Q 413.5 543.8, 413.5 544.2 Q 413.5 544.6, 413.2 545.0 Q 412.9 545.4, 412.2 545.8 L 413.5 545.8 L 413.5 546.2 L 411.6 546.2 L 411.6 545.9 Q 412.2 545.5, 412.5 545.2 Q 412.8 545.0, 412.9 544.7 Q 413.1 544.5, 413.1 544.2 Q 413.1 543.9, 412.9 543.8 Q 412.8 543.6, 412.6 543.6 Q 412.4 543.6, 412.2 543.7 Q 412.1 543.8, 411.9 544.0 L 411.6 543.9 \" fill=\"#0000FF\"/>\n<path class=\"atom-17\" d=\"M 414.7 539.8 L 416.1 542.0 Q 416.2 542.3, 416.4 542.7 Q 416.7 543.1, 416.7 543.1 L 416.7 539.8 L 417.2 539.8 L 417.2 544.0 L 416.7 544.0 L 415.2 541.6 Q 415.0 541.3, 414.8 541.0 Q 414.6 540.6, 414.6 540.5 L 414.6 544.0 L 414.0 544.0 L 414.0 539.8 L 414.7 539.8 \" fill=\"#0000FF\"/>\n<path class=\"atom-18\" d=\"M 431.2 552.0 Q 431.2 551.0, 431.7 550.4 Q 432.2 549.9, 433.1 549.9 Q 434.0 549.9, 434.6 550.4 Q 435.1 551.0, 435.1 552.0 Q 435.1 553.0, 434.5 553.6 Q 434.0 554.2, 433.1 554.2 Q 432.2 554.2, 431.7 553.6 Q 431.2 553.1, 431.2 552.0 M 433.1 553.7 Q 433.8 553.7, 434.1 553.3 Q 434.5 552.9, 434.5 552.0 Q 434.5 551.2, 434.1 550.8 Q 433.8 550.3, 433.1 550.3 Q 432.5 550.3, 432.1 550.8 Q 431.8 551.2, 431.8 552.0 Q 431.8 552.9, 432.1 553.3 Q 432.5 553.7, 433.1 553.7 \" fill=\"#FF0000\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 793.2,566.2 L 794.4,554.6\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-1 atom-1 atom-2\" d=\"M 794.4,554.6 L 790.6,551.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-1 atom-1 atom-2\" d=\"M 790.6,551.9 L 786.9,549.1\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-2 atom-2 atom-3\" d=\"M 785.0,545.3 L 785.0,540.7\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-2 atom-2 atom-3\" d=\"M 785.0,540.7 L 785.0,536.1\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-18 atom-18 atom-2\" d=\"M 773.9,551.3 L 778.5,549.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-18 atom-18 atom-2\" d=\"M 778.5,549.8 L 783.1,548.4\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-3 atom-3 atom-4\" d=\"M 785.0,536.1 L 773.9,532.5\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-4 atom-4 atom-5\" d=\"M 773.9,532.5 L 767.1,541.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-5 atom-5 atom-6\" d=\"M 767.1,541.9 L 755.4,541.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-17 atom-5 atom-18\" d=\"M 767.1,541.9 L 773.9,551.3\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-6 atom-6 atom-7\" d=\"M 755.4,541.9 L 753.2,538.1\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-6 atom-6 atom-7\" d=\"M 753.2,538.1 L 751.0,534.2\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-7 atom-7 atom-8\" d=\"M 747.7,531.8 L 742.8,531.8\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-7 atom-7 atom-8\" d=\"M 742.8,531.8 L 737.9,531.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-8 atom-8 atom-9\" d=\"M 736.9,531.2 L 734.7,535.1\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-8 atom-8 atom-9\" d=\"M 734.7,535.1 L 732.5,538.9\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-8 atom-8 atom-9\" d=\"M 738.9,532.4 L 736.7,536.2\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-8 atom-8 atom-9\" d=\"M 736.7,536.2 L 734.5,540.1\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-9 atom-8 atom-10\" d=\"M 737.9,531.8 L 735.7,528.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-9 atom-8 atom-10\" d=\"M 735.7,528.0 L 733.5,524.2\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-10 atom-10 atom-11\" d=\"M 730.2,521.7 L 725.3,521.7\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-10 atom-10 atom-11\" d=\"M 725.3,521.7 L 720.5,521.7\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-11 atom-11 atom-12\" d=\"M 720.5,521.7 L 714.6,531.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-11 atom-11 atom-12\" d=\"M 717.6,522.1 L 713.5,529.1\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-19 atom-17 atom-11\" d=\"M 714.6,511.7 L 720.5,521.7\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-12 atom-12 atom-13\" d=\"M 714.6,531.8 L 703.0,531.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-13 atom-13 atom-14\" d=\"M 703.0,531.8 L 697.2,521.7\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-13 atom-13 atom-14\" d=\"M 704.1,529.1 L 700.1,522.1\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-14 atom-14 atom-15\" d=\"M 697.2,521.7 L 691.6,521.7\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-14 atom-14 atom-15\" d=\"M 691.6,521.7 L 686.1,521.7\" style=\"fill:none;fill-rule:evenodd;stroke:#00CC00;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-15 atom-14 atom-16\" d=\"M 697.2,521.7 L 703.0,511.7\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-16 atom-16 atom-17\" d=\"M 703.0,511.7 L 714.6,511.7\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-16 atom-16 atom-17\" d=\"M 704.7,514.0 L 712.9,514.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"atom-2\" d=\"M 784.0 545.6 L 785.4 547.9 Q 785.6 548.1, 785.8 548.5 Q 786.0 548.9, 786.0 548.9 L 786.0 545.6 L 786.6 545.6 L 786.6 549.9 L 786.0 549.9 L 784.5 547.4 Q 784.3 547.1, 784.2 546.8 Q 784.0 546.5, 783.9 546.4 L 783.9 549.9 L 783.4 549.9 L 783.4 545.6 L 784.0 545.6 \" fill=\"#0000FF\"/>\n<path class=\"atom-7\" d=\"M 748.6 529.7 L 750.0 532.0 Q 750.2 532.2, 750.4 532.6 Q 750.6 533.0, 750.6 533.0 L 750.6 529.7 L 751.2 529.7 L 751.2 534.0 L 750.6 534.0 L 749.1 531.5 Q 748.9 531.2, 748.8 530.9 Q 748.6 530.5, 748.5 530.4 L 748.5 534.0 L 748.0 534.0 L 748.0 529.7 L 748.6 529.7 \" fill=\"#0000FF\"/>\n<path class=\"atom-7\" d=\"M 751.7 529.7 L 752.3 529.7 L 752.3 531.5 L 754.4 531.5 L 754.4 529.7 L 755.0 529.7 L 755.0 534.0 L 754.4 534.0 L 754.4 532.0 L 752.3 532.0 L 752.3 534.0 L 751.7 534.0 L 751.7 529.7 \" fill=\"#0000FF\"/>\n<path class=\"atom-9\" d=\"M 730.2 541.9 Q 730.2 540.9, 730.7 540.3 Q 731.2 539.8, 732.1 539.8 Q 733.1 539.8, 733.6 540.3 Q 734.1 540.9, 734.1 541.9 Q 734.1 543.0, 733.5 543.5 Q 733.0 544.1, 732.1 544.1 Q 731.2 544.1, 730.7 543.5 Q 730.2 543.0, 730.2 541.9 M 732.1 543.6 Q 732.8 543.6, 733.1 543.2 Q 733.5 542.8, 733.5 541.9 Q 733.5 541.1, 733.1 540.7 Q 732.8 540.2, 732.1 540.2 Q 731.5 540.2, 731.1 540.7 Q 730.8 541.1, 730.8 541.9 Q 730.8 542.8, 731.1 543.2 Q 731.5 543.6, 732.1 543.6 \" fill=\"#FF0000\"/>\n<path class=\"atom-10\" d=\"M 731.2 519.6 L 732.6 521.9 Q 732.7 522.1, 732.9 522.5 Q 733.1 522.9, 733.2 522.9 L 733.2 519.6 L 733.7 519.6 L 733.7 523.9 L 733.1 523.9 L 731.6 521.4 Q 731.5 521.1, 731.3 520.8 Q 731.1 520.5, 731.1 520.4 L 731.1 523.9 L 730.5 523.9 L 730.5 519.6 L 731.2 519.6 \" fill=\"#0000FF\"/>\n<path class=\"atom-10\" d=\"M 734.2 519.6 L 734.8 519.6 L 734.8 521.4 L 737.0 521.4 L 737.0 519.6 L 737.6 519.6 L 737.6 523.9 L 737.0 523.9 L 737.0 521.9 L 734.8 521.9 L 734.8 523.9 L 734.2 523.9 L 734.2 519.6 \" fill=\"#0000FF\"/>\n<path class=\"atom-15\" d=\"M 681.5 521.9 Q 681.5 520.8, 681.9 520.3 Q 682.4 519.7, 683.4 519.7 Q 684.3 519.7, 684.7 520.3 L 684.3 520.7 Q 684.0 520.2, 683.4 520.2 Q 682.7 520.2, 682.4 520.6 Q 682.1 521.1, 682.1 521.9 Q 682.1 522.7, 682.4 523.2 Q 682.8 523.6, 683.5 523.6 Q 683.9 523.6, 684.5 523.3 L 684.6 523.8 Q 684.4 523.9, 684.1 524.0 Q 683.7 524.1, 683.4 524.1 Q 682.4 524.1, 681.9 523.5 Q 681.5 522.9, 681.5 521.9 \" fill=\"#00CC00\"/>\n<path class=\"atom-15\" d=\"M 685.2 519.5 L 685.8 519.5 L 685.8 524.0 L 685.2 524.0 L 685.2 519.5 \" fill=\"#00CC00\"/>\n</svg>",
"text/plain": [
"<IPython.core.display.SVG object>"
]
},
"metadata": {},
"output_type": "display_data"
}
],
"source": [
"# Test partition and alignment on auto core generation based on ring system linker cut\n",
"\n",
"aligned_mols, mol_groups = partition_and_align_mols(molecules_with_confs, partition='strip-scaffold')\n",
"display(dm.to_image(molecules[:16], mol_size=(200, 150)))\n",
"display(dm.to_image(aligned_mols[:16], mol_size=(200, 150)))"
]
},
{
"cell_type": "code",
"execution_count": 11,
"metadata": {},
"outputs": [
{
"data": {
"image/svg+xml": "<svg baseProfile=\"full\" height=\"600px\" version=\"1.1\" viewBox=\"0 0 800 600\" width=\"800px\" xml:space=\"preserve\" xmlns=\"http://www.w3.org/2000/svg\" xmlns:rdkit=\"http://www.rdkit.org/xml\" xmlns:xlink=\"http://www.w3.org/1999/xlink\">\n<!-- END OF HEADER -->\n<rect height=\"600.0\" style=\"opacity:1.0;fill:#FFFFFF;stroke:none\" width=\"800.0\" x=\"0.0\" y=\"0.0\"> </rect>\n<rect height=\"600.0\" style=\"opacity:1.0;fill:#FFFFFF;stroke:none\" width=\"800.0\" x=\"0.0\" y=\"0.0\"> </rect>\n<rect height=\"600.0\" style=\"opacity:1.0;fill:#FFFFFF;stroke:none\" width=\"800.0\" x=\"0.0\" y=\"0.0\"> </rect>\n<rect height=\"600.0\" style=\"opacity:1.0;fill:#FFFFFF;stroke:none\" width=\"800.0\" x=\"0.0\" y=\"0.0\"> </rect>\n<rect height=\"600.0\" style=\"opacity:1.0;fill:#FFFFFF;stroke:none\" width=\"800.0\" x=\"0.0\" y=\"0.0\"> </rect>\n<rect height=\"600.0\" style=\"opacity:1.0;fill:#FFFFFF;stroke:none\" width=\"800.0\" x=\"0.0\" y=\"0.0\"> </rect>\n<rect height=\"600.0\" style=\"opacity:1.0;fill:#FFFFFF;stroke:none\" width=\"800.0\" x=\"0.0\" y=\"0.0\"> </rect>\n<rect height=\"600.0\" style=\"opacity:1.0;fill:#FFFFFF;stroke:none\" width=\"800.0\" x=\"0.0\" y=\"0.0\"> </rect>\n<rect height=\"600.0\" style=\"opacity:1.0;fill:#FFFFFF;stroke:none\" width=\"800.0\" x=\"0.0\" y=\"0.0\"> </rect>\n<rect height=\"600.0\" style=\"opacity:1.0;fill:#FFFFFF;stroke:none\" width=\"800.0\" x=\"0.0\" y=\"0.0\"> </rect>\n<rect height=\"600.0\" style=\"opacity:1.0;fill:#FFFFFF;stroke:none\" width=\"800.0\" x=\"0.0\" y=\"0.0\"> </rect>\n<rect height=\"600.0\" style=\"opacity:1.0;fill:#FFFFFF;stroke:none\" width=\"800.0\" x=\"0.0\" y=\"0.0\"> </rect>\n<rect height=\"600.0\" style=\"opacity:1.0;fill:#FFFFFF;stroke:none\" width=\"800.0\" x=\"0.0\" y=\"0.0\"> </rect>\n<rect height=\"600.0\" style=\"opacity:1.0;fill:#FFFFFF;stroke:none\" width=\"800.0\" x=\"0.0\" y=\"0.0\"> </rect>\n<rect height=\"600.0\" style=\"opacity:1.0;fill:#FFFFFF;stroke:none\" width=\"800.0\" x=\"0.0\" y=\"0.0\"> </rect>\n<rect height=\"600.0\" style=\"opacity:1.0;fill:#FFFFFF;stroke:none\" width=\"800.0\" x=\"0.0\" y=\"0.0\"> </rect>\n<rect height=\"600.0\" style=\"opacity:1.0;fill:#FFFFFF;stroke:none\" width=\"800.0\" x=\"0.0\" y=\"0.0\"> </rect>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 84.8,96.1 L 86.0,90.6\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 86.0,90.6 L 87.2,85.1\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 82.1,95.5 L 83.3,90.0\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 83.3,90.0 L 84.5,84.5\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-1 atom-1 atom-2\" d=\"M 85.9,84.8 L 81.7,81.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-1 atom-1 atom-2\" d=\"M 81.7,81.0 L 77.6,77.2\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-9 atom-1 atom-10\" d=\"M 85.9,84.8 L 91.5,83.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-9 atom-1 atom-10\" d=\"M 91.5,83.0 L 97.1,81.2\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-2 atom-2 atom-3\" d=\"M 73.7,76.1 L 68.1,77.9\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-2 atom-2 atom-3\" d=\"M 68.1,77.9 L 62.5,79.6\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-3 atom-3 atom-4\" d=\"M 62.5,79.6 L 52.2,70.3\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-3 atom-3 atom-4\" d=\"M 59.1,80.3 L 51.9,73.7\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-22 atom-8 atom-3\" d=\"M 59.5,93.2 L 62.5,79.6\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-4 atom-4 atom-5\" d=\"M 52.2,70.3 L 39.1,74.5\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-5 atom-5 atom-6\" d=\"M 39.1,74.5 L 36.1,88.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-5 atom-5 atom-6\" d=\"M 41.3,77.1 L 39.2,86.6\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-6 atom-6 atom-7\" d=\"M 36.1,88.0 L 46.3,97.3\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-7 atom-7 atom-8\" d=\"M 46.3,97.3 L 59.5,93.2\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-7 atom-7 atom-8\" d=\"M 47.4,94.1 L 56.7,91.1\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-8 atom-8 atom-9\" d=\"M 59.5,93.2 L 63.6,96.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-8 atom-8 atom-9\" d=\"M 63.6,96.9 L 67.7,100.7\" style=\"fill:none;fill-rule:evenodd;stroke:#00CC00;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-10 atom-10 atom-11\" d=\"M 101.0,82.4 L 105.2,86.2\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-10 atom-10 atom-11\" d=\"M 105.2,86.2 L 109.3,89.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-23 atom-22 atom-10\" d=\"M 102.0,67.1 L 100.8,72.6\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-23 atom-22 atom-10\" d=\"M 100.8,72.6 L 99.6,78.1\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-11 atom-11 atom-12\" d=\"M 109.3,89.9 L 122.5,85.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-12 atom-12 atom-13\" d=\"M 122.5,85.8 L 125.5,72.3\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-13 atom-13 atom-14\" d=\"M 125.5,72.3 L 138.6,68.1\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-20 atom-13 atom-21\" d=\"M 125.5,72.3 L 115.2,62.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-14 atom-14 atom-15\" d=\"M 138.6,68.1 L 142.8,71.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-14 atom-14 atom-15\" d=\"M 142.8,71.8 L 146.9,75.6\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-15 atom-15 atom-16\" d=\"M 148.3,79.9 L 147.1,85.4\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-15 atom-15 atom-16\" d=\"M 147.1,85.4 L 145.9,90.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-24 atom-20 atom-15\" d=\"M 162.1,73.2 L 156.4,75.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-24 atom-20 atom-15\" d=\"M 156.4,75.0 L 150.8,76.8\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-16 atom-16 atom-17\" d=\"M 145.9,90.9 L 156.1,100.3\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-17 atom-17 atom-18\" d=\"M 156.1,100.3 L 161.6,98.5\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-17 atom-17 atom-18\" d=\"M 161.6,98.5 L 167.0,96.8\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-18 atom-18 atom-19\" d=\"M 169.8,93.6 L 171.1,88.1\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-18 atom-18 atom-19\" d=\"M 171.1,88.1 L 172.3,82.6\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-19 atom-19 atom-20\" d=\"M 172.3,82.6 L 162.1,73.2\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-21 atom-21 atom-22\" d=\"M 115.2,62.9 L 102.0,67.1\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"atom-0\" d=\"M 80.9 98.3 Q 80.9 97.3, 81.5 96.7 Q 82.0 96.2, 82.9 96.2 Q 83.8 96.2, 84.3 96.7 Q 84.8 97.3, 84.8 98.3 Q 84.8 99.4, 84.3 99.9 Q 83.8 100.5, 82.9 100.5 Q 82.0 100.5, 81.5 99.9 Q 80.9 99.4, 80.9 98.3 M 82.9 100.0 Q 83.5 100.0, 83.9 99.6 Q 84.2 99.2, 84.2 98.3 Q 84.2 97.5, 83.9 97.1 Q 83.5 96.6, 82.9 96.6 Q 82.2 96.6, 81.9 97.1 Q 81.5 97.5, 81.5 98.3 Q 81.5 99.2, 81.9 99.6 Q 82.2 100.0, 82.9 100.0 \" fill=\"#FF0000\"/>\n<path class=\"atom-2\" d=\"M 74.7 73.3 L 76.1 75.6 Q 76.2 75.8, 76.5 76.2 Q 76.7 76.6, 76.7 76.6 L 76.7 73.3 L 77.3 73.3 L 77.3 77.6 L 76.7 77.6 L 75.2 75.1 Q 75.0 74.8, 74.8 74.5 Q 74.7 74.2, 74.6 74.1 L 74.6 77.6 L 74.0 77.6 L 74.0 73.3 L 74.7 73.3 \" fill=\"#0000FF\"/>\n<path class=\"atom-2\" d=\"M 74.0 68.7 L 74.6 68.7 L 74.6 70.5 L 76.7 70.5 L 76.7 68.7 L 77.3 68.7 L 77.3 72.9 L 76.7 72.9 L 76.7 70.9 L 74.6 70.9 L 74.6 72.9 L 74.0 72.9 L 74.0 68.7 \" fill=\"#0000FF\"/>\n<path class=\"atom-9\" d=\"M 68.1 102.6 Q 68.1 101.6, 68.6 101.0 Q 69.1 100.5, 70.0 100.5 Q 70.9 100.5, 71.3 101.1 L 70.9 101.4 Q 70.6 101.0, 70.0 101.0 Q 69.4 101.0, 69.0 101.4 Q 68.7 101.8, 68.7 102.6 Q 68.7 103.5, 69.0 103.9 Q 69.4 104.3, 70.1 104.3 Q 70.5 104.3, 71.1 104.1 L 71.2 104.5 Q 71.0 104.7, 70.7 104.7 Q 70.4 104.8, 70.0 104.8 Q 69.1 104.8, 68.6 104.3 Q 68.1 103.7, 68.1 102.6 \" fill=\"#00CC00\"/>\n<path class=\"atom-9\" d=\"M 71.9 100.2 L 72.4 100.2 L 72.4 104.8 L 71.9 104.8 L 71.9 100.2 \" fill=\"#00CC00\"/>\n<path class=\"atom-10\" d=\"M 98.1 78.5 L 99.5 80.7 Q 99.7 81.0, 99.9 81.4 Q 100.1 81.8, 100.1 81.8 L 100.1 78.5 L 100.7 78.5 L 100.7 82.7 L 100.1 82.7 L 98.6 80.3 Q 98.4 80.0, 98.2 79.7 Q 98.1 79.3, 98.0 79.2 L 98.0 82.7 L 97.5 82.7 L 97.5 78.5 L 98.1 78.5 \" fill=\"#0000FF\"/>\n<path class=\"atom-15\" d=\"M 147.9 75.3 L 149.3 77.5 Q 149.5 77.8, 149.7 78.2 Q 149.9 78.6, 149.9 78.6 L 149.9 75.3 L 150.5 75.3 L 150.5 79.5 L 149.9 79.5 L 148.4 77.1 Q 148.2 76.8, 148.0 76.5 Q 147.9 76.1, 147.8 76.0 L 147.8 79.5 L 147.3 79.5 L 147.3 75.3 L 147.9 75.3 \" fill=\"#0000FF\"/>\n<path class=\"atom-18\" d=\"M 167.3 96.1 Q 167.3 95.1, 167.9 94.5 Q 168.4 93.9, 169.3 93.9 Q 170.2 93.9, 170.7 94.5 Q 171.2 95.1, 171.2 96.1 Q 171.2 97.1, 170.7 97.7 Q 170.2 98.3, 169.3 98.3 Q 168.4 98.3, 167.9 97.7 Q 167.3 97.1, 167.3 96.1 M 169.3 97.8 Q 169.9 97.8, 170.3 97.4 Q 170.6 96.9, 170.6 96.1 Q 170.6 95.3, 170.3 94.8 Q 169.9 94.4, 169.3 94.4 Q 168.6 94.4, 168.3 94.8 Q 167.9 95.3, 167.9 96.1 Q 167.9 97.0, 168.3 97.4 Q 168.6 97.8, 169.3 97.8 \" fill=\"#FF0000\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 284.8,96.1 L 286.0,90.6\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 286.0,90.6 L 287.2,85.1\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 282.1,95.5 L 283.3,90.0\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 283.3,90.0 L 284.5,84.5\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-1 atom-1 atom-2\" d=\"M 285.9,84.8 L 281.7,81.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-1 atom-1 atom-2\" d=\"M 281.7,81.0 L 277.6,77.2\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-9 atom-1 atom-10\" d=\"M 285.9,84.8 L 291.5,83.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-9 atom-1 atom-10\" d=\"M 291.5,83.0 L 297.1,81.2\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-2 atom-2 atom-3\" d=\"M 273.7,76.1 L 268.1,77.9\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-2 atom-2 atom-3\" d=\"M 268.1,77.9 L 262.5,79.6\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-3 atom-3 atom-4\" d=\"M 262.5,79.6 L 252.2,70.3\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-3 atom-3 atom-4\" d=\"M 259.1,80.3 L 251.9,73.7\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-22 atom-9 atom-3\" d=\"M 259.5,93.2 L 262.5,79.6\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-4 atom-4 atom-5\" d=\"M 252.2,70.3 L 239.1,74.5\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-5 atom-5 atom-6\" d=\"M 239.1,74.5 L 236.1,88.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-5 atom-5 atom-6\" d=\"M 241.3,77.1 L 239.2,86.6\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-6 atom-6 atom-7\" d=\"M 236.1,88.0 L 230.3,89.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-6 atom-6 atom-7\" d=\"M 230.3,89.8 L 224.5,91.7\" style=\"fill:none;fill-rule:evenodd;stroke:#33CCCC;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-7 atom-6 atom-8\" d=\"M 236.1,88.0 L 246.3,97.3\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-8 atom-8 atom-9\" d=\"M 246.3,97.3 L 259.5,93.2\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-8 atom-8 atom-9\" d=\"M 247.4,94.1 L 256.7,91.1\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-10 atom-10 atom-11\" d=\"M 301.0,82.4 L 305.2,86.2\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-10 atom-10 atom-11\" d=\"M 305.2,86.2 L 309.3,89.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-23 atom-22 atom-10\" d=\"M 302.0,67.1 L 300.8,72.6\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-23 atom-22 atom-10\" d=\"M 300.8,72.6 L 299.6,78.1\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-11 atom-11 atom-12\" d=\"M 309.3,89.9 L 322.5,85.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-12 atom-12 atom-13\" d=\"M 322.5,85.8 L 325.5,72.3\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-13 atom-13 atom-14\" d=\"M 325.5,72.3 L 338.6,68.1\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-20 atom-13 atom-21\" d=\"M 325.5,72.3 L 315.2,62.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-14 atom-14 atom-15\" d=\"M 338.6,68.1 L 342.8,71.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-14 atom-14 atom-15\" d=\"M 342.8,71.8 L 346.9,75.6\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-15 atom-15 atom-16\" d=\"M 348.3,79.9 L 347.1,85.4\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-15 atom-15 atom-16\" d=\"M 347.1,85.4 L 345.9,90.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-24 atom-20 atom-15\" d=\"M 362.1,73.2 L 356.4,75.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-24 atom-20 atom-15\" d=\"M 356.4,75.0 L 350.8,76.8\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-16 atom-16 atom-17\" d=\"M 345.9,90.9 L 356.1,100.3\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-17 atom-17 atom-18\" d=\"M 356.1,100.3 L 361.6,98.5\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-17 atom-17 atom-18\" d=\"M 361.6,98.5 L 367.0,96.8\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-18 atom-18 atom-19\" d=\"M 369.8,93.6 L 371.1,88.1\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-18 atom-18 atom-19\" d=\"M 371.1,88.1 L 372.3,82.6\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-19 atom-19 atom-20\" d=\"M 372.3,82.6 L 362.1,73.2\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-21 atom-21 atom-22\" d=\"M 315.2,62.9 L 302.0,67.1\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"atom-0\" d=\"M 280.9 98.3 Q 280.9 97.3, 281.5 96.7 Q 282.0 96.2, 282.9 96.2 Q 283.8 96.2, 284.3 96.7 Q 284.8 97.3, 284.8 98.3 Q 284.8 99.4, 284.3 99.9 Q 283.8 100.5, 282.9 100.5 Q 282.0 100.5, 281.5 99.9 Q 280.9 99.4, 280.9 98.3 M 282.9 100.0 Q 283.5 100.0, 283.9 99.6 Q 284.2 99.2, 284.2 98.3 Q 284.2 97.5, 283.9 97.1 Q 283.5 96.6, 282.9 96.6 Q 282.2 96.6, 281.9 97.1 Q 281.5 97.5, 281.5 98.3 Q 281.5 99.2, 281.9 99.6 Q 282.2 100.0, 282.9 100.0 \" fill=\"#FF0000\"/>\n<path class=\"atom-2\" d=\"M 274.7 73.3 L 276.1 75.6 Q 276.2 75.8, 276.5 76.2 Q 276.7 76.6, 276.7 76.6 L 276.7 73.3 L 277.3 73.3 L 277.3 77.6 L 276.7 77.6 L 275.2 75.1 Q 275.0 74.8, 274.8 74.5 Q 274.7 74.2, 274.6 74.1 L 274.6 77.6 L 274.0 77.6 L 274.0 73.3 L 274.7 73.3 \" fill=\"#0000FF\"/>\n<path class=\"atom-2\" d=\"M 274.0 68.7 L 274.6 68.7 L 274.6 70.5 L 276.7 70.5 L 276.7 68.7 L 277.3 68.7 L 277.3 72.9 L 276.7 72.9 L 276.7 70.9 L 274.6 70.9 L 274.6 72.9 L 274.0 72.9 L 274.0 68.7 \" fill=\"#0000FF\"/>\n<path class=\"atom-7\" d=\"M 221.6 90.1 L 224.1 90.1 L 224.1 90.5 L 222.2 90.5 L 222.2 91.8 L 223.9 91.8 L 223.9 92.3 L 222.2 92.3 L 222.2 94.3 L 221.6 94.3 L 221.6 90.1 \" fill=\"#33CCCC\"/>\n<path class=\"atom-10\" d=\"M 298.1 78.5 L 299.5 80.7 Q 299.7 81.0, 299.9 81.4 Q 300.1 81.8, 300.1 81.8 L 300.1 78.5 L 300.7 78.5 L 300.7 82.7 L 300.1 82.7 L 298.6 80.3 Q 298.4 80.0, 298.2 79.7 Q 298.1 79.3, 298.0 79.2 L 298.0 82.7 L 297.5 82.7 L 297.5 78.5 L 298.1 78.5 \" fill=\"#0000FF\"/>\n<path class=\"atom-15\" d=\"M 347.9 75.3 L 349.3 77.5 Q 349.5 77.8, 349.7 78.2 Q 349.9 78.6, 349.9 78.6 L 349.9 75.3 L 350.5 75.3 L 350.5 79.5 L 349.9 79.5 L 348.4 77.1 Q 348.2 76.8, 348.0 76.5 Q 347.9 76.1, 347.8 76.0 L 347.8 79.5 L 347.3 79.5 L 347.3 75.3 L 347.9 75.3 \" fill=\"#0000FF\"/>\n<path class=\"atom-18\" d=\"M 367.3 96.1 Q 367.3 95.1, 367.9 94.5 Q 368.4 93.9, 369.3 93.9 Q 370.2 93.9, 370.7 94.5 Q 371.2 95.1, 371.2 96.1 Q 371.2 97.1, 370.7 97.7 Q 370.2 98.3, 369.3 98.3 Q 368.4 98.3, 367.9 97.7 Q 367.3 97.1, 367.3 96.1 M 369.3 97.8 Q 369.9 97.8, 370.3 97.4 Q 370.6 96.9, 370.6 96.1 Q 370.6 95.3, 370.3 94.8 Q 369.9 94.4, 369.3 94.4 Q 368.6 94.4, 368.3 94.8 Q 367.9 95.3, 367.9 96.1 Q 367.9 97.0, 368.3 97.4 Q 368.6 97.8, 369.3 97.8 \" fill=\"#FF0000\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 411.6,95.7 L 417.3,94.0\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 417.3,94.0 L 422.9,92.2\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 412.5,98.4 L 417.3,96.9\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 417.3,96.9 L 422.0,95.3\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 410.8,93.1 L 415.6,91.6\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 415.6,91.6 L 420.4,90.1\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-1 atom-1 atom-2\" d=\"M 422.9,92.2 L 436.1,88.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-2 atom-2 atom-3\" d=\"M 436.1,88.0 L 439.1,74.5\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-2 atom-2 atom-3\" d=\"M 439.2,86.6 L 441.3,77.1\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-23 atom-23 atom-2\" d=\"M 446.3,97.3 L 436.1,88.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-3 atom-3 atom-4\" d=\"M 439.1,74.5 L 452.2,70.3\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-4 atom-4 atom-5\" d=\"M 452.2,70.3 L 462.5,79.6\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-4 atom-4 atom-5\" d=\"M 451.9,73.7 L 459.1,80.3\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-5 atom-5 atom-6\" d=\"M 462.5,79.6 L 468.1,77.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-5 atom-5 atom-6\" d=\"M 468.1,77.9 L 473.7,76.1\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-21 atom-5 atom-22\" d=\"M 462.5,79.6 L 459.5,93.2\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-6 atom-6 atom-7\" d=\"M 477.6,77.2 L 481.7,81.0\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-6 atom-6 atom-7\" d=\"M 481.7,81.0 L 485.9,84.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-7 atom-7 atom-8\" d=\"M 484.5,84.5 L 483.3,90.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-7 atom-7 atom-8\" d=\"M 483.3,90.0 L 482.1,95.5\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-7 atom-7 atom-8\" d=\"M 487.2,85.1 L 486.0,90.6\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-7 atom-7 atom-8\" d=\"M 486.0,90.6 L 484.8,96.1\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-8 atom-7 atom-9\" d=\"M 485.9,84.8 L 491.5,83.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-8 atom-7 atom-9\" d=\"M 491.5,83.0 L 497.1,81.2\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-9 atom-9 atom-10\" d=\"M 501.0,82.4 L 505.2,86.2\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-9 atom-9 atom-10\" d=\"M 505.2,86.2 L 509.3,89.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-24 atom-21 atom-9\" d=\"M 502.0,67.1 L 500.8,72.6\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-24 atom-21 atom-9\" d=\"M 500.8,72.6 L 499.6,78.1\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-10 atom-10 atom-11\" d=\"M 509.3,89.9 L 522.5,85.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-11 atom-11 atom-12\" d=\"M 522.5,85.8 L 525.5,72.3\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-12 atom-12 atom-13\" d=\"M 525.5,72.3 L 538.6,68.1\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-19 atom-12 atom-20\" d=\"M 525.5,72.3 L 515.2,62.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-13 atom-13 atom-14\" d=\"M 538.6,68.1 L 542.8,71.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-13 atom-13 atom-14\" d=\"M 542.8,71.8 L 546.9,75.6\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-14 atom-14 atom-15\" d=\"M 548.3,79.9 L 547.1,85.4\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-14 atom-14 atom-15\" d=\"M 547.1,85.4 L 545.9,90.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-25 atom-19 atom-14\" d=\"M 562.1,73.2 L 556.4,75.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-25 atom-19 atom-14\" d=\"M 556.4,75.0 L 550.8,76.8\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-15 atom-15 atom-16\" d=\"M 545.9,90.9 L 556.1,100.3\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-16 atom-16 atom-17\" d=\"M 556.1,100.3 L 561.6,98.5\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-16 atom-16 atom-17\" d=\"M 561.6,98.5 L 567.0,96.8\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-17 atom-17 atom-18\" d=\"M 569.8,93.6 L 571.1,88.1\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-17 atom-17 atom-18\" d=\"M 571.1,88.1 L 572.3,82.6\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-18 atom-18 atom-19\" d=\"M 572.3,82.6 L 562.1,73.2\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-20 atom-20 atom-21\" d=\"M 515.2,62.9 L 502.0,67.1\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-22 atom-22 atom-23\" d=\"M 459.5,93.2 L 446.3,97.3\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-22 atom-22 atom-23\" d=\"M 456.7,91.1 L 447.4,94.1\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"atom-0\" d=\"M 408.8 94.2 L 410.1 96.5 Q 410.3 96.7, 410.5 97.1 Q 410.7 97.5, 410.7 97.5 L 410.7 94.2 L 411.3 94.2 L 411.3 98.5 L 410.7 98.5 L 409.2 96.0 Q 409.1 95.7, 408.9 95.4 Q 408.7 95.1, 408.6 95.0 L 408.6 98.5 L 408.1 98.5 L 408.1 94.2 L 408.8 94.2 \" fill=\"#0000FF\"/>\n<path class=\"atom-6\" d=\"M 474.7 73.3 L 476.1 75.6 Q 476.2 75.8, 476.5 76.2 Q 476.7 76.6, 476.7 76.6 L 476.7 73.3 L 477.3 73.3 L 477.3 77.6 L 476.7 77.6 L 475.2 75.1 Q 475.0 74.8, 474.8 74.5 Q 474.7 74.2, 474.6 74.1 L 474.6 77.6 L 474.0 77.6 L 474.0 73.3 L 474.7 73.3 \" fill=\"#0000FF\"/>\n<path class=\"atom-6\" d=\"M 474.0 68.7 L 474.6 68.7 L 474.6 70.5 L 476.7 70.5 L 476.7 68.7 L 477.3 68.7 L 477.3 72.9 L 476.7 72.9 L 476.7 70.9 L 474.6 70.9 L 474.6 72.9 L 474.0 72.9 L 474.0 68.7 \" fill=\"#0000FF\"/>\n<path class=\"atom-8\" d=\"M 480.9 98.3 Q 480.9 97.3, 481.5 96.7 Q 482.0 96.2, 482.9 96.2 Q 483.8 96.2, 484.3 96.7 Q 484.8 97.3, 484.8 98.3 Q 484.8 99.4, 484.3 99.9 Q 483.8 100.5, 482.9 100.5 Q 482.0 100.5, 481.5 99.9 Q 480.9 99.4, 480.9 98.3 M 482.9 100.0 Q 483.5 100.0, 483.9 99.6 Q 484.2 99.2, 484.2 98.3 Q 484.2 97.5, 483.9 97.1 Q 483.5 96.6, 482.9 96.6 Q 482.2 96.6, 481.9 97.1 Q 481.5 97.5, 481.5 98.3 Q 481.5 99.2, 481.9 99.6 Q 482.2 100.0, 482.9 100.0 \" fill=\"#FF0000\"/>\n<path class=\"atom-9\" d=\"M 498.1 78.5 L 499.5 80.7 Q 499.7 81.0, 499.9 81.4 Q 500.1 81.8, 500.1 81.8 L 500.1 78.5 L 500.7 78.5 L 500.7 82.7 L 500.1 82.7 L 498.6 80.3 Q 498.4 80.0, 498.2 79.7 Q 498.1 79.3, 498.0 79.2 L 498.0 82.7 L 497.5 82.7 L 497.5 78.5 L 498.1 78.5 \" fill=\"#0000FF\"/>\n<path class=\"atom-14\" d=\"M 547.9 75.3 L 549.3 77.5 Q 549.5 77.8, 549.7 78.2 Q 549.9 78.6, 549.9 78.6 L 549.9 75.3 L 550.5 75.3 L 550.5 79.5 L 549.9 79.5 L 548.4 77.1 Q 548.2 76.8, 548.0 76.5 Q 547.9 76.1, 547.8 76.0 L 547.8 79.5 L 547.3 79.5 L 547.3 75.3 L 547.9 75.3 \" fill=\"#0000FF\"/>\n<path class=\"atom-17\" d=\"M 567.3 96.1 Q 567.3 95.1, 567.9 94.5 Q 568.4 93.9, 569.3 93.9 Q 570.2 93.9, 570.7 94.5 Q 571.2 95.1, 571.2 96.1 Q 571.2 97.1, 570.7 97.7 Q 570.2 98.3, 569.3 98.3 Q 568.4 98.3, 567.9 97.7 Q 567.3 97.1, 567.3 96.1 M 569.3 97.8 Q 569.9 97.8, 570.3 97.4 Q 570.6 96.9, 570.6 96.1 Q 570.6 95.3, 570.3 94.8 Q 569.9 94.4, 569.3 94.4 Q 568.6 94.4, 568.3 94.8 Q 567.9 95.3, 567.9 96.1 Q 567.9 97.0, 568.3 97.4 Q 568.6 97.8, 569.3 97.8 \" fill=\"#FF0000\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 628.8,65.1 L 639.1,74.5\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-1 atom-1 atom-2\" d=\"M 639.1,74.5 L 636.1,88.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-1 atom-1 atom-2\" d=\"M 641.3,77.1 L 639.2,86.6\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-22 atom-22 atom-1\" d=\"M 652.2,70.3 L 639.1,74.5\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-2 atom-2 atom-3\" d=\"M 636.1,88.0 L 646.3,97.3\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-3 atom-3 atom-4\" d=\"M 646.3,97.3 L 659.5,93.2\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-3 atom-3 atom-4\" d=\"M 647.4,94.1 L 656.7,91.1\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-4 atom-4 atom-5\" d=\"M 659.5,93.2 L 662.5,79.6\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-5 atom-5 atom-6\" d=\"M 662.5,79.6 L 668.1,77.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-5 atom-5 atom-6\" d=\"M 668.1,77.9 L 673.7,76.1\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-21 atom-5 atom-22\" d=\"M 662.5,79.6 L 652.2,70.3\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-21 atom-5 atom-22\" d=\"M 659.1,80.3 L 651.9,73.7\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-6 atom-6 atom-7\" d=\"M 677.6,77.2 L 681.7,81.0\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-6 atom-6 atom-7\" d=\"M 681.7,81.0 L 685.9,84.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-7 atom-7 atom-8\" d=\"M 684.5,84.5 L 683.3,90.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-7 atom-7 atom-8\" d=\"M 683.3,90.0 L 682.1,95.5\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-7 atom-7 atom-8\" d=\"M 687.2,85.1 L 686.0,90.6\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-7 atom-7 atom-8\" d=\"M 686.0,90.6 L 684.8,96.1\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-8 atom-7 atom-9\" d=\"M 685.9,84.8 L 691.5,83.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-8 atom-7 atom-9\" d=\"M 691.5,83.0 L 697.1,81.2\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-9 atom-9 atom-10\" d=\"M 701.0,82.4 L 705.2,86.2\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-9 atom-9 atom-10\" d=\"M 705.2,86.2 L 709.3,89.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-23 atom-21 atom-9\" d=\"M 702.0,67.1 L 700.8,72.6\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-23 atom-21 atom-9\" d=\"M 700.8,72.6 L 699.6,78.1\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-10 atom-10 atom-11\" d=\"M 709.3,89.9 L 722.5,85.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-11 atom-11 atom-12\" d=\"M 722.5,85.8 L 725.5,72.3\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-12 atom-12 atom-13\" d=\"M 725.5,72.3 L 738.6,68.1\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-19 atom-12 atom-20\" d=\"M 725.5,72.3 L 715.2,62.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-13 atom-13 atom-14\" d=\"M 738.6,68.1 L 742.8,71.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-13 atom-13 atom-14\" d=\"M 742.8,71.8 L 746.9,75.6\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-14 atom-14 atom-15\" d=\"M 748.3,79.9 L 747.1,85.4\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-14 atom-14 atom-15\" d=\"M 747.1,85.4 L 745.9,90.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-24 atom-19 atom-14\" d=\"M 762.1,73.2 L 756.4,75.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-24 atom-19 atom-14\" d=\"M 756.4,75.0 L 750.8,76.8\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-15 atom-15 atom-16\" d=\"M 745.9,90.9 L 756.1,100.3\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-16 atom-16 atom-17\" d=\"M 756.1,100.3 L 761.6,98.5\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-16 atom-16 atom-17\" d=\"M 761.6,98.5 L 767.0,96.8\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-17 atom-17 atom-18\" d=\"M 769.8,93.6 L 771.1,88.1\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-17 atom-17 atom-18\" d=\"M 771.1,88.1 L 772.3,82.6\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-18 atom-18 atom-19\" d=\"M 772.3,82.6 L 762.1,73.2\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-20 atom-20 atom-21\" d=\"M 715.2,62.9 L 702.0,67.1\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"atom-6\" d=\"M 674.7 73.3 L 676.1 75.6 Q 676.2 75.8, 676.5 76.2 Q 676.7 76.6, 676.7 76.6 L 676.7 73.3 L 677.3 73.3 L 677.3 77.6 L 676.7 77.6 L 675.2 75.1 Q 675.0 74.8, 674.8 74.5 Q 674.7 74.2, 674.6 74.1 L 674.6 77.6 L 674.0 77.6 L 674.0 73.3 L 674.7 73.3 \" fill=\"#0000FF\"/>\n<path class=\"atom-6\" d=\"M 674.0 68.7 L 674.6 68.7 L 674.6 70.5 L 676.7 70.5 L 676.7 68.7 L 677.3 68.7 L 677.3 72.9 L 676.7 72.9 L 676.7 70.9 L 674.6 70.9 L 674.6 72.9 L 674.0 72.9 L 674.0 68.7 \" fill=\"#0000FF\"/>\n<path class=\"atom-8\" d=\"M 680.9 98.3 Q 680.9 97.3, 681.5 96.7 Q 682.0 96.2, 682.9 96.2 Q 683.8 96.2, 684.3 96.7 Q 684.8 97.3, 684.8 98.3 Q 684.8 99.4, 684.3 99.9 Q 683.8 100.5, 682.9 100.5 Q 682.0 100.5, 681.5 99.9 Q 680.9 99.4, 680.9 98.3 M 682.9 100.0 Q 683.5 100.0, 683.9 99.6 Q 684.2 99.2, 684.2 98.3 Q 684.2 97.5, 683.9 97.1 Q 683.5 96.6, 682.9 96.6 Q 682.2 96.6, 681.9 97.1 Q 681.5 97.5, 681.5 98.3 Q 681.5 99.2, 681.9 99.6 Q 682.2 100.0, 682.9 100.0 \" fill=\"#FF0000\"/>\n<path class=\"atom-9\" d=\"M 698.1 78.5 L 699.5 80.7 Q 699.7 81.0, 699.9 81.4 Q 700.1 81.8, 700.1 81.8 L 700.1 78.5 L 700.7 78.5 L 700.7 82.7 L 700.1 82.7 L 698.6 80.3 Q 698.4 80.0, 698.2 79.7 Q 698.1 79.3, 698.0 79.2 L 698.0 82.7 L 697.5 82.7 L 697.5 78.5 L 698.1 78.5 \" fill=\"#0000FF\"/>\n<path class=\"atom-14\" d=\"M 747.9 75.3 L 749.3 77.5 Q 749.5 77.8, 749.7 78.2 Q 749.9 78.6, 749.9 78.6 L 749.9 75.3 L 750.5 75.3 L 750.5 79.5 L 749.9 79.5 L 748.4 77.1 Q 748.2 76.8, 748.0 76.5 Q 747.9 76.1, 747.8 76.0 L 747.8 79.5 L 747.3 79.5 L 747.3 75.3 L 747.9 75.3 \" fill=\"#0000FF\"/>\n<path class=\"atom-17\" d=\"M 767.3 96.1 Q 767.3 95.1, 767.9 94.5 Q 768.4 93.9, 769.3 93.9 Q 770.2 93.9, 770.7 94.5 Q 771.2 95.1, 771.2 96.1 Q 771.2 97.1, 770.7 97.7 Q 770.2 98.3, 769.3 98.3 Q 768.4 98.3, 767.9 97.7 Q 767.3 97.1, 767.3 96.1 M 769.3 97.8 Q 769.9 97.8, 770.3 97.4 Q 770.6 96.9, 770.6 96.1 Q 770.6 95.3, 770.3 94.8 Q 769.9 94.4, 769.3 94.4 Q 768.6 94.4, 768.3 94.8 Q 767.9 95.3, 767.9 96.1 Q 767.9 97.0, 768.3 97.4 Q 768.6 97.8, 769.3 97.8 \" fill=\"#FF0000\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 84.8,246.1 L 86.0,240.6\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 86.0,240.6 L 87.2,235.1\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 82.1,245.5 L 83.3,240.0\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 83.3,240.0 L 84.5,234.5\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-1 atom-1 atom-2\" d=\"M 85.9,234.8 L 81.7,231.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-1 atom-1 atom-2\" d=\"M 81.7,231.0 L 77.6,227.2\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-9 atom-1 atom-10\" d=\"M 85.9,234.8 L 91.5,233.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-9 atom-1 atom-10\" d=\"M 91.5,233.0 L 97.1,231.2\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-2 atom-2 atom-3\" d=\"M 73.7,226.1 L 68.1,227.9\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-2 atom-2 atom-3\" d=\"M 68.1,227.9 L 62.5,229.6\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-3 atom-3 atom-4\" d=\"M 62.5,229.6 L 52.2,220.3\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-3 atom-3 atom-4\" d=\"M 59.1,230.3 L 51.9,223.7\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-22 atom-9 atom-3\" d=\"M 59.5,243.2 L 62.5,229.6\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-4 atom-4 atom-5\" d=\"M 52.2,220.3 L 39.1,224.5\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-5 atom-5 atom-6\" d=\"M 39.1,224.5 L 34.7,220.5\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-5 atom-5 atom-6\" d=\"M 34.7,220.5 L 30.4,216.6\" style=\"fill:none;fill-rule:evenodd;stroke:#33CCCC;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-6 atom-5 atom-7\" d=\"M 39.1,224.5 L 36.1,238.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-6 atom-5 atom-7\" d=\"M 41.3,227.1 L 39.2,236.6\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-7 atom-7 atom-8\" d=\"M 36.1,238.0 L 46.3,247.3\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-8 atom-8 atom-9\" d=\"M 46.3,247.3 L 59.5,243.2\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-8 atom-8 atom-9\" d=\"M 47.4,244.1 L 56.7,241.1\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-10 atom-10 atom-11\" d=\"M 101.0,232.4 L 105.2,236.2\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-10 atom-10 atom-11\" d=\"M 105.2,236.2 L 109.3,239.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-23 atom-22 atom-10\" d=\"M 102.0,217.1 L 100.8,222.6\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-23 atom-22 atom-10\" d=\"M 100.8,222.6 L 99.6,228.1\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-11 atom-11 atom-12\" d=\"M 109.3,239.9 L 122.5,235.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-12 atom-12 atom-13\" d=\"M 122.5,235.8 L 125.5,222.3\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-13 atom-13 atom-14\" d=\"M 125.5,222.3 L 138.6,218.1\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-20 atom-13 atom-21\" d=\"M 125.5,222.3 L 115.2,212.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-14 atom-14 atom-15\" d=\"M 138.6,218.1 L 142.8,221.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-14 atom-14 atom-15\" d=\"M 142.8,221.8 L 146.9,225.6\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-15 atom-15 atom-16\" d=\"M 148.3,229.9 L 147.1,235.4\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-15 atom-15 atom-16\" d=\"M 147.1,235.4 L 145.9,240.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-24 atom-20 atom-15\" d=\"M 162.1,223.2 L 156.4,225.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-24 atom-20 atom-15\" d=\"M 156.4,225.0 L 150.8,226.8\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-16 atom-16 atom-17\" d=\"M 145.9,240.9 L 156.1,250.3\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-17 atom-17 atom-18\" d=\"M 156.1,250.3 L 161.6,248.5\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-17 atom-17 atom-18\" d=\"M 161.6,248.5 L 167.0,246.8\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-18 atom-18 atom-19\" d=\"M 169.8,243.6 L 171.1,238.1\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-18 atom-18 atom-19\" d=\"M 171.1,238.1 L 172.3,232.6\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-19 atom-19 atom-20\" d=\"M 172.3,232.6 L 162.1,223.2\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-21 atom-21 atom-22\" d=\"M 115.2,212.9 L 102.0,217.1\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"atom-0\" d=\"M 80.9 248.3 Q 80.9 247.3, 81.5 246.7 Q 82.0 246.2, 82.9 246.2 Q 83.8 246.2, 84.3 246.7 Q 84.8 247.3, 84.8 248.3 Q 84.8 249.4, 84.3 249.9 Q 83.8 250.5, 82.9 250.5 Q 82.0 250.5, 81.5 249.9 Q 80.9 249.4, 80.9 248.3 M 82.9 250.0 Q 83.5 250.0, 83.9 249.6 Q 84.2 249.2, 84.2 248.3 Q 84.2 247.5, 83.9 247.1 Q 83.5 246.6, 82.9 246.6 Q 82.2 246.6, 81.9 247.1 Q 81.5 247.5, 81.5 248.3 Q 81.5 249.2, 81.9 249.6 Q 82.2 250.0, 82.9 250.0 \" fill=\"#FF0000\"/>\n<path class=\"atom-2\" d=\"M 74.7 223.3 L 76.1 225.6 Q 76.2 225.8, 76.5 226.2 Q 76.7 226.6, 76.7 226.6 L 76.7 223.3 L 77.3 223.3 L 77.3 227.6 L 76.7 227.6 L 75.2 225.1 Q 75.0 224.8, 74.8 224.5 Q 74.7 224.2, 74.6 224.1 L 74.6 227.6 L 74.0 227.6 L 74.0 223.3 L 74.7 223.3 \" fill=\"#0000FF\"/>\n<path class=\"atom-2\" d=\"M 74.0 218.7 L 74.6 218.7 L 74.6 220.5 L 76.7 220.5 L 76.7 218.7 L 77.3 218.7 L 77.3 222.9 L 76.7 222.9 L 76.7 220.9 L 74.6 220.9 L 74.6 222.9 L 74.0 222.9 L 74.0 218.7 \" fill=\"#0000FF\"/>\n<path class=\"atom-6\" d=\"M 27.6 213.0 L 30.1 213.0 L 30.1 213.5 L 28.1 213.5 L 28.1 214.8 L 29.9 214.8 L 29.9 215.3 L 28.1 215.3 L 28.1 217.3 L 27.6 217.3 L 27.6 213.0 \" fill=\"#33CCCC\"/>\n<path class=\"atom-10\" d=\"M 98.1 228.5 L 99.5 230.7 Q 99.7 231.0, 99.9 231.4 Q 100.1 231.8, 100.1 231.8 L 100.1 228.5 L 100.7 228.5 L 100.7 232.7 L 100.1 232.7 L 98.6 230.3 Q 98.4 230.0, 98.2 229.7 Q 98.1 229.3, 98.0 229.2 L 98.0 232.7 L 97.5 232.7 L 97.5 228.5 L 98.1 228.5 \" fill=\"#0000FF\"/>\n<path class=\"atom-15\" d=\"M 147.9 225.3 L 149.3 227.5 Q 149.5 227.8, 149.7 228.2 Q 149.9 228.6, 149.9 228.6 L 149.9 225.3 L 150.5 225.3 L 150.5 229.5 L 149.9 229.5 L 148.4 227.1 Q 148.2 226.8, 148.0 226.5 Q 147.9 226.1, 147.8 226.0 L 147.8 229.5 L 147.3 229.5 L 147.3 225.3 L 147.9 225.3 \" fill=\"#0000FF\"/>\n<path class=\"atom-18\" d=\"M 167.3 246.1 Q 167.3 245.1, 167.9 244.5 Q 168.4 243.9, 169.3 243.9 Q 170.2 243.9, 170.7 244.5 Q 171.2 245.1, 171.2 246.1 Q 171.2 247.1, 170.7 247.7 Q 170.2 248.3, 169.3 248.3 Q 168.4 248.3, 167.9 247.7 Q 167.3 247.1, 167.3 246.1 M 169.3 247.8 Q 169.9 247.8, 170.3 247.4 Q 170.6 246.9, 170.6 246.1 Q 170.6 245.3, 170.3 244.8 Q 169.9 244.4, 169.3 244.4 Q 168.6 244.4, 168.3 244.8 Q 167.9 245.3, 167.9 246.1 Q 167.9 247.0, 168.3 247.4 Q 168.6 247.8, 169.3 247.8 \" fill=\"#FF0000\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 284.8,246.1 L 286.0,240.6\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 286.0,240.6 L 287.2,235.1\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 282.1,245.5 L 283.3,240.0\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 283.3,240.0 L 284.5,234.5\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-1 atom-1 atom-2\" d=\"M 285.9,234.8 L 281.7,231.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-1 atom-1 atom-2\" d=\"M 281.7,231.0 L 277.6,227.2\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-9 atom-1 atom-10\" d=\"M 285.9,234.8 L 291.5,233.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-9 atom-1 atom-10\" d=\"M 291.5,233.0 L 297.1,231.2\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-2 atom-2 atom-3\" d=\"M 273.7,226.1 L 268.1,227.9\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-2 atom-2 atom-3\" d=\"M 268.1,227.9 L 262.5,229.6\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-3 atom-3 atom-4\" d=\"M 262.5,229.6 L 252.2,220.3\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-3 atom-3 atom-4\" d=\"M 259.1,230.3 L 251.9,223.7\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-22 atom-8 atom-3\" d=\"M 259.5,243.2 L 262.5,229.6\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-4 atom-4 atom-5\" d=\"M 252.2,220.3 L 239.1,224.5\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-5 atom-5 atom-6\" d=\"M 239.1,224.5 L 236.1,238.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-5 atom-5 atom-6\" d=\"M 241.3,227.1 L 239.2,236.6\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-6 atom-6 atom-7\" d=\"M 236.1,238.0 L 246.3,247.3\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-7 atom-7 atom-8\" d=\"M 246.3,247.3 L 259.5,243.2\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-7 atom-7 atom-8\" d=\"M 247.4,244.1 L 256.7,241.1\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-8 atom-8 atom-9\" d=\"M 259.5,243.2 L 263.8,247.1\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-8 atom-8 atom-9\" d=\"M 263.8,247.1 L 268.1,251.0\" style=\"fill:none;fill-rule:evenodd;stroke:#33CCCC;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-10 atom-10 atom-11\" d=\"M 301.0,232.4 L 305.2,236.2\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-10 atom-10 atom-11\" d=\"M 305.2,236.2 L 309.3,239.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-23 atom-22 atom-10\" d=\"M 302.0,217.1 L 300.8,222.6\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-23 atom-22 atom-10\" d=\"M 300.8,222.6 L 299.6,228.1\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-11 atom-11 atom-12\" d=\"M 309.3,239.9 L 322.5,235.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-12 atom-12 atom-13\" d=\"M 322.5,235.8 L 325.5,222.3\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-13 atom-13 atom-14\" d=\"M 325.5,222.3 L 338.6,218.1\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-20 atom-13 atom-21\" d=\"M 325.5,222.3 L 315.2,212.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-14 atom-14 atom-15\" d=\"M 338.6,218.1 L 342.8,221.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-14 atom-14 atom-15\" d=\"M 342.8,221.8 L 346.9,225.6\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-15 atom-15 atom-16\" d=\"M 348.3,229.9 L 347.1,235.4\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-15 atom-15 atom-16\" d=\"M 347.1,235.4 L 345.9,240.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-24 atom-20 atom-15\" d=\"M 362.1,223.2 L 356.4,225.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-24 atom-20 atom-15\" d=\"M 356.4,225.0 L 350.8,226.8\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-16 atom-16 atom-17\" d=\"M 345.9,240.9 L 356.1,250.3\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-17 atom-17 atom-18\" d=\"M 356.1,250.3 L 361.6,248.5\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-17 atom-17 atom-18\" d=\"M 361.6,248.5 L 367.0,246.8\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-18 atom-18 atom-19\" d=\"M 369.8,243.6 L 371.1,238.1\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-18 atom-18 atom-19\" d=\"M 371.1,238.1 L 372.3,232.6\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-19 atom-19 atom-20\" d=\"M 372.3,232.6 L 362.1,223.2\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-21 atom-21 atom-22\" d=\"M 315.2,212.9 L 302.0,217.1\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"atom-0\" d=\"M 280.9 248.3 Q 280.9 247.3, 281.5 246.7 Q 282.0 246.2, 282.9 246.2 Q 283.8 246.2, 284.3 246.7 Q 284.8 247.3, 284.8 248.3 Q 284.8 249.4, 284.3 249.9 Q 283.8 250.5, 282.9 250.5 Q 282.0 250.5, 281.5 249.9 Q 280.9 249.4, 280.9 248.3 M 282.9 250.0 Q 283.5 250.0, 283.9 249.6 Q 284.2 249.2, 284.2 248.3 Q 284.2 247.5, 283.9 247.1 Q 283.5 246.6, 282.9 246.6 Q 282.2 246.6, 281.9 247.1 Q 281.5 247.5, 281.5 248.3 Q 281.5 249.2, 281.9 249.6 Q 282.2 250.0, 282.9 250.0 \" fill=\"#FF0000\"/>\n<path class=\"atom-2\" d=\"M 274.7 223.3 L 276.1 225.6 Q 276.2 225.8, 276.5 226.2 Q 276.7 226.6, 276.7 226.6 L 276.7 223.3 L 277.3 223.3 L 277.3 227.6 L 276.7 227.6 L 275.2 225.1 Q 275.0 224.8, 274.8 224.5 Q 274.7 224.2, 274.6 224.1 L 274.6 227.6 L 274.0 227.6 L 274.0 223.3 L 274.7 223.3 \" fill=\"#0000FF\"/>\n<path class=\"atom-2\" d=\"M 274.0 218.7 L 274.6 218.7 L 274.6 220.5 L 276.7 220.5 L 276.7 218.7 L 277.3 218.7 L 277.3 222.9 L 276.7 222.9 L 276.7 220.9 L 274.6 220.9 L 274.6 222.9 L 274.0 222.9 L 274.0 218.7 \" fill=\"#0000FF\"/>\n<path class=\"atom-9\" d=\"M 268.4 250.4 L 271.0 250.4 L 271.0 250.9 L 269.0 250.9 L 269.0 252.1 L 270.8 252.1 L 270.8 252.6 L 269.0 252.6 L 269.0 254.6 L 268.4 254.6 L 268.4 250.4 \" fill=\"#33CCCC\"/>\n<path class=\"atom-10\" d=\"M 298.1 228.5 L 299.5 230.7 Q 299.7 231.0, 299.9 231.4 Q 300.1 231.8, 300.1 231.8 L 300.1 228.5 L 300.7 228.5 L 300.7 232.7 L 300.1 232.7 L 298.6 230.3 Q 298.4 230.0, 298.2 229.7 Q 298.1 229.3, 298.0 229.2 L 298.0 232.7 L 297.5 232.7 L 297.5 228.5 L 298.1 228.5 \" fill=\"#0000FF\"/>\n<path class=\"atom-15\" d=\"M 347.9 225.3 L 349.3 227.5 Q 349.5 227.8, 349.7 228.2 Q 349.9 228.6, 349.9 228.6 L 349.9 225.3 L 350.5 225.3 L 350.5 229.5 L 349.9 229.5 L 348.4 227.1 Q 348.2 226.8, 348.0 226.5 Q 347.9 226.1, 347.8 226.0 L 347.8 229.5 L 347.3 229.5 L 347.3 225.3 L 347.9 225.3 \" fill=\"#0000FF\"/>\n<path class=\"atom-18\" d=\"M 367.3 246.1 Q 367.3 245.1, 367.9 244.5 Q 368.4 243.9, 369.3 243.9 Q 370.2 243.9, 370.7 244.5 Q 371.2 245.1, 371.2 246.1 Q 371.2 247.1, 370.7 247.7 Q 370.2 248.3, 369.3 248.3 Q 368.4 248.3, 367.9 247.7 Q 367.3 247.1, 367.3 246.1 M 369.3 247.8 Q 369.9 247.8, 370.3 247.4 Q 370.6 246.9, 370.6 246.1 Q 370.6 245.3, 370.3 244.8 Q 369.9 244.4, 369.3 244.4 Q 368.6 244.4, 368.3 244.8 Q 367.9 245.3, 367.9 246.1 Q 367.9 247.0, 368.3 247.4 Q 368.6 247.8, 369.3 247.8 \" fill=\"#FF0000\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 594.8,268.2 L 589.0,268.2\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 589.0,268.2 L 583.3,268.2\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-1 atom-1 atom-2\" d=\"M 579.5,265.7 L 576.8,260.9\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-1 atom-1 atom-2\" d=\"M 576.8,260.9 L 574.1,256.2\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-2 atom-2 atom-3\" d=\"M 574.1,256.2 L 560.2,256.2\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-3 atom-3 atom-4\" d=\"M 560.2,256.2 L 557.5,251.4\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-3 atom-3 atom-4\" d=\"M 557.5,251.4 L 554.7,246.7\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-4 atom-4 atom-5\" d=\"M 554.7,241.7 L 557.5,237.0\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-4 atom-4 atom-5\" d=\"M 557.5,237.0 L 560.2,232.2\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-7 atom-4 atom-8\" d=\"M 551.3,244.2 L 545.4,244.2\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-7 atom-4 atom-8\" d=\"M 545.4,244.2 L 539.5,244.2\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-5 atom-5 atom-6\" d=\"M 560.2,232.2 L 574.1,232.2\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-6 atom-6 atom-7\" d=\"M 574.1,232.2 L 576.8,227.5\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-6 atom-6 atom-7\" d=\"M 576.8,227.5 L 579.5,222.8\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-8 atom-8 atom-9\" d=\"M 538.3,243.5 L 535.5,248.2\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-8 atom-8 atom-9\" d=\"M 535.5,248.2 L 532.8,253.0\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-8 atom-8 atom-9\" d=\"M 540.6,244.9 L 537.9,249.6\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-8 atom-8 atom-9\" d=\"M 537.9,249.6 L 535.2,254.4\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-9 atom-8 atom-10\" d=\"M 539.5,244.2 L 536.7,239.4\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-9 atom-8 atom-10\" d=\"M 536.7,239.4 L 534.0,234.7\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-10 atom-10 atom-11\" d=\"M 530.6,232.2 L 524.6,232.2\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-10 atom-10 atom-11\" d=\"M 524.6,232.2 L 518.7,232.2\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-11 atom-11 atom-12\" d=\"M 518.7,232.2 L 511.8,244.2\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-11 atom-11 atom-12\" d=\"M 515.3,232.6 L 510.4,241.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-17 atom-16 atom-11\" d=\"M 511.8,220.2 L 518.7,232.2\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-12 atom-12 atom-13\" d=\"M 511.8,244.2 L 497.9,244.2\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-13 atom-13 atom-14\" d=\"M 497.9,244.2 L 491.0,232.2\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-13 atom-13 atom-14\" d=\"M 499.3,241.0 L 494.4,232.6\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-14 atom-14 atom-15\" d=\"M 491.0,232.2 L 497.9,220.2\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-15 atom-15 atom-16\" d=\"M 497.9,220.2 L 511.8,220.2\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-15 atom-15 atom-16\" d=\"M 500.0,223.0 L 509.7,223.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-16 atom-16 atom-17\" d=\"M 511.8,220.2 L 514.5,215.6\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-16 atom-16 atom-17\" d=\"M 514.5,215.6 L 517.1,210.9\" style=\"fill:none;fill-rule:evenodd;stroke:#00CC00;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"atom-1\" d=\"M 579.0 268.2 Q 579.0 267.2, 579.5 266.6 Q 580.0 266.0, 581.0 266.0 Q 581.9 266.0, 582.4 266.6 Q 582.9 267.2, 582.9 268.2 Q 582.9 269.2, 582.4 269.8 Q 581.9 270.4, 581.0 270.4 Q 580.0 270.4, 579.5 269.8 Q 579.0 269.2, 579.0 268.2 M 581.0 269.9 Q 581.6 269.9, 582.0 269.5 Q 582.3 269.0, 582.3 268.2 Q 582.3 267.3, 582.0 266.9 Q 581.6 266.5, 581.0 266.5 Q 580.3 266.5, 580.0 266.9 Q 579.6 267.3, 579.6 268.2 Q 579.6 269.0, 580.0 269.5 Q 580.3 269.9, 581.0 269.9 \" fill=\"#FF0000\"/>\n<path class=\"atom-4\" d=\"M 552.4 242.1 L 553.7 244.3 Q 553.9 244.5, 554.1 244.9 Q 554.3 245.3, 554.3 245.4 L 554.3 242.1 L 554.9 242.1 L 554.9 246.3 L 554.3 246.3 L 552.8 243.9 Q 552.7 243.6, 552.5 243.2 Q 552.3 242.9, 552.2 242.8 L 552.2 246.3 L 551.7 246.3 L 551.7 242.1 L 552.4 242.1 \" fill=\"#0000FF\"/>\n<path class=\"atom-7\" d=\"M 579.0 220.2 Q 579.0 219.2, 579.5 218.6 Q 580.0 218.1, 581.0 218.1 Q 581.9 218.1, 582.4 218.6 Q 582.9 219.2, 582.9 220.2 Q 582.9 221.3, 582.4 221.9 Q 581.9 222.4, 581.0 222.4 Q 580.0 222.4, 579.5 221.9 Q 579.0 221.3, 579.0 220.2 M 581.0 222.0 Q 581.6 222.0, 582.0 221.5 Q 582.3 221.1, 582.3 220.2 Q 582.3 219.4, 582.0 219.0 Q 581.6 218.6, 581.0 218.6 Q 580.3 218.6, 580.0 219.0 Q 579.6 219.4, 579.6 220.2 Q 579.6 221.1, 580.0 221.5 Q 580.3 222.0, 581.0 222.0 \" fill=\"#FF0000\"/>\n<path class=\"atom-7\" d=\"M 583.4 218.1 L 584.0 218.1 L 584.0 219.9 L 586.2 219.9 L 586.2 218.1 L 586.8 218.1 L 586.8 222.4 L 586.2 222.4 L 586.2 220.4 L 584.0 220.4 L 584.0 222.4 L 583.4 222.4 L 583.4 218.1 \" fill=\"#FF0000\"/>\n<path class=\"atom-9\" d=\"M 530.6 256.2 Q 530.6 255.2, 531.1 254.6 Q 531.6 254.0, 532.5 254.0 Q 533.5 254.0, 534.0 254.6 Q 534.5 255.2, 534.5 256.2 Q 534.5 257.2, 534.0 257.8 Q 533.5 258.4, 532.5 258.4 Q 531.6 258.4, 531.1 257.8 Q 530.6 257.2, 530.6 256.2 M 532.5 257.9 Q 533.2 257.9, 533.5 257.5 Q 533.9 257.0, 533.9 256.2 Q 533.9 255.4, 533.5 254.9 Q 533.2 254.5, 532.5 254.5 Q 531.9 254.5, 531.5 254.9 Q 531.2 255.4, 531.2 256.2 Q 531.2 257.1, 531.5 257.5 Q 531.9 257.9, 532.5 257.9 \" fill=\"#FF0000\"/>\n<path class=\"atom-10\" d=\"M 531.6 230.1 L 533.0 232.3 Q 533.1 232.6, 533.3 233.0 Q 533.6 233.4, 533.6 233.4 L 533.6 230.1 L 534.1 230.1 L 534.1 234.3 L 533.6 234.3 L 532.1 231.9 Q 531.9 231.6, 531.7 231.3 Q 531.5 230.9, 531.5 230.8 L 531.5 234.3 L 530.9 234.3 L 530.9 230.1 L 531.6 230.1 \" fill=\"#0000FF\"/>\n<path class=\"atom-10\" d=\"M 534.7 230.1 L 535.2 230.1 L 535.2 231.9 L 537.4 231.9 L 537.4 230.1 L 538.0 230.1 L 538.0 234.3 L 537.4 234.3 L 537.4 232.4 L 535.2 232.4 L 535.2 234.3 L 534.7 234.3 L 534.7 230.1 \" fill=\"#0000FF\"/>\n<path class=\"atom-17\" d=\"M 517.1 208.4 Q 517.1 207.3, 517.5 206.8 Q 518.0 206.2, 519.0 206.2 Q 519.9 206.2, 520.3 206.8 L 519.9 207.2 Q 519.6 206.7, 519.0 206.7 Q 518.3 206.7, 518.0 207.1 Q 517.7 207.6, 517.7 208.4 Q 517.7 209.2, 518.0 209.7 Q 518.4 210.1, 519.1 210.1 Q 519.5 210.1, 520.1 209.8 L 520.2 210.3 Q 520.0 210.4, 519.7 210.5 Q 519.3 210.6, 519.0 210.6 Q 518.0 210.6, 517.5 210.0 Q 517.1 209.4, 517.1 208.4 \" fill=\"#00CC00\"/>\n<path class=\"atom-17\" d=\"M 520.8 206.0 L 521.4 206.0 L 521.4 210.5 L 520.8 210.5 L 520.8 206.0 \" fill=\"#00CC00\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 640.9,271.9 L 642.1,266.4\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 642.1,266.4 L 643.3,260.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 643.6,272.5 L 644.6,267.8\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 644.6,267.8 L 645.7,263.1\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 638.2,271.3 L 639.2,266.6\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 639.2,266.6 L 640.2,261.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-1 atom-1 atom-2\" d=\"M 643.3,260.8 L 646.3,247.3\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-2 atom-2 atom-3\" d=\"M 646.3,247.3 L 659.5,243.2\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-2 atom-2 atom-3\" d=\"M 647.4,244.1 L 656.7,241.1\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-23 atom-23 atom-2\" d=\"M 636.1,238.0 L 646.3,247.3\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-3 atom-3 atom-4\" d=\"M 659.5,243.2 L 662.5,229.6\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-4 atom-4 atom-5\" d=\"M 662.5,229.6 L 668.1,227.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-4 atom-4 atom-5\" d=\"M 668.1,227.9 L 673.7,226.1\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-20 atom-4 atom-21\" d=\"M 662.5,229.6 L 652.2,220.3\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-20 atom-4 atom-21\" d=\"M 659.1,230.3 L 651.9,223.7\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-5 atom-5 atom-6\" d=\"M 677.6,227.2 L 681.7,231.0\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-5 atom-5 atom-6\" d=\"M 681.7,231.0 L 685.9,234.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-6 atom-6 atom-7\" d=\"M 684.5,234.5 L 683.3,240.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-6 atom-6 atom-7\" d=\"M 683.3,240.0 L 682.1,245.5\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-6 atom-6 atom-7\" d=\"M 687.2,235.1 L 686.0,240.6\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-6 atom-6 atom-7\" d=\"M 686.0,240.6 L 684.8,246.1\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-7 atom-6 atom-8\" d=\"M 685.9,234.8 L 691.5,233.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-7 atom-6 atom-8\" d=\"M 691.5,233.0 L 697.1,231.2\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-8 atom-8 atom-9\" d=\"M 701.0,232.4 L 705.2,236.2\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-8 atom-8 atom-9\" d=\"M 705.2,236.2 L 709.3,239.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-24 atom-20 atom-8\" d=\"M 702.0,217.1 L 700.8,222.6\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-24 atom-20 atom-8\" d=\"M 700.8,222.6 L 699.6,228.1\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-9 atom-9 atom-10\" d=\"M 709.3,239.9 L 722.5,235.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-10 atom-10 atom-11\" d=\"M 722.5,235.8 L 725.5,222.3\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-11 atom-11 atom-12\" d=\"M 725.5,222.3 L 738.6,218.1\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-18 atom-11 atom-19\" d=\"M 725.5,222.3 L 715.2,212.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-12 atom-12 atom-13\" d=\"M 738.6,218.1 L 742.8,221.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-12 atom-12 atom-13\" d=\"M 742.8,221.8 L 746.9,225.6\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-13 atom-13 atom-14\" d=\"M 748.3,229.9 L 747.1,235.4\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-13 atom-13 atom-14\" d=\"M 747.1,235.4 L 745.9,240.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-25 atom-18 atom-13\" d=\"M 762.1,223.2 L 756.4,225.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-25 atom-18 atom-13\" d=\"M 756.4,225.0 L 750.8,226.8\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-14 atom-14 atom-15\" d=\"M 745.9,240.9 L 756.1,250.3\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-15 atom-15 atom-16\" d=\"M 756.1,250.3 L 761.6,248.5\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-15 atom-15 atom-16\" d=\"M 761.6,248.5 L 767.0,246.8\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-16 atom-16 atom-17\" d=\"M 769.8,243.6 L 771.1,238.1\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-16 atom-16 atom-17\" d=\"M 771.1,238.1 L 772.3,232.6\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-17 atom-17 atom-18\" d=\"M 772.3,232.6 L 762.1,223.2\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-19 atom-19 atom-20\" d=\"M 715.2,212.9 L 702.0,217.1\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-21 atom-21 atom-22\" d=\"M 652.2,220.3 L 639.1,224.5\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-22 atom-22 atom-23\" d=\"M 639.1,224.5 L 636.1,238.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-22 atom-22 atom-23\" d=\"M 641.3,227.1 L 639.2,236.6\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"atom-0\" d=\"M 639.4 272.2 L 640.8 274.5 Q 640.9 274.7, 641.2 275.1 Q 641.4 275.5, 641.4 275.5 L 641.4 272.2 L 642.0 272.2 L 642.0 276.5 L 641.4 276.5 L 639.9 274.0 Q 639.7 273.7, 639.5 273.4 Q 639.3 273.1, 639.3 273.0 L 639.3 276.5 L 638.7 276.5 L 638.7 272.2 L 639.4 272.2 \" fill=\"#0000FF\"/>\n<path class=\"atom-5\" d=\"M 674.7 223.3 L 676.1 225.6 Q 676.2 225.8, 676.5 226.2 Q 676.7 226.6, 676.7 226.6 L 676.7 223.3 L 677.3 223.3 L 677.3 227.6 L 676.7 227.6 L 675.2 225.1 Q 675.0 224.8, 674.8 224.5 Q 674.7 224.2, 674.6 224.1 L 674.6 227.6 L 674.0 227.6 L 674.0 223.3 L 674.7 223.3 \" fill=\"#0000FF\"/>\n<path class=\"atom-5\" d=\"M 674.0 218.7 L 674.6 218.7 L 674.6 220.5 L 676.7 220.5 L 676.7 218.7 L 677.3 218.7 L 677.3 222.9 L 676.7 222.9 L 676.7 220.9 L 674.6 220.9 L 674.6 222.9 L 674.0 222.9 L 674.0 218.7 \" fill=\"#0000FF\"/>\n<path class=\"atom-7\" d=\"M 680.9 248.3 Q 680.9 247.3, 681.5 246.7 Q 682.0 246.2, 682.9 246.2 Q 683.8 246.2, 684.3 246.7 Q 684.8 247.3, 684.8 248.3 Q 684.8 249.4, 684.3 249.9 Q 683.8 250.5, 682.9 250.5 Q 682.0 250.5, 681.5 249.9 Q 680.9 249.4, 680.9 248.3 M 682.9 250.0 Q 683.5 250.0, 683.9 249.6 Q 684.2 249.2, 684.2 248.3 Q 684.2 247.5, 683.9 247.1 Q 683.5 246.6, 682.9 246.6 Q 682.2 246.6, 681.9 247.1 Q 681.5 247.5, 681.5 248.3 Q 681.5 249.2, 681.9 249.6 Q 682.2 250.0, 682.9 250.0 \" fill=\"#FF0000\"/>\n<path class=\"atom-8\" d=\"M 698.1 228.5 L 699.5 230.7 Q 699.7 231.0, 699.9 231.4 Q 700.1 231.8, 700.1 231.8 L 700.1 228.5 L 700.7 228.5 L 700.7 232.7 L 700.1 232.7 L 698.6 230.3 Q 698.4 230.0, 698.2 229.7 Q 698.1 229.3, 698.0 229.2 L 698.0 232.7 L 697.5 232.7 L 697.5 228.5 L 698.1 228.5 \" fill=\"#0000FF\"/>\n<path class=\"atom-13\" d=\"M 747.9 225.3 L 749.3 227.5 Q 749.5 227.8, 749.7 228.2 Q 749.9 228.6, 749.9 228.6 L 749.9 225.3 L 750.5 225.3 L 750.5 229.5 L 749.9 229.5 L 748.4 227.1 Q 748.2 226.8, 748.0 226.5 Q 747.9 226.1, 747.8 226.0 L 747.8 229.5 L 747.3 229.5 L 747.3 225.3 L 747.9 225.3 \" fill=\"#0000FF\"/>\n<path class=\"atom-16\" d=\"M 767.3 246.1 Q 767.3 245.1, 767.9 244.5 Q 768.4 243.9, 769.3 243.9 Q 770.2 243.9, 770.7 244.5 Q 771.2 245.1, 771.2 246.1 Q 771.2 247.1, 770.7 247.7 Q 770.2 248.3, 769.3 248.3 Q 768.4 248.3, 767.9 247.7 Q 767.3 247.1, 767.3 246.1 M 769.3 247.8 Q 769.9 247.8, 770.3 247.4 Q 770.6 246.9, 770.6 246.1 Q 770.6 245.3, 770.3 244.8 Q 769.9 244.4, 769.3 244.4 Q 768.6 244.4, 768.3 244.8 Q 767.9 245.3, 767.9 246.1 Q 767.9 247.0, 768.3 247.4 Q 768.6 247.8, 769.3 247.8 \" fill=\"#FF0000\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 23.3,381.1 L 29.1,380.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 29.1,380.0 L 34.9,378.9\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-1 atom-1 atom-2\" d=\"M 37.7,376.0 L 39.5,370.7\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-1 atom-1 atom-2\" d=\"M 39.5,370.7 L 41.4,365.4\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-2 atom-1 atom-3\" d=\"M 38.8,380.7 L 42.4,384.8\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-2 atom-1 atom-3\" d=\"M 42.4,384.8 L 46.0,388.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-3 atom-3 atom-4\" d=\"M 46.0,388.9 L 59.6,386.2\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-4 atom-4 atom-5\" d=\"M 59.6,386.2 L 68.7,396.7\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-20 atom-20 atom-4\" d=\"M 64.0,373.1 L 59.6,386.2\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-5 atom-5 atom-6\" d=\"M 68.7,396.7 L 82.2,394.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-6 atom-6 atom-7\" d=\"M 82.2,394.0 L 84.1,388.7\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-6 atom-6 atom-7\" d=\"M 84.1,388.7 L 85.9,383.4\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-7 atom-7 atom-8\" d=\"M 88.7,380.5 L 94.5,379.4\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-7 atom-7 atom-8\" d=\"M 94.5,379.4 L 100.3,378.2\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-18 atom-7 atom-19\" d=\"M 84.8,378.6 L 81.2,374.6\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-18 atom-7 atom-19\" d=\"M 81.2,374.6 L 77.6,370.5\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-8 atom-8 atom-9\" d=\"M 101.6,378.7 L 103.4,373.4\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-8 atom-8 atom-9\" d=\"M 103.4,373.4 L 105.2,368.1\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-8 atom-8 atom-9\" d=\"M 99.0,377.8 L 100.8,372.5\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-8 atom-8 atom-9\" d=\"M 100.8,372.5 L 102.6,367.2\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-9 atom-8 atom-10\" d=\"M 100.3,378.2 L 103.9,382.3\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-9 atom-8 atom-10\" d=\"M 103.9,382.3 L 107.5,386.4\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-10 atom-10 atom-11\" d=\"M 111.4,388.3 L 117.2,387.1\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-10 atom-10 atom-11\" d=\"M 117.2,387.1 L 123.0,386.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-11 atom-11 atom-12\" d=\"M 123.0,386.0 L 132.1,396.4\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-11 atom-11 atom-12\" d=\"M 126.4,385.7 L 132.8,393.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-21 atom-18 atom-11\" d=\"M 127.5,372.9 L 123.0,386.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-12 atom-12 atom-13\" d=\"M 132.1,396.4 L 145.7,393.7\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-13 atom-13 atom-14\" d=\"M 145.7,393.7 L 150.1,380.6\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-13 atom-13 atom-14\" d=\"M 143.7,390.9 L 146.9,381.7\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-14 atom-14 atom-15\" d=\"M 150.1,380.6 L 155.9,379.5\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-14 atom-14 atom-15\" d=\"M 155.9,379.5 L 161.7,378.4\" style=\"fill:none;fill-rule:evenodd;stroke:#00CC00;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-15 atom-14 atom-16\" d=\"M 150.1,380.6 L 141.0,370.2\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-16 atom-16 atom-17\" d=\"M 141.0,370.2 L 142.8,365.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-16 atom-16 atom-17\" d=\"M 142.8,365.0 L 144.6,359.8\" style=\"fill:none;fill-rule:evenodd;stroke:#00CC00;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-17 atom-16 atom-18\" d=\"M 141.0,370.2 L 127.5,372.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-17 atom-16 atom-18\" d=\"M 139.5,373.3 L 130.0,375.2\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-19 atom-19 atom-20\" d=\"M 77.6,370.5 L 64.0,373.1\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"atom-1\" d=\"M 35.9 376.3 L 37.3 378.6 Q 37.5 378.8, 37.7 379.2 Q 37.9 379.6, 37.9 379.6 L 37.9 376.3 L 38.5 376.3 L 38.5 380.6 L 37.9 380.6 L 36.4 378.1 Q 36.2 377.8, 36.1 377.5 Q 35.9 377.2, 35.8 377.1 L 35.8 380.6 L 35.3 380.6 L 35.3 376.3 L 35.9 376.3 \" fill=\"#0000FF\"/>\n<path class=\"atom-7\" d=\"M 85.8 378.8 L 87.2 381.0 Q 87.3 381.2, 87.5 381.6 Q 87.8 382.0, 87.8 382.1 L 87.8 378.8 L 88.3 378.8 L 88.3 383.0 L 87.8 383.0 L 86.3 380.6 Q 86.1 380.3, 85.9 379.9 Q 85.7 379.6, 85.7 379.5 L 85.7 383.0 L 85.1 383.0 L 85.1 378.8 L 85.8 378.8 \" fill=\"#0000FF\"/>\n<path class=\"atom-9\" d=\"M 102.8 365.1 Q 102.8 364.1, 103.3 363.5 Q 103.8 363.0, 104.8 363.0 Q 105.7 363.0, 106.2 363.5 Q 106.7 364.1, 106.7 365.1 Q 106.7 366.2, 106.2 366.8 Q 105.7 367.3, 104.8 367.3 Q 103.8 367.3, 103.3 366.8 Q 102.8 366.2, 102.8 365.1 M 104.8 366.9 Q 105.4 366.9, 105.8 366.4 Q 106.1 366.0, 106.1 365.1 Q 106.1 364.3, 105.8 363.9 Q 105.4 363.5, 104.8 363.5 Q 104.1 363.5, 103.8 363.9 Q 103.4 364.3, 103.4 365.1 Q 103.4 366.0, 103.8 366.4 Q 104.1 366.9, 104.8 366.9 \" fill=\"#FF0000\"/>\n<path class=\"atom-10\" d=\"M 108.5 386.5 L 109.9 388.8 Q 110.0 389.0, 110.2 389.4 Q 110.4 389.8, 110.5 389.8 L 110.5 386.5 L 111.0 386.5 L 111.0 390.8 L 110.4 390.8 L 108.9 388.3 Q 108.8 388.0, 108.6 387.7 Q 108.4 387.4, 108.3 387.3 L 108.3 390.8 L 107.8 390.8 L 107.8 386.5 L 108.5 386.5 \" fill=\"#0000FF\"/>\n<path class=\"atom-10\" d=\"M 107.7 391.2 L 108.3 391.2 L 108.3 393.0 L 110.5 393.0 L 110.5 391.2 L 111.1 391.2 L 111.1 395.4 L 110.5 395.4 L 110.5 393.5 L 108.3 393.5 L 108.3 395.4 L 107.7 395.4 L 107.7 391.2 \" fill=\"#0000FF\"/>\n<path class=\"atom-15\" d=\"M 162.1 378.1 Q 162.1 377.1, 162.6 376.5 Q 163.1 375.9, 164.0 375.9 Q 164.9 375.9, 165.4 376.6 L 165.0 376.9 Q 164.6 376.4, 164.0 376.4 Q 163.4 376.4, 163.0 376.9 Q 162.7 377.3, 162.7 378.1 Q 162.7 378.9, 163.0 379.4 Q 163.4 379.8, 164.1 379.8 Q 164.6 379.8, 165.1 379.5 L 165.3 380.0 Q 165.0 380.1, 164.7 380.2 Q 164.4 380.3, 164.0 380.3 Q 163.1 380.3, 162.6 379.7 Q 162.1 379.2, 162.1 378.1 \" fill=\"#00CC00\"/>\n<path class=\"atom-15\" d=\"M 165.9 375.7 L 166.4 375.7 L 166.4 380.2 L 165.9 380.2 L 165.9 375.7 \" fill=\"#00CC00\"/>\n<path class=\"atom-17\" d=\"M 143.9 357.3 Q 143.9 356.2, 144.4 355.7 Q 144.9 355.1, 145.8 355.1 Q 146.7 355.1, 147.2 355.7 L 146.8 356.0 Q 146.4 355.6, 145.8 355.6 Q 145.2 355.6, 144.8 356.0 Q 144.5 356.4, 144.5 357.3 Q 144.5 358.1, 144.8 358.5 Q 145.2 359.0, 145.9 359.0 Q 146.3 359.0, 146.9 358.7 L 147.1 359.1 Q 146.8 359.3, 146.5 359.4 Q 146.2 359.4, 145.8 359.4 Q 144.9 359.4, 144.4 358.9 Q 143.9 358.3, 143.9 357.3 \" fill=\"#00CC00\"/>\n<path class=\"atom-17\" d=\"M 147.7 354.8 L 148.2 354.8 L 148.2 359.4 L 147.7 359.4 L 147.7 354.8 \" fill=\"#00CC00\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 231.8,351.6 L 230.6,357.1\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 230.6,357.1 L 229.4,362.7\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-1 atom-1 atom-2\" d=\"M 231.1,367.2 L 235.1,370.9\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-1 atom-1 atom-2\" d=\"M 235.1,370.9 L 239.1,374.5\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-2 atom-2 atom-3\" d=\"M 239.1,374.5 L 236.1,388.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-2 atom-2 atom-3\" d=\"M 241.3,377.1 L 239.2,386.6\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-23 atom-23 atom-2\" d=\"M 252.2,370.3 L 239.1,374.5\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-3 atom-3 atom-4\" d=\"M 236.1,388.0 L 246.3,397.3\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-4 atom-4 atom-5\" d=\"M 246.3,397.3 L 259.5,393.2\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-4 atom-4 atom-5\" d=\"M 247.4,394.1 L 256.7,391.1\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-5 atom-5 atom-6\" d=\"M 259.5,393.2 L 262.5,379.6\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-6 atom-6 atom-7\" d=\"M 262.5,379.6 L 268.1,377.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-6 atom-6 atom-7\" d=\"M 268.1,377.9 L 273.7,376.1\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-22 atom-6 atom-23\" d=\"M 262.5,379.6 L 252.2,370.3\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-22 atom-6 atom-23\" d=\"M 259.1,380.3 L 251.9,373.7\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-7 atom-7 atom-8\" d=\"M 277.6,377.2 L 281.7,381.0\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-7 atom-7 atom-8\" d=\"M 281.7,381.0 L 285.9,384.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-8 atom-8 atom-9\" d=\"M 284.5,384.5 L 283.3,390.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-8 atom-8 atom-9\" d=\"M 283.3,390.0 L 282.1,395.5\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-8 atom-8 atom-9\" d=\"M 287.2,385.1 L 286.0,390.6\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-8 atom-8 atom-9\" d=\"M 286.0,390.6 L 284.8,396.1\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-9 atom-8 atom-10\" d=\"M 285.9,384.8 L 291.5,383.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-9 atom-8 atom-10\" d=\"M 291.5,383.0 L 297.1,381.2\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-10 atom-10 atom-11\" d=\"M 301.0,382.4 L 305.2,386.2\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-10 atom-10 atom-11\" d=\"M 305.2,386.2 L 309.3,389.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-24 atom-22 atom-10\" d=\"M 302.0,367.1 L 300.8,372.6\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-24 atom-22 atom-10\" d=\"M 300.8,372.6 L 299.6,378.1\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-11 atom-11 atom-12\" d=\"M 309.3,389.9 L 322.5,385.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-12 atom-12 atom-13\" d=\"M 322.5,385.8 L 325.5,372.3\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-13 atom-13 atom-14\" d=\"M 325.5,372.3 L 338.6,368.1\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-20 atom-13 atom-21\" d=\"M 325.5,372.3 L 315.2,362.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-14 atom-14 atom-15\" d=\"M 338.6,368.1 L 342.8,371.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-14 atom-14 atom-15\" d=\"M 342.8,371.8 L 346.9,375.6\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-15 atom-15 atom-16\" d=\"M 348.3,379.9 L 347.1,385.4\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-15 atom-15 atom-16\" d=\"M 347.1,385.4 L 345.9,390.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-25 atom-20 atom-15\" d=\"M 362.1,373.2 L 356.4,375.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-25 atom-20 atom-15\" d=\"M 356.4,375.0 L 350.8,376.8\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-16 atom-16 atom-17\" d=\"M 345.9,390.9 L 356.1,400.3\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-17 atom-17 atom-18\" d=\"M 356.1,400.3 L 361.6,398.5\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-17 atom-17 atom-18\" d=\"M 361.6,398.5 L 367.0,396.8\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-18 atom-18 atom-19\" d=\"M 369.8,393.6 L 371.1,388.1\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-18 atom-18 atom-19\" d=\"M 371.1,388.1 L 372.3,382.6\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-19 atom-19 atom-20\" d=\"M 372.3,382.6 L 362.1,373.2\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-21 atom-21 atom-22\" d=\"M 315.2,362.9 L 302.0,367.1\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"atom-1\" d=\"M 226.9 365.2 Q 226.9 364.1, 227.4 363.6 Q 227.9 363.0, 228.8 363.0 Q 229.8 363.0, 230.3 363.6 Q 230.8 364.1, 230.8 365.2 Q 230.8 366.2, 230.3 366.8 Q 229.8 367.4, 228.8 367.4 Q 227.9 367.4, 227.4 366.8 Q 226.9 366.2, 226.9 365.2 M 228.8 366.9 Q 229.5 366.9, 229.8 366.4 Q 230.2 366.0, 230.2 365.2 Q 230.2 364.3, 229.8 363.9 Q 229.5 363.5, 228.8 363.5 Q 228.2 363.5, 227.8 363.9 Q 227.5 364.3, 227.5 365.2 Q 227.5 366.0, 227.8 366.4 Q 228.2 366.9, 228.8 366.9 \" fill=\"#FF0000\"/>\n<path class=\"atom-7\" d=\"M 274.7 373.3 L 276.1 375.6 Q 276.2 375.8, 276.5 376.2 Q 276.7 376.6, 276.7 376.6 L 276.7 373.3 L 277.3 373.3 L 277.3 377.6 L 276.7 377.6 L 275.2 375.1 Q 275.0 374.8, 274.8 374.5 Q 274.7 374.2, 274.6 374.1 L 274.6 377.6 L 274.0 377.6 L 274.0 373.3 L 274.7 373.3 \" fill=\"#0000FF\"/>\n<path class=\"atom-7\" d=\"M 274.0 368.7 L 274.6 368.7 L 274.6 370.5 L 276.7 370.5 L 276.7 368.7 L 277.3 368.7 L 277.3 372.9 L 276.7 372.9 L 276.7 370.9 L 274.6 370.9 L 274.6 372.9 L 274.0 372.9 L 274.0 368.7 \" fill=\"#0000FF\"/>\n<path class=\"atom-9\" d=\"M 280.9 398.3 Q 280.9 397.3, 281.5 396.7 Q 282.0 396.2, 282.9 396.2 Q 283.8 396.2, 284.3 396.7 Q 284.8 397.3, 284.8 398.3 Q 284.8 399.4, 284.3 399.9 Q 283.8 400.5, 282.9 400.5 Q 282.0 400.5, 281.5 399.9 Q 280.9 399.4, 280.9 398.3 M 282.9 400.0 Q 283.5 400.0, 283.9 399.6 Q 284.2 399.2, 284.2 398.3 Q 284.2 397.5, 283.9 397.1 Q 283.5 396.6, 282.9 396.6 Q 282.2 396.6, 281.9 397.1 Q 281.5 397.5, 281.5 398.3 Q 281.5 399.2, 281.9 399.6 Q 282.2 400.0, 282.9 400.0 \" fill=\"#FF0000\"/>\n<path class=\"atom-10\" d=\"M 298.1 378.5 L 299.5 380.7 Q 299.7 381.0, 299.9 381.4 Q 300.1 381.8, 300.1 381.8 L 300.1 378.5 L 300.7 378.5 L 300.7 382.7 L 300.1 382.7 L 298.6 380.3 Q 298.4 380.0, 298.2 379.7 Q 298.1 379.3, 298.0 379.2 L 298.0 382.7 L 297.5 382.7 L 297.5 378.5 L 298.1 378.5 \" fill=\"#0000FF\"/>\n<path class=\"atom-15\" d=\"M 347.9 375.3 L 349.3 377.5 Q 349.5 377.8, 349.7 378.2 Q 349.9 378.6, 349.9 378.6 L 349.9 375.3 L 350.5 375.3 L 350.5 379.5 L 349.9 379.5 L 348.4 377.1 Q 348.2 376.8, 348.0 376.5 Q 347.9 376.1, 347.8 376.0 L 347.8 379.5 L 347.3 379.5 L 347.3 375.3 L 347.9 375.3 \" fill=\"#0000FF\"/>\n<path class=\"atom-18\" d=\"M 367.3 396.1 Q 367.3 395.1, 367.9 394.5 Q 368.4 393.9, 369.3 393.9 Q 370.2 393.9, 370.7 394.5 Q 371.2 395.1, 371.2 396.1 Q 371.2 397.1, 370.7 397.7 Q 370.2 398.3, 369.3 398.3 Q 368.4 398.3, 367.9 397.7 Q 367.3 397.1, 367.3 396.1 M 369.3 397.8 Q 369.9 397.8, 370.3 397.4 Q 370.6 396.9, 370.6 396.1 Q 370.6 395.3, 370.3 394.8 Q 369.9 394.4, 369.3 394.4 Q 368.6 394.4, 368.3 394.8 Q 367.9 395.3, 367.9 396.1 Q 367.9 397.0, 368.3 397.4 Q 368.6 397.8, 369.3 397.8 \" fill=\"#FF0000\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 422.9,392.2 L 436.1,388.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-1 atom-1 atom-2\" d=\"M 436.1,388.0 L 439.1,374.5\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-1 atom-1 atom-2\" d=\"M 439.2,386.6 L 441.3,377.1\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-23 atom-22 atom-1\" d=\"M 446.3,397.3 L 436.1,388.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-2 atom-2 atom-3\" d=\"M 439.1,374.5 L 452.2,370.3\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-3 atom-3 atom-4\" d=\"M 452.2,370.3 L 462.5,379.6\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-3 atom-3 atom-4\" d=\"M 451.9,373.7 L 459.1,380.3\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-4 atom-4 atom-5\" d=\"M 462.5,379.6 L 468.1,377.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-4 atom-4 atom-5\" d=\"M 468.1,377.9 L 473.7,376.1\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-20 atom-4 atom-21\" d=\"M 462.5,379.6 L 459.5,393.2\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-5 atom-5 atom-6\" d=\"M 477.6,377.2 L 481.7,381.0\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-5 atom-5 atom-6\" d=\"M 481.7,381.0 L 485.9,384.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-6 atom-6 atom-7\" d=\"M 484.5,384.5 L 483.3,390.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-6 atom-6 atom-7\" d=\"M 483.3,390.0 L 482.1,395.5\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-6 atom-6 atom-7\" d=\"M 487.2,385.1 L 486.0,390.6\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-6 atom-6 atom-7\" d=\"M 486.0,390.6 L 484.8,396.1\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-7 atom-6 atom-8\" d=\"M 485.9,384.8 L 491.5,383.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-7 atom-6 atom-8\" d=\"M 491.5,383.0 L 497.1,381.2\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-8 atom-8 atom-9\" d=\"M 501.0,382.4 L 505.2,386.2\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-8 atom-8 atom-9\" d=\"M 505.2,386.2 L 509.3,389.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-24 atom-20 atom-8\" d=\"M 502.0,367.1 L 500.8,372.6\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-24 atom-20 atom-8\" d=\"M 500.8,372.6 L 499.6,378.1\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-9 atom-9 atom-10\" d=\"M 509.3,389.9 L 522.5,385.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-10 atom-10 atom-11\" d=\"M 522.5,385.8 L 525.5,372.3\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-11 atom-11 atom-12\" d=\"M 525.5,372.3 L 538.6,368.1\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-18 atom-11 atom-19\" d=\"M 525.5,372.3 L 515.2,362.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-12 atom-12 atom-13\" d=\"M 538.6,368.1 L 542.8,371.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-12 atom-12 atom-13\" d=\"M 542.8,371.8 L 546.9,375.6\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-13 atom-13 atom-14\" d=\"M 548.3,379.9 L 547.1,385.4\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-13 atom-13 atom-14\" d=\"M 547.1,385.4 L 545.9,390.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-25 atom-18 atom-13\" d=\"M 562.1,373.2 L 556.4,375.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-25 atom-18 atom-13\" d=\"M 556.4,375.0 L 550.8,376.8\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-14 atom-14 atom-15\" d=\"M 545.9,390.9 L 556.1,400.3\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-15 atom-15 atom-16\" d=\"M 556.1,400.3 L 561.6,398.5\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-15 atom-15 atom-16\" d=\"M 561.6,398.5 L 567.0,396.8\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-16 atom-16 atom-17\" d=\"M 569.8,393.6 L 571.1,388.1\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-16 atom-16 atom-17\" d=\"M 571.1,388.1 L 572.3,382.6\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-17 atom-17 atom-18\" d=\"M 572.3,382.6 L 562.1,373.2\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-19 atom-19 atom-20\" d=\"M 515.2,362.9 L 502.0,367.1\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-21 atom-21 atom-22\" d=\"M 459.5,393.2 L 446.3,397.3\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-21 atom-21 atom-22\" d=\"M 456.7,391.1 L 447.4,394.1\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-22 atom-22 atom-23\" d=\"M 446.3,397.3 L 445.1,402.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-22 atom-22 atom-23\" d=\"M 445.1,402.9 L 443.9,408.4\" style=\"fill:none;fill-rule:evenodd;stroke:#33CCCC;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"atom-5\" d=\"M 474.7 373.3 L 476.1 375.6 Q 476.2 375.8, 476.5 376.2 Q 476.7 376.6, 476.7 376.6 L 476.7 373.3 L 477.3 373.3 L 477.3 377.6 L 476.7 377.6 L 475.2 375.1 Q 475.0 374.8, 474.8 374.5 Q 474.7 374.2, 474.6 374.1 L 474.6 377.6 L 474.0 377.6 L 474.0 373.3 L 474.7 373.3 \" fill=\"#0000FF\"/>\n<path class=\"atom-5\" d=\"M 474.0 368.7 L 474.6 368.7 L 474.6 370.5 L 476.7 370.5 L 476.7 368.7 L 477.3 368.7 L 477.3 372.9 L 476.7 372.9 L 476.7 370.9 L 474.6 370.9 L 474.6 372.9 L 474.0 372.9 L 474.0 368.7 \" fill=\"#0000FF\"/>\n<path class=\"atom-7\" d=\"M 480.9 398.3 Q 480.9 397.3, 481.5 396.7 Q 482.0 396.2, 482.9 396.2 Q 483.8 396.2, 484.3 396.7 Q 484.8 397.3, 484.8 398.3 Q 484.8 399.4, 484.3 399.9 Q 483.8 400.5, 482.9 400.5 Q 482.0 400.5, 481.5 399.9 Q 480.9 399.4, 480.9 398.3 M 482.9 400.0 Q 483.5 400.0, 483.9 399.6 Q 484.2 399.2, 484.2 398.3 Q 484.2 397.5, 483.9 397.1 Q 483.5 396.6, 482.9 396.6 Q 482.2 396.6, 481.9 397.1 Q 481.5 397.5, 481.5 398.3 Q 481.5 399.2, 481.9 399.6 Q 482.2 400.0, 482.9 400.0 \" fill=\"#FF0000\"/>\n<path class=\"atom-8\" d=\"M 498.1 378.5 L 499.5 380.7 Q 499.7 381.0, 499.9 381.4 Q 500.1 381.8, 500.1 381.8 L 500.1 378.5 L 500.7 378.5 L 500.7 382.7 L 500.1 382.7 L 498.6 380.3 Q 498.4 380.0, 498.2 379.7 Q 498.1 379.3, 498.0 379.2 L 498.0 382.7 L 497.5 382.7 L 497.5 378.5 L 498.1 378.5 \" fill=\"#0000FF\"/>\n<path class=\"atom-13\" d=\"M 547.9 375.3 L 549.3 377.5 Q 549.5 377.8, 549.7 378.2 Q 549.9 378.6, 549.9 378.6 L 549.9 375.3 L 550.5 375.3 L 550.5 379.5 L 549.9 379.5 L 548.4 377.1 Q 548.2 376.8, 548.0 376.5 Q 547.9 376.1, 547.8 376.0 L 547.8 379.5 L 547.3 379.5 L 547.3 375.3 L 547.9 375.3 \" fill=\"#0000FF\"/>\n<path class=\"atom-16\" d=\"M 567.3 396.1 Q 567.3 395.1, 567.9 394.5 Q 568.4 393.9, 569.3 393.9 Q 570.2 393.9, 570.7 394.5 Q 571.2 395.1, 571.2 396.1 Q 571.2 397.1, 570.7 397.7 Q 570.2 398.3, 569.3 398.3 Q 568.4 398.3, 567.9 397.7 Q 567.3 397.1, 567.3 396.1 M 569.3 397.8 Q 569.9 397.8, 570.3 397.4 Q 570.6 396.9, 570.6 396.1 Q 570.6 395.3, 570.3 394.8 Q 569.9 394.4, 569.3 394.4 Q 568.6 394.4, 568.3 394.8 Q 567.9 395.3, 567.9 396.1 Q 567.9 397.0, 568.3 397.4 Q 568.6 397.8, 569.3 397.8 \" fill=\"#FF0000\"/>\n<path class=\"atom-23\" d=\"M 442.1 408.7 L 444.6 408.7 L 444.6 409.2 L 442.6 409.2 L 442.6 410.5 L 444.4 410.5 L 444.4 411.0 L 442.6 411.0 L 442.6 413.0 L 442.1 413.0 L 442.1 408.7 \" fill=\"#33CCCC\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 763.7,378.0 L 750.1,380.6\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-1 atom-1 atom-2\" d=\"M 750.1,380.6 L 745.7,393.7\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-1 atom-1 atom-2\" d=\"M 746.9,381.7 L 743.7,390.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-20 atom-20 atom-1\" d=\"M 741.0,370.2 L 750.1,380.6\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-2 atom-2 atom-3\" d=\"M 745.7,393.7 L 732.1,396.4\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-3 atom-3 atom-4\" d=\"M 732.1,396.4 L 723.0,386.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-3 atom-3 atom-4\" d=\"M 732.8,393.0 L 726.4,385.7\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-4 atom-4 atom-5\" d=\"M 723.0,386.0 L 717.2,387.1\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-4 atom-4 atom-5\" d=\"M 717.2,387.1 L 711.4,388.3\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-18 atom-4 atom-19\" d=\"M 723.0,386.0 L 727.5,372.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-5 atom-5 atom-6\" d=\"M 707.5,386.4 L 703.9,382.3\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-5 atom-5 atom-6\" d=\"M 703.9,382.3 L 700.3,378.2\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-6 atom-6 atom-7\" d=\"M 701.6,378.7 L 703.4,373.4\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-6 atom-6 atom-7\" d=\"M 703.4,373.4 L 705.2,368.1\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-6 atom-6 atom-7\" d=\"M 699.0,377.8 L 700.8,372.5\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-6 atom-6 atom-7\" d=\"M 700.8,372.5 L 702.6,367.2\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-7 atom-6 atom-8\" d=\"M 700.3,378.2 L 694.5,379.4\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-7 atom-6 atom-8\" d=\"M 694.5,379.4 L 688.7,380.5\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-8 atom-8 atom-9\" d=\"M 685.9,383.4 L 684.1,388.7\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-8 atom-8 atom-9\" d=\"M 684.1,388.7 L 682.2,394.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-21 atom-18 atom-8\" d=\"M 677.6,370.5 L 681.2,374.6\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-21 atom-18 atom-8\" d=\"M 681.2,374.6 L 684.8,378.6\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-9 atom-9 atom-10\" d=\"M 682.2,394.0 L 668.7,396.7\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-10 atom-10 atom-11\" d=\"M 668.7,396.7 L 659.6,386.2\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-11 atom-11 atom-12\" d=\"M 659.6,386.2 L 646.0,388.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-16 atom-11 atom-17\" d=\"M 659.6,386.2 L 664.0,373.1\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-12 atom-12 atom-13\" d=\"M 644.7,388.5 L 642.9,393.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-12 atom-12 atom-13\" d=\"M 642.9,393.8 L 641.1,399.1\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-12 atom-12 atom-13\" d=\"M 647.3,389.3 L 645.5,394.6\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-12 atom-12 atom-13\" d=\"M 645.5,394.6 L 643.7,399.9\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-13 atom-12 atom-14\" d=\"M 646.0,388.9 L 642.4,384.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-13 atom-12 atom-14\" d=\"M 642.4,384.8 L 638.8,380.7\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-14 atom-14 atom-15\" d=\"M 634.9,378.9 L 629.1,380.0\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-14 atom-14 atom-15\" d=\"M 629.1,380.0 L 623.3,381.1\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-15 atom-14 atom-16\" d=\"M 637.7,376.0 L 639.5,370.7\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-15 atom-14 atom-16\" d=\"M 639.5,370.7 L 641.4,365.4\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-17 atom-17 atom-18\" d=\"M 664.0,373.1 L 677.6,370.5\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-19 atom-19 atom-20\" d=\"M 727.5,372.9 L 741.0,370.2\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-19 atom-19 atom-20\" d=\"M 730.0,375.2 L 739.5,373.3\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"atom-5\" d=\"M 708.5 386.5 L 709.9 388.8 Q 710.0 389.0, 710.2 389.4 Q 710.4 389.8, 710.5 389.8 L 710.5 386.5 L 711.0 386.5 L 711.0 390.8 L 710.4 390.8 L 708.9 388.3 Q 708.8 388.0, 708.6 387.7 Q 708.4 387.4, 708.3 387.3 L 708.3 390.8 L 707.8 390.8 L 707.8 386.5 L 708.5 386.5 \" fill=\"#0000FF\"/>\n<path class=\"atom-5\" d=\"M 707.7 391.2 L 708.3 391.2 L 708.3 393.0 L 710.5 393.0 L 710.5 391.2 L 711.1 391.2 L 711.1 395.4 L 710.5 395.4 L 710.5 393.5 L 708.3 393.5 L 708.3 395.4 L 707.7 395.4 L 707.7 391.2 \" fill=\"#0000FF\"/>\n<path class=\"atom-7\" d=\"M 702.8 365.1 Q 702.8 364.1, 703.3 363.5 Q 703.8 363.0, 704.8 363.0 Q 705.7 363.0, 706.2 363.5 Q 706.7 364.1, 706.7 365.1 Q 706.7 366.2, 706.2 366.8 Q 705.7 367.3, 704.8 367.3 Q 703.8 367.3, 703.3 366.8 Q 702.8 366.2, 702.8 365.1 M 704.8 366.9 Q 705.4 366.9, 705.8 366.4 Q 706.1 366.0, 706.1 365.1 Q 706.1 364.3, 705.8 363.9 Q 705.4 363.5, 704.8 363.5 Q 704.1 363.5, 703.8 363.9 Q 703.4 364.3, 703.4 365.1 Q 703.4 366.0, 703.8 366.4 Q 704.1 366.9, 704.8 366.9 \" fill=\"#FF0000\"/>\n<path class=\"atom-8\" d=\"M 685.8 378.8 L 687.2 381.0 Q 687.3 381.2, 687.5 381.6 Q 687.8 382.0, 687.8 382.1 L 687.8 378.8 L 688.3 378.8 L 688.3 383.0 L 687.8 383.0 L 686.3 380.6 Q 686.1 380.3, 685.9 379.9 Q 685.7 379.6, 685.7 379.5 L 685.7 383.0 L 685.1 383.0 L 685.1 378.8 L 685.8 378.8 \" fill=\"#0000FF\"/>\n<path class=\"atom-13\" d=\"M 639.6 402.0 Q 639.6 401.0, 640.1 400.4 Q 640.6 399.8, 641.5 399.8 Q 642.5 399.8, 643.0 400.4 Q 643.5 401.0, 643.5 402.0 Q 643.5 403.0, 642.9 403.6 Q 642.4 404.2, 641.5 404.2 Q 640.6 404.2, 640.1 403.6 Q 639.6 403.0, 639.6 402.0 M 641.5 403.7 Q 642.2 403.7, 642.5 403.3 Q 642.9 402.9, 642.9 402.0 Q 642.9 401.2, 642.5 400.8 Q 642.2 400.3, 641.5 400.3 Q 640.9 400.3, 640.5 400.7 Q 640.2 401.2, 640.2 402.0 Q 640.2 402.9, 640.5 403.3 Q 640.9 403.7, 641.5 403.7 \" fill=\"#FF0000\"/>\n<path class=\"atom-14\" d=\"M 635.9 376.3 L 637.3 378.6 Q 637.5 378.8, 637.7 379.2 Q 637.9 379.6, 637.9 379.6 L 637.9 376.3 L 638.5 376.3 L 638.5 380.6 L 637.9 380.6 L 636.4 378.1 Q 636.2 377.8, 636.1 377.5 Q 635.9 377.2, 635.8 377.1 L 635.8 380.6 L 635.3 380.6 L 635.3 376.3 L 635.9 376.3 \" fill=\"#0000FF\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 95.0,546.8 L 96.1,541.3\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 96.1,541.3 L 97.2,535.7\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 92.3,546.3 L 93.4,540.7\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 93.4,540.7 L 94.5,535.2\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-1 atom-1 atom-2\" d=\"M 95.9,535.5 L 91.7,531.7\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-1 atom-1 atom-2\" d=\"M 91.7,531.7 L 87.5,528.0\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-11 atom-1 atom-12\" d=\"M 95.9,535.5 L 101.4,533.6\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-11 atom-1 atom-12\" d=\"M 101.4,533.6 L 107.0,531.7\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-2 atom-2 atom-3\" d=\"M 83.5,527.0 L 78.0,528.8\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-2 atom-2 atom-3\" d=\"M 78.0,528.8 L 72.4,530.7\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-3 atom-3 atom-4\" d=\"M 72.4,530.7 L 69.6,544.3\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-3 atom-3 atom-4\" d=\"M 69.2,532.2 L 67.3,541.7\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-24 atom-11 atom-3\" d=\"M 62.0,521.5 L 72.4,530.7\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-4 atom-4 atom-5\" d=\"M 69.6,544.3 L 56.5,548.6\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-5 atom-5 atom-6\" d=\"M 56.5,548.6 L 46.1,539.5\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-5 atom-5 atom-6\" d=\"M 56.8,545.2 L 49.5,538.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-6 atom-6 atom-7\" d=\"M 46.1,539.5 L 40.4,540.1\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-6 atom-6 atom-7\" d=\"M 40.4,540.1 L 34.7,540.8\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-26 atom-10 atom-6\" d=\"M 48.9,525.9 L 46.1,539.5\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-7 atom-7 atom-8\" d=\"M 31.2,538.6 L 28.9,533.5\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-7 atom-7 atom-8\" d=\"M 28.9,533.5 L 26.6,528.5\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-8 atom-8 atom-9\" d=\"M 26.6,528.5 L 30.6,524.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-8 atom-8 atom-9\" d=\"M 30.6,524.8 L 34.5,521.2\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-9 atom-9 atom-10\" d=\"M 39.1,520.4 L 44.0,523.2\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-9 atom-9 atom-10\" d=\"M 44.0,523.2 L 48.9,525.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-10 atom-10 atom-11\" d=\"M 48.9,525.9 L 62.0,521.5\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-10 atom-10 atom-11\" d=\"M 51.7,527.9 L 60.9,524.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-12 atom-12 atom-13\" d=\"M 110.9,532.8 L 115.1,536.5\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-12 atom-12 atom-13\" d=\"M 115.1,536.5 L 119.4,540.2\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-25 atom-24 atom-12\" d=\"M 111.7,517.5 L 110.6,523.1\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-25 atom-24 atom-12\" d=\"M 110.6,523.1 L 109.5,528.6\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-13 atom-13 atom-14\" d=\"M 119.4,540.2 L 132.5,535.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-14 atom-14 atom-15\" d=\"M 132.5,535.8 L 135.2,522.3\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-15 atom-15 atom-16\" d=\"M 135.2,522.3 L 148.4,517.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-22 atom-15 atom-23\" d=\"M 135.2,522.3 L 124.9,513.1\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-16 atom-16 atom-17\" d=\"M 148.4,517.9 L 152.6,521.6\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-16 atom-16 atom-17\" d=\"M 152.6,521.6 L 156.8,525.3\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-17 atom-17 atom-18\" d=\"M 158.2,529.5 L 157.1,535.1\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-17 atom-17 atom-18\" d=\"M 157.1,535.1 L 156.0,540.6\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-27 atom-22 atom-17\" d=\"M 171.8,522.7 L 166.3,524.5\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-27 atom-22 atom-17\" d=\"M 166.3,524.5 L 160.7,526.4\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-18 atom-18 atom-19\" d=\"M 156.0,540.6 L 166.3,549.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-19 atom-19 atom-20\" d=\"M 166.3,549.8 L 171.7,548.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-19 atom-19 atom-20\" d=\"M 171.7,548.0 L 177.2,546.2\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-20 atom-20 atom-21\" d=\"M 180.0,542.9 L 181.1,537.4\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-20 atom-20 atom-21\" d=\"M 181.1,537.4 L 182.2,531.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-21 atom-21 atom-22\" d=\"M 182.2,531.8 L 171.8,522.7\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-23 atom-23 atom-24\" d=\"M 124.9,513.1 L 111.7,517.5\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"atom-0\" d=\"M 91.2 549.0 Q 91.2 548.0, 91.7 547.5 Q 92.2 546.9, 93.1 546.9 Q 94.0 546.9, 94.5 547.5 Q 95.1 548.0, 95.1 549.0 Q 95.1 550.1, 94.5 550.7 Q 94.0 551.2, 93.1 551.2 Q 92.2 551.2, 91.7 550.7 Q 91.2 550.1, 91.2 549.0 M 93.1 550.8 Q 93.8 550.8, 94.1 550.3 Q 94.5 549.9, 94.5 549.0 Q 94.5 548.2, 94.1 547.8 Q 93.8 547.4, 93.1 547.4 Q 92.5 547.4, 92.1 547.8 Q 91.8 548.2, 91.8 549.0 Q 91.8 549.9, 92.1 550.3 Q 92.5 550.8, 93.1 550.8 \" fill=\"#FF0000\"/>\n<path class=\"atom-2\" d=\"M 84.6 524.2 L 85.9 526.4 Q 86.1 526.6, 86.3 527.0 Q 86.5 527.4, 86.5 527.5 L 86.5 524.2 L 87.1 524.2 L 87.1 528.4 L 86.5 528.4 L 85.0 526.0 Q 84.9 525.7, 84.7 525.3 Q 84.5 525.0, 84.4 524.9 L 84.4 528.4 L 83.9 528.4 L 83.9 524.2 L 84.6 524.2 \" fill=\"#0000FF\"/>\n<path class=\"atom-2\" d=\"M 83.8 519.5 L 84.4 519.5 L 84.4 521.3 L 86.6 521.3 L 86.6 519.5 L 87.2 519.5 L 87.2 523.7 L 86.6 523.7 L 86.6 521.8 L 84.4 521.8 L 84.4 523.7 L 83.8 523.7 L 83.8 519.5 \" fill=\"#0000FF\"/>\n<path class=\"atom-7\" d=\"M 30.4 541.1 Q 30.4 540.0, 30.9 539.5 Q 31.4 538.9, 32.4 538.9 Q 33.3 538.9, 33.8 539.5 Q 34.3 540.0, 34.3 541.1 Q 34.3 542.1, 33.8 542.7 Q 33.3 543.3, 32.4 543.3 Q 31.4 543.3, 30.9 542.7 Q 30.4 542.1, 30.4 541.1 M 32.4 542.8 Q 33.0 542.8, 33.4 542.3 Q 33.7 541.9, 33.7 541.1 Q 33.7 540.2, 33.4 539.8 Q 33.0 539.4, 32.4 539.4 Q 31.7 539.4, 31.4 539.8 Q 31.0 540.2, 31.0 541.1 Q 31.0 541.9, 31.4 542.3 Q 31.7 542.8, 32.4 542.8 \" fill=\"#FF0000\"/>\n<path class=\"atom-9\" d=\"M 34.9 519.1 Q 34.9 518.1, 35.4 517.5 Q 35.9 517.0, 36.8 517.0 Q 37.8 517.0, 38.3 517.5 Q 38.8 518.1, 38.8 519.1 Q 38.8 520.1, 38.3 520.7 Q 37.8 521.3, 36.8 521.3 Q 35.9 521.3, 35.4 520.7 Q 34.9 520.2, 34.9 519.1 M 36.8 520.8 Q 37.5 520.8, 37.8 520.4 Q 38.2 520.0, 38.2 519.1 Q 38.2 518.3, 37.8 517.9 Q 37.5 517.4, 36.8 517.4 Q 36.2 517.4, 35.8 517.9 Q 35.5 518.3, 35.5 519.1 Q 35.5 520.0, 35.8 520.4 Q 36.2 520.8, 36.8 520.8 \" fill=\"#FF0000\"/>\n<path class=\"atom-12\" d=\"M 108.0 528.9 L 109.4 531.2 Q 109.6 531.4, 109.8 531.8 Q 110.0 532.2, 110.0 532.2 L 110.0 528.9 L 110.6 528.9 L 110.6 533.2 L 110.0 533.2 L 108.5 530.7 Q 108.3 530.4, 108.2 530.1 Q 108.0 529.8, 107.9 529.7 L 107.9 533.2 L 107.4 533.2 L 107.4 528.9 L 108.0 528.9 \" fill=\"#0000FF\"/>\n<path class=\"atom-17\" d=\"M 157.8 524.9 L 159.2 527.2 Q 159.3 527.4, 159.5 527.8 Q 159.8 528.2, 159.8 528.2 L 159.8 524.9 L 160.3 524.9 L 160.3 529.2 L 159.8 529.2 L 158.3 526.7 Q 158.1 526.4, 157.9 526.1 Q 157.7 525.8, 157.7 525.7 L 157.7 529.2 L 157.1 529.2 L 157.1 524.9 L 157.8 524.9 \" fill=\"#0000FF\"/>\n<path class=\"atom-20\" d=\"M 177.5 545.4 Q 177.5 544.4, 178.0 543.8 Q 178.5 543.3, 179.5 543.3 Q 180.4 543.3, 180.9 543.8 Q 181.4 544.4, 181.4 545.4 Q 181.4 546.4, 180.9 547.0 Q 180.4 547.6, 179.5 547.6 Q 178.5 547.6, 178.0 547.0 Q 177.5 546.4, 177.5 545.4 M 179.5 547.1 Q 180.1 547.1, 180.5 546.7 Q 180.8 546.3, 180.8 545.4 Q 180.8 544.6, 180.5 544.2 Q 180.1 543.7, 179.5 543.7 Q 178.8 543.7, 178.5 544.2 Q 178.1 544.6, 178.1 545.4 Q 178.1 546.3, 178.5 546.7 Q 178.8 547.1, 179.5 547.1 \" fill=\"#FF0000\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 246.1,575.5 L 250.6,562.4\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-1 atom-1 atom-2\" d=\"M 250.6,562.4 L 256.3,561.3\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-1 atom-1 atom-2\" d=\"M 256.3,561.3 L 261.9,560.2\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-2 atom-2 atom-3\" d=\"M 265.0,557.3 L 266.9,552.0\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-2 atom-2 atom-3\" d=\"M 266.9,552.0 L 268.7,546.7\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-3 atom-3 atom-4\" d=\"M 268.7,546.7 L 259.6,536.2\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-20 atom-20 atom-3\" d=\"M 282.2,544.0 L 268.7,546.7\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-4 atom-4 atom-5\" d=\"M 259.6,536.2 L 264.0,523.1\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-5 atom-5 atom-6\" d=\"M 264.0,523.1 L 277.6,520.5\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-6 atom-6 atom-7\" d=\"M 277.6,520.5 L 281.2,524.6\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-6 atom-6 atom-7\" d=\"M 281.2,524.6 L 284.8,528.6\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-7 atom-7 atom-8\" d=\"M 288.7,530.5 L 294.5,529.4\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-7 atom-7 atom-8\" d=\"M 294.5,529.4 L 300.3,528.2\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-19 atom-7 atom-20\" d=\"M 285.9,533.4 L 284.1,538.7\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-19 atom-7 atom-20\" d=\"M 284.1,538.7 L 282.2,544.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-8 atom-8 atom-9\" d=\"M 301.6,528.7 L 303.4,523.4\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-8 atom-8 atom-9\" d=\"M 303.4,523.4 L 305.2,518.1\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-8 atom-8 atom-9\" d=\"M 299.0,527.8 L 300.8,522.5\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-8 atom-8 atom-9\" d=\"M 300.8,522.5 L 302.6,517.2\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-9 atom-8 atom-10\" d=\"M 300.3,528.2 L 303.9,532.3\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-9 atom-8 atom-10\" d=\"M 303.9,532.3 L 307.5,536.4\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-10 atom-10 atom-11\" d=\"M 311.4,538.3 L 317.2,537.1\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-10 atom-10 atom-11\" d=\"M 317.2,537.1 L 323.0,536.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-11 atom-11 atom-12\" d=\"M 323.0,536.0 L 332.1,546.4\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-11 atom-11 atom-12\" d=\"M 326.4,535.7 L 332.8,543.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-21 atom-18 atom-11\" d=\"M 327.5,522.9 L 323.0,536.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-12 atom-12 atom-13\" d=\"M 332.1,546.4 L 327.6,559.5\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-13 atom-12 atom-14\" d=\"M 332.1,546.4 L 345.7,543.7\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-14 atom-14 atom-15\" d=\"M 345.7,543.7 L 350.1,530.6\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-14 atom-14 atom-15\" d=\"M 343.7,540.9 L 346.9,531.7\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-15 atom-15 atom-16\" d=\"M 350.1,530.6 L 363.7,528.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-16 atom-15 atom-17\" d=\"M 350.1,530.6 L 341.0,520.2\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-17 atom-17 atom-18\" d=\"M 341.0,520.2 L 327.5,522.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-17 atom-17 atom-18\" d=\"M 339.5,523.3 L 330.0,525.2\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-18 atom-18 atom-19\" d=\"M 327.5,522.9 L 323.2,518.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-18 atom-18 atom-19\" d=\"M 323.2,518.0 L 319.0,513.2\" style=\"fill:none;fill-rule:evenodd;stroke:#00CC00;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"atom-2\" d=\"M 262.2 559.8 Q 262.2 558.7, 262.7 558.2 Q 263.2 557.6, 264.2 557.6 Q 265.1 557.6, 265.6 558.2 Q 266.1 558.7, 266.1 559.8 Q 266.1 560.8, 265.6 561.4 Q 265.1 562.0, 264.2 562.0 Q 263.3 562.0, 262.7 561.4 Q 262.2 560.8, 262.2 559.8 M 264.2 561.5 Q 264.8 561.5, 265.2 561.1 Q 265.5 560.6, 265.5 559.8 Q 265.5 558.9, 265.2 558.5 Q 264.8 558.1, 264.2 558.1 Q 263.5 558.1, 263.2 558.5 Q 262.8 558.9, 262.8 559.8 Q 262.8 560.6, 263.2 561.1 Q 263.5 561.5, 264.2 561.5 \" fill=\"#FF0000\"/>\n<path class=\"atom-7\" d=\"M 285.8 528.8 L 287.2 531.0 Q 287.3 531.2, 287.5 531.6 Q 287.8 532.0, 287.8 532.1 L 287.8 528.8 L 288.3 528.8 L 288.3 533.0 L 287.8 533.0 L 286.3 530.6 Q 286.1 530.3, 285.9 529.9 Q 285.7 529.6, 285.7 529.5 L 285.7 533.0 L 285.1 533.0 L 285.1 528.8 L 285.8 528.8 \" fill=\"#0000FF\"/>\n<path class=\"atom-9\" d=\"M 302.8 515.1 Q 302.8 514.1, 303.3 513.5 Q 303.8 513.0, 304.8 513.0 Q 305.7 513.0, 306.2 513.5 Q 306.7 514.1, 306.7 515.1 Q 306.7 516.2, 306.2 516.8 Q 305.7 517.3, 304.8 517.3 Q 303.8 517.3, 303.3 516.8 Q 302.8 516.2, 302.8 515.1 M 304.8 516.9 Q 305.4 516.9, 305.8 516.4 Q 306.1 516.0, 306.1 515.1 Q 306.1 514.3, 305.8 513.9 Q 305.4 513.5, 304.8 513.5 Q 304.1 513.5, 303.8 513.9 Q 303.4 514.3, 303.4 515.1 Q 303.4 516.0, 303.8 516.4 Q 304.1 516.9, 304.8 516.9 \" fill=\"#FF0000\"/>\n<path class=\"atom-10\" d=\"M 308.5 536.5 L 309.9 538.8 Q 310.0 539.0, 310.2 539.4 Q 310.4 539.8, 310.5 539.8 L 310.5 536.5 L 311.0 536.5 L 311.0 540.8 L 310.4 540.8 L 308.9 538.3 Q 308.8 538.0, 308.6 537.7 Q 308.4 537.4, 308.3 537.3 L 308.3 540.8 L 307.8 540.8 L 307.8 536.5 L 308.5 536.5 \" fill=\"#0000FF\"/>\n<path class=\"atom-10\" d=\"M 307.7 541.2 L 308.3 541.2 L 308.3 543.0 L 310.5 543.0 L 310.5 541.2 L 311.1 541.2 L 311.1 545.4 L 310.5 545.4 L 310.5 543.5 L 308.3 543.5 L 308.3 545.4 L 307.7 545.4 L 307.7 541.2 \" fill=\"#0000FF\"/>\n<path class=\"atom-19\" d=\"M 314.3 512.6 Q 314.3 511.5, 314.8 511.0 Q 315.3 510.4, 316.2 510.4 Q 317.1 510.4, 317.6 511.1 L 317.2 511.4 Q 316.8 510.9, 316.2 510.9 Q 315.6 510.9, 315.2 511.4 Q 314.9 511.8, 314.9 512.6 Q 314.9 513.4, 315.3 513.9 Q 315.6 514.3, 316.3 514.3 Q 316.8 514.3, 317.3 514.0 L 317.5 514.5 Q 317.3 514.6, 316.9 514.7 Q 316.6 514.8, 316.2 514.8 Q 315.3 514.8, 314.8 514.2 Q 314.3 513.7, 314.3 512.6 \" fill=\"#00CC00\"/>\n<path class=\"atom-19\" d=\"M 318.1 510.2 L 318.6 510.2 L 318.6 514.7 L 318.1 514.7 L 318.1 510.2 \" fill=\"#00CC00\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 575.3,525.7 L 569.5,526.8\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 569.5,526.8 L 563.7,528.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 574.8,523.0 L 569.9,523.9\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 569.9,523.9 L 564.9,524.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 575.9,528.4 L 570.9,529.4\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 570.9,529.4 L 566.0,530.3\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-1 atom-1 atom-2\" d=\"M 563.7,528.0 L 550.1,530.6\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-2 atom-2 atom-3\" d=\"M 550.1,530.6 L 545.7,543.7\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-2 atom-2 atom-3\" d=\"M 546.9,531.7 L 543.7,540.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-21 atom-21 atom-2\" d=\"M 541.0,520.2 L 550.1,530.6\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-3 atom-3 atom-4\" d=\"M 545.7,543.7 L 532.1,546.4\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-4 atom-4 atom-5\" d=\"M 532.1,546.4 L 523.0,536.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-4 atom-4 atom-5\" d=\"M 532.8,543.0 L 526.4,535.7\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-5 atom-5 atom-6\" d=\"M 523.0,536.0 L 517.2,537.1\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-5 atom-5 atom-6\" d=\"M 517.2,537.1 L 511.4,538.3\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-19 atom-5 atom-20\" d=\"M 523.0,536.0 L 527.5,522.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-6 atom-6 atom-7\" d=\"M 507.5,536.4 L 503.9,532.3\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-6 atom-6 atom-7\" d=\"M 503.9,532.3 L 500.3,528.2\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-7 atom-7 atom-8\" d=\"M 501.6,528.7 L 503.4,523.4\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-7 atom-7 atom-8\" d=\"M 503.4,523.4 L 505.2,518.1\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-7 atom-7 atom-8\" d=\"M 499.0,527.8 L 500.8,522.5\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-7 atom-7 atom-8\" d=\"M 500.8,522.5 L 502.6,517.2\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-8 atom-7 atom-9\" d=\"M 500.3,528.2 L 494.5,529.4\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-8 atom-7 atom-9\" d=\"M 494.5,529.4 L 488.7,530.5\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-9 atom-9 atom-10\" d=\"M 485.9,533.4 L 484.1,538.7\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-9 atom-9 atom-10\" d=\"M 484.1,538.7 L 482.2,544.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-22 atom-19 atom-9\" d=\"M 477.6,520.5 L 481.2,524.6\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-22 atom-19 atom-9\" d=\"M 481.2,524.6 L 484.8,528.6\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-10 atom-10 atom-11\" d=\"M 482.2,544.0 L 468.7,546.7\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-11 atom-11 atom-12\" d=\"M 468.7,546.7 L 459.6,536.2\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-12 atom-12 atom-13\" d=\"M 459.6,536.2 L 464.0,523.1\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-13 atom-13 atom-14\" d=\"M 464.0,523.1 L 454.9,512.7\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-18 atom-13 atom-19\" d=\"M 464.0,523.1 L 477.6,520.5\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-14 atom-14 atom-15\" d=\"M 454.9,512.7 L 456.8,507.4\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-14 atom-14 atom-15\" d=\"M 456.8,507.4 L 458.6,502.1\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-15 atom-15 atom-16\" d=\"M 457.5,497.4 L 453.9,493.3\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-15 atom-15 atom-16\" d=\"M 453.9,493.3 L 450.3,489.2\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-16 atom-16 atom-17\" d=\"M 450.3,489.2 L 452.1,483.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-16 atom-16 atom-17\" d=\"M 452.1,483.9 L 453.9,478.6\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-17 atom-16 atom-18\" d=\"M 450.0,487.8 L 444.4,488.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-17 atom-16 atom-18\" d=\"M 444.4,488.9 L 438.8,490.0\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-17 atom-16 atom-18\" d=\"M 450.6,490.5 L 444.9,491.7\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-17 atom-16 atom-18\" d=\"M 444.9,491.7 L 439.3,492.8\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-20 atom-20 atom-21\" d=\"M 527.5,522.9 L 541.0,520.2\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-20 atom-20 atom-21\" d=\"M 530.0,525.2 L 539.5,523.3\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"atom-0\" d=\"M 576.4 523.2 L 577.8 525.4 Q 577.9 525.6, 578.1 526.0 Q 578.3 526.4, 578.4 526.5 L 578.4 523.2 L 578.9 523.2 L 578.9 527.4 L 578.3 527.4 L 576.8 525.0 Q 576.7 524.7, 576.5 524.3 Q 576.3 524.0, 576.2 523.9 L 576.2 527.4 L 575.7 527.4 L 575.7 523.2 L 576.4 523.2 \" fill=\"#0000FF\"/>\n<path class=\"atom-6\" d=\"M 508.5 536.5 L 509.9 538.8 Q 510.0 539.0, 510.2 539.4 Q 510.4 539.8, 510.5 539.8 L 510.5 536.5 L 511.0 536.5 L 511.0 540.8 L 510.4 540.8 L 508.9 538.3 Q 508.8 538.0, 508.6 537.7 Q 508.4 537.4, 508.3 537.3 L 508.3 540.8 L 507.8 540.8 L 507.8 536.5 L 508.5 536.5 \" fill=\"#0000FF\"/>\n<path class=\"atom-6\" d=\"M 507.7 541.2 L 508.3 541.2 L 508.3 543.0 L 510.5 543.0 L 510.5 541.2 L 511.1 541.2 L 511.1 545.4 L 510.5 545.4 L 510.5 543.5 L 508.3 543.5 L 508.3 545.4 L 507.7 545.4 L 507.7 541.2 \" fill=\"#0000FF\"/>\n<path class=\"atom-8\" d=\"M 502.8 515.1 Q 502.8 514.1, 503.3 513.5 Q 503.8 513.0, 504.8 513.0 Q 505.7 513.0, 506.2 513.5 Q 506.7 514.1, 506.7 515.1 Q 506.7 516.2, 506.2 516.8 Q 505.7 517.3, 504.8 517.3 Q 503.8 517.3, 503.3 516.8 Q 502.8 516.2, 502.8 515.1 M 504.8 516.9 Q 505.4 516.9, 505.8 516.4 Q 506.1 516.0, 506.1 515.1 Q 506.1 514.3, 505.8 513.9 Q 505.4 513.5, 504.8 513.5 Q 504.1 513.5, 503.8 513.9 Q 503.4 514.3, 503.4 515.1 Q 503.4 516.0, 503.8 516.4 Q 504.1 516.9, 504.8 516.9 \" fill=\"#FF0000\"/>\n<path class=\"atom-9\" d=\"M 485.8 528.8 L 487.2 531.0 Q 487.3 531.2, 487.5 531.6 Q 487.8 532.0, 487.8 532.1 L 487.8 528.8 L 488.3 528.8 L 488.3 533.0 L 487.8 533.0 L 486.3 530.6 Q 486.1 530.3, 485.9 529.9 Q 485.7 529.6, 485.7 529.5 L 485.7 533.0 L 485.1 533.0 L 485.1 528.8 L 485.8 528.8 \" fill=\"#0000FF\"/>\n<path class=\"atom-15\" d=\"M 458.5 497.5 L 459.9 499.7 Q 460.0 500.0, 460.2 500.4 Q 460.5 500.8, 460.5 500.8 L 460.5 497.5 L 461.0 497.5 L 461.0 501.7 L 460.4 501.7 L 459.0 499.3 Q 458.8 499.0, 458.6 498.7 Q 458.4 498.3, 458.4 498.2 L 458.4 501.7 L 457.8 501.7 L 457.8 497.5 L 458.5 497.5 \" fill=\"#0000FF\"/>\n<path class=\"atom-15\" d=\"M 461.5 497.5 L 462.1 497.5 L 462.1 499.3 L 464.3 499.3 L 464.3 497.5 L 464.9 497.5 L 464.9 501.7 L 464.3 501.7 L 464.3 499.8 L 462.1 499.8 L 462.1 501.7 L 461.5 501.7 L 461.5 497.5 \" fill=\"#0000FF\"/>\n<path class=\"atom-17\" d=\"M 453.9 474.0 L 455.2 476.2 Q 455.4 476.4, 455.6 476.8 Q 455.8 477.2, 455.8 477.3 L 455.8 474.0 L 456.4 474.0 L 456.4 478.2 L 455.8 478.2 L 454.3 475.8 Q 454.2 475.5, 454.0 475.1 Q 453.8 474.8, 453.7 474.7 L 453.7 478.2 L 453.2 478.2 L 453.2 474.0 L 453.9 474.0 \" fill=\"#0000FF\"/>\n<path class=\"atom-17\" d=\"M 456.9 474.0 L 457.5 474.0 L 457.5 475.8 L 459.7 475.8 L 459.7 474.0 L 460.2 474.0 L 460.2 478.2 L 459.7 478.2 L 459.7 476.3 L 457.5 476.3 L 457.5 478.2 L 456.9 478.2 L 456.9 474.0 \" fill=\"#0000FF\"/>\n<path class=\"atom-17\" d=\"M 460.4 478.1 Q 460.5 477.8, 460.8 477.7 Q 461.0 477.5, 461.4 477.5 Q 461.8 477.5, 462.0 477.7 Q 462.3 478.0, 462.3 478.4 Q 462.3 478.8, 462.0 479.2 Q 461.7 479.6, 461.0 480.0 L 462.3 480.0 L 462.3 480.3 L 460.4 480.3 L 460.4 480.1 Q 461.0 479.7, 461.3 479.4 Q 461.6 479.1, 461.7 478.9 Q 461.9 478.6, 461.9 478.4 Q 461.9 478.1, 461.7 478.0 Q 461.6 477.8, 461.4 477.8 Q 461.2 477.8, 461.0 477.9 Q 460.9 478.0, 460.7 478.2 L 460.4 478.1 \" fill=\"#0000FF\"/>\n<path class=\"atom-18\" d=\"M 434.8 491.9 Q 434.8 490.8, 435.3 490.3 Q 435.8 489.7, 436.7 489.7 Q 437.7 489.7, 438.2 490.3 Q 438.7 490.8, 438.7 491.9 Q 438.7 492.9, 438.2 493.5 Q 437.7 494.1, 436.7 494.1 Q 435.8 494.1, 435.3 493.5 Q 434.8 492.9, 434.8 491.9 M 436.7 493.6 Q 437.4 493.6, 437.7 493.2 Q 438.1 492.7, 438.1 491.9 Q 438.1 491.0, 437.7 490.6 Q 437.4 490.2, 436.7 490.2 Q 436.1 490.2, 435.7 490.6 Q 435.4 491.0, 435.4 491.9 Q 435.4 492.7, 435.7 493.2 Q 436.1 493.6, 436.7 493.6 \" fill=\"#FF0000\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 632.9,511.4 L 635.5,525.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-1 atom-1 atom-2\" d=\"M 635.5,525.0 L 641.1,526.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-1 atom-1 atom-2\" d=\"M 641.1,526.9 L 646.6,528.8\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-2 atom-2 atom-3\" d=\"M 649.3,532.0 L 651.0,537.4\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-2 atom-2 atom-3\" d=\"M 651.0,537.4 L 652.6,542.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-18 atom-18 atom-2\" d=\"M 659.9,521.6 L 655.2,524.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-18 atom-18 atom-2\" d=\"M 655.2,524.9 L 650.5,528.2\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-3 atom-3 atom-4\" d=\"M 652.6,542.8 L 666.4,543.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-4 atom-4 atom-5\" d=\"M 666.4,543.0 L 671.0,530.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-5 atom-5 atom-6\" d=\"M 671.0,530.0 L 684.2,525.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-17 atom-5 atom-18\" d=\"M 671.0,530.0 L 659.9,521.6\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-6 atom-6 atom-7\" d=\"M 684.2,525.9 L 688.3,529.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-6 atom-6 atom-7\" d=\"M 688.3,529.8 L 692.3,533.6\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-7 atom-7 atom-8\" d=\"M 696.3,534.8 L 701.9,533.1\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-7 atom-7 atom-8\" d=\"M 701.9,533.1 L 707.5,531.4\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-8 atom-8 atom-9\" d=\"M 708.9,531.7 L 710.2,526.2\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-8 atom-8 atom-9\" d=\"M 710.2,526.2 L 711.4,520.8\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-8 atom-8 atom-9\" d=\"M 706.2,531.1 L 707.5,525.6\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-8 atom-8 atom-9\" d=\"M 707.5,525.6 L 708.7,520.2\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-9 atom-8 atom-10\" d=\"M 707.5,531.4 L 711.6,535.2\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-9 atom-8 atom-10\" d=\"M 711.6,535.2 L 715.7,539.0\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-10 atom-10 atom-11\" d=\"M 719.6,540.3 L 725.2,538.5\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-10 atom-10 atom-11\" d=\"M 725.2,538.5 L 730.9,536.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-11 atom-11 atom-12\" d=\"M 730.9,536.8 L 741.0,546.3\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-11 atom-11 atom-12\" d=\"M 734.3,536.2 L 741.4,542.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-19 atom-17 atom-11\" d=\"M 734.0,523.4 L 730.9,536.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-12 atom-12 atom-13\" d=\"M 741.0,546.3 L 754.2,542.3\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-13 atom-13 atom-14\" d=\"M 754.2,542.3 L 757.4,528.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-13 atom-13 atom-14\" d=\"M 752.0,539.6 L 754.2,530.2\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-14 atom-14 atom-15\" d=\"M 757.4,528.8 L 763.0,527.1\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-14 atom-14 atom-15\" d=\"M 763.0,527.1 L 768.6,525.4\" style=\"fill:none;fill-rule:evenodd;stroke:#00CC00;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-15 atom-14 atom-16\" d=\"M 757.4,528.8 L 747.3,519.3\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-16 atom-16 atom-17\" d=\"M 747.3,519.3 L 734.0,523.4\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-16 atom-16 atom-17\" d=\"M 746.1,522.6 L 736.8,525.4\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"atom-2\" d=\"M 647.6 527.4 L 649.0 529.6 Q 649.2 529.9, 649.4 530.3 Q 649.6 530.7, 649.6 530.7 L 649.6 527.4 L 650.2 527.4 L 650.2 531.6 L 649.6 531.6 L 648.1 529.2 Q 647.9 528.9, 647.7 528.6 Q 647.6 528.2, 647.5 528.1 L 647.5 531.6 L 647.0 531.6 L 647.0 527.4 L 647.6 527.4 \" fill=\"#0000FF\"/>\n<path class=\"atom-7\" d=\"M 693.4 533.3 L 694.8 535.5 Q 694.9 535.8, 695.1 536.2 Q 695.3 536.6, 695.3 536.6 L 695.3 533.3 L 695.9 533.3 L 695.9 537.5 L 695.3 537.5 L 693.8 535.1 Q 693.7 534.8, 693.5 534.5 Q 693.3 534.1, 693.2 534.0 L 693.2 537.5 L 692.7 537.5 L 692.7 533.3 L 693.4 533.3 \" fill=\"#0000FF\"/>\n<path class=\"atom-7\" d=\"M 692.6 538.0 L 693.2 538.0 L 693.2 539.8 L 695.4 539.8 L 695.4 538.0 L 696.0 538.0 L 696.0 542.2 L 695.4 542.2 L 695.4 540.2 L 693.2 540.2 L 693.2 542.2 L 692.6 542.2 L 692.6 538.0 \" fill=\"#0000FF\"/>\n<path class=\"atom-9\" d=\"M 708.7 517.9 Q 708.7 516.9, 709.2 516.3 Q 709.7 515.8, 710.7 515.8 Q 711.6 515.8, 712.1 516.3 Q 712.6 516.9, 712.6 517.9 Q 712.6 519.0, 712.1 519.5 Q 711.6 520.1, 710.7 520.1 Q 709.8 520.1, 709.2 519.5 Q 708.7 519.0, 708.7 517.9 M 710.7 519.6 Q 711.3 519.6, 711.7 519.2 Q 712.0 518.8, 712.0 517.9 Q 712.0 517.1, 711.7 516.7 Q 711.3 516.2, 710.7 516.2 Q 710.0 516.2, 709.7 516.7 Q 709.3 517.1, 709.3 517.9 Q 709.3 518.8, 709.7 519.2 Q 710.0 519.6, 710.7 519.6 \" fill=\"#FF0000\"/>\n<path class=\"atom-10\" d=\"M 716.7 538.7 L 718.1 541.0 Q 718.2 541.2, 718.5 541.6 Q 718.7 542.0, 718.7 542.0 L 718.7 538.7 L 719.3 538.7 L 719.3 543.0 L 718.7 543.0 L 717.2 540.5 Q 717.0 540.2, 716.8 539.9 Q 716.6 539.6, 716.6 539.5 L 716.6 543.0 L 716.0 543.0 L 716.0 538.7 L 716.7 538.7 \" fill=\"#0000FF\"/>\n<path class=\"atom-10\" d=\"M 716.0 543.4 L 716.6 543.4 L 716.6 545.2 L 718.7 545.2 L 718.7 543.4 L 719.3 543.4 L 719.3 547.7 L 718.7 547.7 L 718.7 545.7 L 716.6 545.7 L 716.6 547.7 L 716.0 547.7 L 716.0 543.4 \" fill=\"#0000FF\"/>\n<path class=\"atom-15\" d=\"M 769.0 524.9 Q 769.0 523.9, 769.5 523.3 Q 770.0 522.8, 770.9 522.8 Q 771.8 522.8, 772.3 523.4 L 771.9 523.7 Q 771.5 523.3, 770.9 523.3 Q 770.3 523.3, 769.9 523.7 Q 769.6 524.1, 769.6 524.9 Q 769.6 525.8, 769.9 526.2 Q 770.3 526.6, 771.0 526.6 Q 771.4 526.6, 772.0 526.4 L 772.2 526.8 Q 771.9 527.0, 771.6 527.0 Q 771.3 527.1, 770.9 527.1 Q 770.0 527.1, 769.5 526.6 Q 769.0 526.0, 769.0 524.9 \" fill=\"#00CC00\"/>\n<path class=\"atom-15\" d=\"M 772.8 522.5 L 773.3 522.5 L 773.3 527.1 L 772.8 527.1 L 772.8 522.5 \" fill=\"#00CC00\"/>\n</svg>",
"text/plain": [
"<IPython.core.display.SVG object>"
]
},
"metadata": {},
"output_type": "display_data"
}
],
"source": [
"# Test partition and alignment on raw murko scaffold generation\n",
"aligned_mols, mol_groups = partition_and_align_mols(molecules_with_confs, partition='scaffold')\n",
"display(dm.to_image(aligned_mols[:16], mol_size=(200, 150)))"
]
},
{
"cell_type": "code",
"execution_count": 12,
"metadata": {},
"outputs": [
{
"data": {
"image/svg+xml": "<svg baseProfile=\"full\" height=\"600px\" version=\"1.1\" viewBox=\"0 0 800 600\" width=\"800px\" xml:space=\"preserve\" xmlns=\"http://www.w3.org/2000/svg\" xmlns:rdkit=\"http://www.rdkit.org/xml\" xmlns:xlink=\"http://www.w3.org/1999/xlink\">\n<!-- END OF HEADER -->\n<rect height=\"600.0\" style=\"opacity:1.0;fill:#FFFFFF;stroke:none\" width=\"800.0\" x=\"0.0\" y=\"0.0\"> </rect>\n<rect height=\"600.0\" style=\"opacity:1.0;fill:#FFFFFF;stroke:none\" width=\"800.0\" x=\"0.0\" y=\"0.0\"> </rect>\n<rect height=\"600.0\" style=\"opacity:1.0;fill:#FFFFFF;stroke:none\" width=\"800.0\" x=\"0.0\" y=\"0.0\"> </rect>\n<rect height=\"600.0\" style=\"opacity:1.0;fill:#FFFFFF;stroke:none\" width=\"800.0\" x=\"0.0\" y=\"0.0\"> </rect>\n<rect height=\"600.0\" style=\"opacity:1.0;fill:#FFFFFF;stroke:none\" width=\"800.0\" x=\"0.0\" y=\"0.0\"> </rect>\n<rect height=\"600.0\" style=\"opacity:1.0;fill:#FFFFFF;stroke:none\" width=\"800.0\" x=\"0.0\" y=\"0.0\"> </rect>\n<rect height=\"600.0\" style=\"opacity:1.0;fill:#FFFFFF;stroke:none\" width=\"800.0\" x=\"0.0\" y=\"0.0\"> </rect>\n<rect height=\"600.0\" style=\"opacity:1.0;fill:#FFFFFF;stroke:none\" width=\"800.0\" x=\"0.0\" y=\"0.0\"> </rect>\n<rect height=\"600.0\" style=\"opacity:1.0;fill:#FFFFFF;stroke:none\" width=\"800.0\" x=\"0.0\" y=\"0.0\"> </rect>\n<rect height=\"600.0\" style=\"opacity:1.0;fill:#FFFFFF;stroke:none\" width=\"800.0\" x=\"0.0\" y=\"0.0\"> </rect>\n<rect height=\"600.0\" style=\"opacity:1.0;fill:#FFFFFF;stroke:none\" width=\"800.0\" x=\"0.0\" y=\"0.0\"> </rect>\n<rect height=\"600.0\" style=\"opacity:1.0;fill:#FFFFFF;stroke:none\" width=\"800.0\" x=\"0.0\" y=\"0.0\"> </rect>\n<rect height=\"600.0\" style=\"opacity:1.0;fill:#FFFFFF;stroke:none\" width=\"800.0\" x=\"0.0\" y=\"0.0\"> </rect>\n<rect height=\"600.0\" style=\"opacity:1.0;fill:#FFFFFF;stroke:none\" width=\"800.0\" x=\"0.0\" y=\"0.0\"> </rect>\n<rect height=\"600.0\" style=\"opacity:1.0;fill:#FFFFFF;stroke:none\" width=\"800.0\" x=\"0.0\" y=\"0.0\"> </rect>\n<rect height=\"600.0\" style=\"opacity:1.0;fill:#FFFFFF;stroke:none\" width=\"800.0\" x=\"0.0\" y=\"0.0\"> </rect>\n<rect height=\"600.0\" style=\"opacity:1.0;fill:#FFFFFF;stroke:none\" width=\"800.0\" x=\"0.0\" y=\"0.0\"> </rect>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 51.5,47.7 L 54.9,52.8\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 54.9,52.8 L 58.2,58.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 54.1,46.0 L 57.5,51.1\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 57.5,51.1 L 60.8,56.3\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-1 atom-1 atom-2\" d=\"M 59.5,57.1 L 56.7,62.7\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-1 atom-1 atom-2\" d=\"M 56.7,62.7 L 53.8,68.3\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-9 atom-1 atom-10\" d=\"M 59.5,57.1 L 66.2,56.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-9 atom-1 atom-10\" d=\"M 66.2,56.8 L 72.8,56.4\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-2 atom-2 atom-3\" d=\"M 54.2,73.4 L 57.5,78.6\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-2 atom-2 atom-3\" d=\"M 57.5,78.6 L 60.9,83.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-3 atom-3 atom-4\" d=\"M 60.9,83.8 L 53.9,97.5\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-3 atom-3 atom-4\" d=\"M 62.6,87.2 L 57.7,96.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-22 atom-8 atom-3\" d=\"M 76.3,83.0 L 60.9,83.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-4 atom-4 atom-5\" d=\"M 53.9,97.5 L 62.3,110.4\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-5 atom-5 atom-6\" d=\"M 62.3,110.4 L 77.7,109.6\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-5 atom-5 atom-6\" d=\"M 64.5,107.2 L 75.2,106.7\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-6 atom-6 atom-7\" d=\"M 77.7,109.6 L 84.7,95.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-7 atom-7 atom-8\" d=\"M 84.7,95.9 L 76.3,83.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-7 atom-7 atom-8\" d=\"M 80.8,95.6 L 75.0,86.6\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-8 atom-8 atom-9\" d=\"M 76.3,83.0 L 78.0,81.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-8 atom-8 atom-9\" d=\"M 78.0,81.0 L 79.8,79.0\" style=\"fill:none;fill-rule:evenodd;stroke:#00CC00;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-10 atom-10 atom-11\" d=\"M 76.6,58.9 L 79.9,64.1\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-10 atom-10 atom-11\" d=\"M 79.9,64.1 L 83.3,69.2\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-23 atom-22 atom-10\" d=\"M 81.9,42.6 L 79.0,48.2\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-23 atom-22 atom-10\" d=\"M 79.0,48.2 L 76.2,53.7\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-11 atom-11 atom-12\" d=\"M 83.3,69.2 L 98.7,68.4\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-12 atom-12 atom-13\" d=\"M 98.7,68.4 L 105.7,54.7\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-13 atom-13 atom-14\" d=\"M 105.7,54.7 L 121.1,53.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-20 atom-13 atom-21\" d=\"M 105.7,54.7 L 97.3,41.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-14 atom-14 atom-15\" d=\"M 121.1,53.9 L 124.4,59.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-14 atom-14 atom-15\" d=\"M 124.4,59.0 L 127.8,64.2\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-15 atom-15 atom-16\" d=\"M 128.2,69.4 L 125.3,74.9\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-15 atom-15 atom-16\" d=\"M 125.3,74.9 L 122.5,80.5\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-24 atom-20 atom-15\" d=\"M 144.9,66.0 L 138.2,66.3\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-24 atom-20 atom-15\" d=\"M 138.2,66.3 L 131.5,66.7\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-16 atom-16 atom-17\" d=\"M 122.5,80.5 L 130.9,93.4\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-17 atom-17 atom-18\" d=\"M 130.9,93.4 L 137.4,93.1\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-17 atom-17 atom-18\" d=\"M 137.4,93.1 L 143.9,92.8\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-18 atom-18 atom-19\" d=\"M 147.6,90.0 L 150.4,84.5\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-18 atom-18 atom-19\" d=\"M 150.4,84.5 L 153.3,78.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-19 atom-19 atom-20\" d=\"M 153.3,78.9 L 144.9,66.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-21 atom-21 atom-22\" d=\"M 97.3,41.8 L 81.9,42.6\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"atom-0\" d=\"M 49.1 44.2 Q 49.1 43.2, 49.6 42.6 Q 50.1 42.0, 51.1 42.0 Q 52.1 42.0, 52.6 42.6 Q 53.1 43.2, 53.1 44.2 Q 53.1 45.3, 52.6 45.9 Q 52.0 46.5, 51.1 46.5 Q 50.1 46.5, 49.6 45.9 Q 49.1 45.3, 49.1 44.2 M 51.1 46.0 Q 51.8 46.0, 52.1 45.5 Q 52.5 45.1, 52.5 44.2 Q 52.5 43.4, 52.1 42.9 Q 51.8 42.5, 51.1 42.5 Q 50.4 42.5, 50.1 42.9 Q 49.7 43.3, 49.7 44.2 Q 49.7 45.1, 50.1 45.5 Q 50.4 46.0, 51.1 46.0 \" fill=\"#FF0000\"/>\n<path class=\"atom-2\" d=\"M 46.9 68.7 L 47.5 68.7 L 47.5 70.5 L 49.7 70.5 L 49.7 68.7 L 50.3 68.7 L 50.3 73.0 L 49.7 73.0 L 49.7 71.0 L 47.5 71.0 L 47.5 73.0 L 46.9 73.0 L 46.9 68.7 \" fill=\"#0000FF\"/>\n<path class=\"atom-2\" d=\"M 51.5 68.7 L 53.0 71.0 Q 53.1 71.2, 53.3 71.6 Q 53.6 72.0, 53.6 72.1 L 53.6 68.7 L 54.2 68.7 L 54.2 73.0 L 53.6 73.0 L 52.0 70.5 Q 51.8 70.2, 51.7 69.9 Q 51.5 69.5, 51.4 69.4 L 51.4 73.0 L 50.8 73.0 L 50.8 68.7 L 51.5 68.7 \" fill=\"#0000FF\"/>\n<path class=\"atom-9\" d=\"M 80.0 76.9 Q 80.0 75.8, 80.5 75.3 Q 81.0 74.7, 82.0 74.7 Q 82.9 74.7, 83.3 75.3 L 82.9 75.7 Q 82.6 75.2, 82.0 75.2 Q 81.3 75.2, 81.0 75.7 Q 80.6 76.1, 80.6 76.9 Q 80.6 77.8, 81.0 78.2 Q 81.3 78.7, 82.0 78.7 Q 82.5 78.7, 83.1 78.4 L 83.2 78.9 Q 83.0 79.0, 82.7 79.1 Q 82.3 79.2, 81.9 79.2 Q 81.0 79.2, 80.5 78.6 Q 80.0 78.0, 80.0 76.9 \" fill=\"#00CC00\"/>\n<path class=\"atom-9\" d=\"M 83.9 74.4 L 84.4 74.4 L 84.4 79.1 L 83.9 79.1 L 83.9 74.4 \" fill=\"#00CC00\"/>\n<path class=\"atom-10\" d=\"M 73.9 54.1 L 75.4 56.4 Q 75.5 56.7, 75.7 57.1 Q 75.9 57.5, 76.0 57.5 L 76.0 54.1 L 76.5 54.1 L 76.5 58.5 L 75.9 58.5 L 74.4 56.0 Q 74.2 55.7, 74.0 55.3 Q 73.9 55.0, 73.8 54.9 L 73.8 58.5 L 73.2 58.5 L 73.2 54.1 L 73.9 54.1 \" fill=\"#0000FF\"/>\n<path class=\"atom-15\" d=\"M 128.5 64.6 L 129.9 66.9 Q 130.1 67.1, 130.3 67.6 Q 130.5 68.0, 130.5 68.0 L 130.5 64.6 L 131.1 64.6 L 131.1 69.0 L 130.5 69.0 L 129.0 66.4 Q 128.8 66.1, 128.6 65.8 Q 128.4 65.5, 128.4 65.4 L 128.4 69.0 L 127.8 69.0 L 127.8 64.6 L 128.5 64.6 \" fill=\"#0000FF\"/>\n<path class=\"atom-18\" d=\"M 144.3 92.6 Q 144.3 91.6, 144.8 91.0 Q 145.3 90.4, 146.3 90.4 Q 147.2 90.4, 147.7 91.0 Q 148.3 91.6, 148.3 92.6 Q 148.3 93.7, 147.7 94.3 Q 147.2 94.9, 146.3 94.9 Q 145.3 94.9, 144.8 94.3 Q 144.3 93.7, 144.3 92.6 M 146.3 94.4 Q 146.9 94.4, 147.3 94.0 Q 147.6 93.5, 147.6 92.6 Q 147.6 91.8, 147.3 91.4 Q 146.9 90.9, 146.3 90.9 Q 145.6 90.9, 145.2 91.4 Q 144.9 91.8, 144.9 92.6 Q 144.9 93.5, 145.2 94.0 Q 145.6 94.4, 146.3 94.4 \" fill=\"#FF0000\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 251.5,47.7 L 254.9,52.8\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 254.9,52.8 L 258.2,58.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 254.1,46.0 L 257.5,51.1\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 257.5,51.1 L 260.8,56.3\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-1 atom-1 atom-2\" d=\"M 259.5,57.1 L 256.7,62.7\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-1 atom-1 atom-2\" d=\"M 256.7,62.7 L 253.8,68.3\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-9 atom-1 atom-10\" d=\"M 259.5,57.1 L 266.2,56.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-9 atom-1 atom-10\" d=\"M 266.2,56.8 L 272.8,56.4\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-2 atom-2 atom-3\" d=\"M 254.2,73.4 L 257.5,78.6\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-2 atom-2 atom-3\" d=\"M 257.5,78.6 L 260.9,83.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-3 atom-3 atom-4\" d=\"M 260.9,83.8 L 253.9,97.5\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-3 atom-3 atom-4\" d=\"M 262.6,87.2 L 257.7,96.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-22 atom-9 atom-3\" d=\"M 276.3,83.0 L 260.9,83.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-4 atom-4 atom-5\" d=\"M 253.9,97.5 L 262.3,110.4\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-5 atom-5 atom-6\" d=\"M 262.3,110.4 L 277.7,109.6\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-5 atom-5 atom-6\" d=\"M 264.5,107.2 L 275.2,106.7\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-6 atom-6 atom-7\" d=\"M 277.7,109.6 L 281.1,114.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-6 atom-6 atom-7\" d=\"M 281.1,114.8 L 284.4,120.0\" style=\"fill:none;fill-rule:evenodd;stroke:#33CCCC;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-7 atom-6 atom-8\" d=\"M 277.7,109.6 L 284.7,95.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-8 atom-8 atom-9\" d=\"M 284.7,95.9 L 276.3,83.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-8 atom-8 atom-9\" d=\"M 280.8,95.6 L 275.0,86.6\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-10 atom-10 atom-11\" d=\"M 276.6,58.9 L 279.9,64.1\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-10 atom-10 atom-11\" d=\"M 279.9,64.1 L 283.3,69.2\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-23 atom-22 atom-10\" d=\"M 281.9,42.6 L 279.0,48.2\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-23 atom-22 atom-10\" d=\"M 279.0,48.2 L 276.2,53.7\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-11 atom-11 atom-12\" d=\"M 283.3,69.2 L 298.7,68.4\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-12 atom-12 atom-13\" d=\"M 298.7,68.4 L 305.7,54.7\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-13 atom-13 atom-14\" d=\"M 305.7,54.7 L 321.1,53.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-20 atom-13 atom-21\" d=\"M 305.7,54.7 L 297.3,41.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-14 atom-14 atom-15\" d=\"M 321.1,53.9 L 324.4,59.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-14 atom-14 atom-15\" d=\"M 324.4,59.0 L 327.8,64.2\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-15 atom-15 atom-16\" d=\"M 328.2,69.4 L 325.3,74.9\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-15 atom-15 atom-16\" d=\"M 325.3,74.9 L 322.5,80.5\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-24 atom-20 atom-15\" d=\"M 344.9,66.0 L 338.2,66.3\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-24 atom-20 atom-15\" d=\"M 338.2,66.3 L 331.5,66.7\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-16 atom-16 atom-17\" d=\"M 322.5,80.5 L 330.9,93.4\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-17 atom-17 atom-18\" d=\"M 330.9,93.4 L 337.4,93.1\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-17 atom-17 atom-18\" d=\"M 337.4,93.1 L 343.9,92.8\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-18 atom-18 atom-19\" d=\"M 347.6,90.0 L 350.4,84.5\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-18 atom-18 atom-19\" d=\"M 350.4,84.5 L 353.3,78.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-19 atom-19 atom-20\" d=\"M 353.3,78.9 L 344.9,66.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-21 atom-21 atom-22\" d=\"M 297.3,41.8 L 281.9,42.6\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"atom-0\" d=\"M 249.1 44.2 Q 249.1 43.2, 249.6 42.6 Q 250.1 42.0, 251.1 42.0 Q 252.1 42.0, 252.6 42.6 Q 253.1 43.2, 253.1 44.2 Q 253.1 45.3, 252.6 45.9 Q 252.0 46.5, 251.1 46.5 Q 250.1 46.5, 249.6 45.9 Q 249.1 45.3, 249.1 44.2 M 251.1 46.0 Q 251.8 46.0, 252.1 45.5 Q 252.5 45.1, 252.5 44.2 Q 252.5 43.4, 252.1 42.9 Q 251.8 42.5, 251.1 42.5 Q 250.4 42.5, 250.1 42.9 Q 249.7 43.3, 249.7 44.2 Q 249.7 45.1, 250.1 45.5 Q 250.4 46.0, 251.1 46.0 \" fill=\"#FF0000\"/>\n<path class=\"atom-2\" d=\"M 246.9 68.7 L 247.5 68.7 L 247.5 70.5 L 249.7 70.5 L 249.7 68.7 L 250.3 68.7 L 250.3 73.0 L 249.7 73.0 L 249.7 71.0 L 247.5 71.0 L 247.5 73.0 L 246.9 73.0 L 246.9 68.7 \" fill=\"#0000FF\"/>\n<path class=\"atom-2\" d=\"M 251.5 68.7 L 253.0 71.0 Q 253.1 71.2, 253.3 71.6 Q 253.6 72.0, 253.6 72.1 L 253.6 68.7 L 254.2 68.7 L 254.2 73.0 L 253.6 73.0 L 252.0 70.5 Q 251.8 70.2, 251.7 69.9 Q 251.5 69.5, 251.4 69.4 L 251.4 73.0 L 250.8 73.0 L 250.8 68.7 L 251.5 68.7 \" fill=\"#0000FF\"/>\n<path class=\"atom-7\" d=\"M 284.8 120.4 L 287.4 120.4 L 287.4 120.9 L 285.4 120.9 L 285.4 122.2 L 287.2 122.2 L 287.2 122.7 L 285.4 122.7 L 285.4 124.7 L 284.8 124.7 L 284.8 120.4 \" fill=\"#33CCCC\"/>\n<path class=\"atom-10\" d=\"M 273.9 54.1 L 275.4 56.4 Q 275.5 56.7, 275.7 57.1 Q 275.9 57.5, 276.0 57.5 L 276.0 54.1 L 276.5 54.1 L 276.5 58.5 L 275.9 58.5 L 274.4 56.0 Q 274.2 55.7, 274.0 55.3 Q 273.9 55.0, 273.8 54.9 L 273.8 58.5 L 273.2 58.5 L 273.2 54.1 L 273.9 54.1 \" fill=\"#0000FF\"/>\n<path class=\"atom-15\" d=\"M 328.5 64.6 L 329.9 66.9 Q 330.1 67.1, 330.3 67.6 Q 330.5 68.0, 330.5 68.0 L 330.5 64.6 L 331.1 64.6 L 331.1 69.0 L 330.5 69.0 L 329.0 66.4 Q 328.8 66.1, 328.6 65.8 Q 328.4 65.5, 328.4 65.4 L 328.4 69.0 L 327.8 69.0 L 327.8 64.6 L 328.5 64.6 \" fill=\"#0000FF\"/>\n<path class=\"atom-18\" d=\"M 344.3 92.6 Q 344.3 91.6, 344.8 91.0 Q 345.3 90.4, 346.3 90.4 Q 347.2 90.4, 347.7 91.0 Q 348.3 91.6, 348.3 92.6 Q 348.3 93.7, 347.7 94.3 Q 347.2 94.9, 346.3 94.9 Q 345.3 94.9, 344.8 94.3 Q 344.3 93.7, 344.3 92.6 M 346.3 94.4 Q 346.9 94.4, 347.3 94.0 Q 347.6 93.5, 347.6 92.6 Q 347.6 91.8, 347.3 91.4 Q 346.9 90.9, 346.3 90.9 Q 345.6 90.9, 345.2 91.4 Q 344.9 91.8, 344.9 92.6 Q 344.9 93.5, 345.2 94.0 Q 345.6 94.4, 346.3 94.4 \" fill=\"#FF0000\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 492.8,132.9 L 489.5,127.7\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 489.5,127.7 L 486.1,122.5\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 495.4,131.2 L 492.6,126.8\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 492.6,126.8 L 489.7,122.4\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 490.2,134.6 L 487.4,130.2\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 487.4,130.2 L 484.5,125.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-1 atom-1 atom-2\" d=\"M 486.1,122.5 L 477.7,109.6\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-2 atom-2 atom-3\" d=\"M 477.7,109.6 L 462.3,110.4\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-2 atom-2 atom-3\" d=\"M 475.2,106.7 L 464.5,107.2\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-23 atom-23 atom-2\" d=\"M 484.7,95.9 L 477.7,109.6\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-3 atom-3 atom-4\" d=\"M 462.3,110.4 L 453.9,97.5\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-4 atom-4 atom-5\" d=\"M 453.9,97.5 L 460.9,83.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-4 atom-4 atom-5\" d=\"M 457.7,96.9 L 462.6,87.2\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-5 atom-5 atom-6\" d=\"M 460.9,83.8 L 457.5,78.6\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-5 atom-5 atom-6\" d=\"M 457.5,78.6 L 454.2,73.4\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-21 atom-5 atom-22\" d=\"M 460.9,83.8 L 476.3,83.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-6 atom-6 atom-7\" d=\"M 453.8,68.3 L 456.7,62.7\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-6 atom-6 atom-7\" d=\"M 456.7,62.7 L 459.5,57.1\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-7 atom-7 atom-8\" d=\"M 460.8,56.3 L 457.5,51.1\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-7 atom-7 atom-8\" d=\"M 457.5,51.1 L 454.1,46.0\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-7 atom-7 atom-8\" d=\"M 458.2,58.0 L 454.9,52.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-7 atom-7 atom-8\" d=\"M 454.9,52.8 L 451.5,47.7\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-8 atom-7 atom-9\" d=\"M 459.5,57.1 L 466.2,56.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-8 atom-7 atom-9\" d=\"M 466.2,56.8 L 472.8,56.4\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-9 atom-9 atom-10\" d=\"M 476.6,58.9 L 479.9,64.1\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-9 atom-9 atom-10\" d=\"M 479.9,64.1 L 483.3,69.2\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-24 atom-21 atom-9\" d=\"M 481.9,42.6 L 479.0,48.2\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-24 atom-21 atom-9\" d=\"M 479.0,48.2 L 476.2,53.7\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-10 atom-10 atom-11\" d=\"M 483.3,69.2 L 498.7,68.4\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-11 atom-11 atom-12\" d=\"M 498.7,68.4 L 505.7,54.7\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-12 atom-12 atom-13\" d=\"M 505.7,54.7 L 521.1,53.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-19 atom-12 atom-20\" d=\"M 505.7,54.7 L 497.3,41.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-13 atom-13 atom-14\" d=\"M 521.1,53.9 L 524.4,59.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-13 atom-13 atom-14\" d=\"M 524.4,59.0 L 527.8,64.2\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-14 atom-14 atom-15\" d=\"M 528.2,69.4 L 525.3,74.9\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-14 atom-14 atom-15\" d=\"M 525.3,74.9 L 522.5,80.5\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-25 atom-19 atom-14\" d=\"M 544.9,66.0 L 538.2,66.3\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-25 atom-19 atom-14\" d=\"M 538.2,66.3 L 531.5,66.7\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-15 atom-15 atom-16\" d=\"M 522.5,80.5 L 530.9,93.4\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-16 atom-16 atom-17\" d=\"M 530.9,93.4 L 537.4,93.1\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-16 atom-16 atom-17\" d=\"M 537.4,93.1 L 543.9,92.8\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-17 atom-17 atom-18\" d=\"M 547.6,90.0 L 550.4,84.5\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-17 atom-17 atom-18\" d=\"M 550.4,84.5 L 553.3,78.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-18 atom-18 atom-19\" d=\"M 553.3,78.9 L 544.9,66.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-20 atom-20 atom-21\" d=\"M 497.3,41.8 L 481.9,42.6\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-22 atom-22 atom-23\" d=\"M 476.3,83.0 L 484.7,95.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-22 atom-22 atom-23\" d=\"M 475.0,86.6 L 480.8,95.6\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"atom-0\" d=\"M 493.5 133.3 L 495.0 135.6 Q 495.1 135.8, 495.3 136.2 Q 495.6 136.7, 495.6 136.7 L 495.6 133.3 L 496.2 133.3 L 496.2 137.7 L 495.6 137.7 L 494.0 135.1 Q 493.8 134.8, 493.7 134.5 Q 493.5 134.2, 493.4 134.0 L 493.4 137.7 L 492.8 137.7 L 492.8 133.3 L 493.5 133.3 \" fill=\"#0000FF\"/>\n<path class=\"atom-6\" d=\"M 446.9 68.7 L 447.5 68.7 L 447.5 70.5 L 449.7 70.5 L 449.7 68.7 L 450.3 68.7 L 450.3 73.0 L 449.7 73.0 L 449.7 71.0 L 447.5 71.0 L 447.5 73.0 L 446.9 73.0 L 446.9 68.7 \" fill=\"#0000FF\"/>\n<path class=\"atom-6\" d=\"M 451.5 68.7 L 453.0 71.0 Q 453.1 71.2, 453.3 71.6 Q 453.6 72.0, 453.6 72.1 L 453.6 68.7 L 454.2 68.7 L 454.2 73.0 L 453.6 73.0 L 452.0 70.5 Q 451.8 70.2, 451.7 69.9 Q 451.5 69.5, 451.4 69.4 L 451.4 73.0 L 450.8 73.0 L 450.8 68.7 L 451.5 68.7 \" fill=\"#0000FF\"/>\n<path class=\"atom-8\" d=\"M 449.1 44.2 Q 449.1 43.2, 449.6 42.6 Q 450.1 42.0, 451.1 42.0 Q 452.1 42.0, 452.6 42.6 Q 453.1 43.2, 453.1 44.2 Q 453.1 45.3, 452.6 45.9 Q 452.0 46.5, 451.1 46.5 Q 450.1 46.5, 449.6 45.9 Q 449.1 45.3, 449.1 44.2 M 451.1 46.0 Q 451.8 46.0, 452.1 45.5 Q 452.5 45.1, 452.5 44.2 Q 452.5 43.4, 452.1 42.9 Q 451.8 42.5, 451.1 42.5 Q 450.4 42.5, 450.1 42.9 Q 449.7 43.3, 449.7 44.2 Q 449.7 45.1, 450.1 45.5 Q 450.4 46.0, 451.1 46.0 \" fill=\"#FF0000\"/>\n<path class=\"atom-9\" d=\"M 473.9 54.1 L 475.4 56.4 Q 475.5 56.7, 475.7 57.1 Q 475.9 57.5, 476.0 57.5 L 476.0 54.1 L 476.5 54.1 L 476.5 58.5 L 475.9 58.5 L 474.4 56.0 Q 474.2 55.7, 474.0 55.3 Q 473.9 55.0, 473.8 54.9 L 473.8 58.5 L 473.2 58.5 L 473.2 54.1 L 473.9 54.1 \" fill=\"#0000FF\"/>\n<path class=\"atom-14\" d=\"M 528.5 64.6 L 529.9 66.9 Q 530.1 67.1, 530.3 67.6 Q 530.5 68.0, 530.5 68.0 L 530.5 64.6 L 531.1 64.6 L 531.1 69.0 L 530.5 69.0 L 529.0 66.4 Q 528.8 66.1, 528.6 65.8 Q 528.4 65.5, 528.4 65.4 L 528.4 69.0 L 527.8 69.0 L 527.8 64.6 L 528.5 64.6 \" fill=\"#0000FF\"/>\n<path class=\"atom-17\" d=\"M 544.3 92.6 Q 544.3 91.6, 544.8 91.0 Q 545.3 90.4, 546.3 90.4 Q 547.2 90.4, 547.7 91.0 Q 548.3 91.6, 548.3 92.6 Q 548.3 93.7, 547.7 94.3 Q 547.2 94.9, 546.3 94.9 Q 545.3 94.9, 544.8 94.3 Q 544.3 93.7, 544.3 92.6 M 546.3 94.4 Q 546.9 94.4, 547.3 94.0 Q 547.6 93.5, 547.6 92.6 Q 547.6 91.8, 547.3 91.4 Q 546.9 90.9, 546.3 90.9 Q 545.6 90.9, 545.2 91.4 Q 544.9 91.8, 544.9 92.6 Q 544.9 93.5, 545.2 94.0 Q 545.6 94.4, 546.3 94.4 \" fill=\"#FF0000\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 700.1,95.1 L 684.7,95.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-1 atom-1 atom-2\" d=\"M 684.7,95.9 L 677.7,109.6\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-1 atom-1 atom-2\" d=\"M 680.9,96.6 L 676.0,106.2\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-22 atom-22 atom-1\" d=\"M 676.3,83.0 L 684.7,95.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-2 atom-2 atom-3\" d=\"M 677.7,109.6 L 662.3,110.4\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-3 atom-3 atom-4\" d=\"M 662.3,110.4 L 653.9,97.5\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-3 atom-3 atom-4\" d=\"M 663.6,106.8 L 657.8,97.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-4 atom-4 atom-5\" d=\"M 653.9,97.5 L 660.9,83.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-5 atom-5 atom-6\" d=\"M 660.9,83.8 L 657.5,78.6\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-5 atom-5 atom-6\" d=\"M 657.5,78.6 L 654.2,73.4\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-21 atom-5 atom-22\" d=\"M 660.9,83.8 L 676.3,83.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-21 atom-5 atom-22\" d=\"M 663.4,86.7 L 674.1,86.2\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-6 atom-6 atom-7\" d=\"M 653.8,68.3 L 656.7,62.7\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-6 atom-6 atom-7\" d=\"M 656.7,62.7 L 659.5,57.1\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-7 atom-7 atom-8\" d=\"M 660.8,56.3 L 657.5,51.1\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-7 atom-7 atom-8\" d=\"M 657.5,51.1 L 654.1,46.0\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-7 atom-7 atom-8\" d=\"M 658.2,58.0 L 654.9,52.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-7 atom-7 atom-8\" d=\"M 654.9,52.8 L 651.5,47.7\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-8 atom-7 atom-9\" d=\"M 659.5,57.1 L 666.2,56.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-8 atom-7 atom-9\" d=\"M 666.2,56.8 L 672.8,56.4\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-9 atom-9 atom-10\" d=\"M 676.6,58.9 L 679.9,64.1\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-9 atom-9 atom-10\" d=\"M 679.9,64.1 L 683.3,69.2\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-23 atom-21 atom-9\" d=\"M 681.9,42.6 L 679.0,48.2\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-23 atom-21 atom-9\" d=\"M 679.0,48.2 L 676.2,53.7\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-10 atom-10 atom-11\" d=\"M 683.3,69.2 L 698.7,68.4\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-11 atom-11 atom-12\" d=\"M 698.7,68.4 L 705.7,54.7\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-12 atom-12 atom-13\" d=\"M 705.7,54.7 L 721.1,53.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-19 atom-12 atom-20\" d=\"M 705.7,54.7 L 697.3,41.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-13 atom-13 atom-14\" d=\"M 721.1,53.9 L 724.4,59.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-13 atom-13 atom-14\" d=\"M 724.4,59.0 L 727.8,64.2\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-14 atom-14 atom-15\" d=\"M 728.2,69.4 L 725.3,74.9\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-14 atom-14 atom-15\" d=\"M 725.3,74.9 L 722.5,80.5\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-24 atom-19 atom-14\" d=\"M 744.9,66.0 L 738.2,66.3\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-24 atom-19 atom-14\" d=\"M 738.2,66.3 L 731.5,66.7\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-15 atom-15 atom-16\" d=\"M 722.5,80.5 L 730.9,93.4\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-16 atom-16 atom-17\" d=\"M 730.9,93.4 L 737.4,93.1\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-16 atom-16 atom-17\" d=\"M 737.4,93.1 L 743.9,92.8\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-17 atom-17 atom-18\" d=\"M 747.6,90.0 L 750.4,84.5\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-17 atom-17 atom-18\" d=\"M 750.4,84.5 L 753.3,78.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-18 atom-18 atom-19\" d=\"M 753.3,78.9 L 744.9,66.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-20 atom-20 atom-21\" d=\"M 697.3,41.8 L 681.9,42.6\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"atom-6\" d=\"M 646.9 68.7 L 647.5 68.7 L 647.5 70.5 L 649.7 70.5 L 649.7 68.7 L 650.3 68.7 L 650.3 73.0 L 649.7 73.0 L 649.7 71.0 L 647.5 71.0 L 647.5 73.0 L 646.9 73.0 L 646.9 68.7 \" fill=\"#0000FF\"/>\n<path class=\"atom-6\" d=\"M 651.5 68.7 L 653.0 71.0 Q 653.1 71.2, 653.3 71.6 Q 653.6 72.0, 653.6 72.1 L 653.6 68.7 L 654.2 68.7 L 654.2 73.0 L 653.6 73.0 L 652.0 70.5 Q 651.8 70.2, 651.7 69.9 Q 651.5 69.5, 651.4 69.4 L 651.4 73.0 L 650.8 73.0 L 650.8 68.7 L 651.5 68.7 \" fill=\"#0000FF\"/>\n<path class=\"atom-8\" d=\"M 649.1 44.2 Q 649.1 43.2, 649.6 42.6 Q 650.1 42.0, 651.1 42.0 Q 652.1 42.0, 652.6 42.6 Q 653.1 43.2, 653.1 44.2 Q 653.1 45.3, 652.6 45.9 Q 652.0 46.5, 651.1 46.5 Q 650.1 46.5, 649.6 45.9 Q 649.1 45.3, 649.1 44.2 M 651.1 46.0 Q 651.8 46.0, 652.1 45.5 Q 652.5 45.1, 652.5 44.2 Q 652.5 43.4, 652.1 42.9 Q 651.8 42.5, 651.1 42.5 Q 650.4 42.5, 650.1 42.9 Q 649.7 43.3, 649.7 44.2 Q 649.7 45.1, 650.1 45.5 Q 650.4 46.0, 651.1 46.0 \" fill=\"#FF0000\"/>\n<path class=\"atom-9\" d=\"M 673.9 54.1 L 675.4 56.4 Q 675.5 56.7, 675.7 57.1 Q 675.9 57.5, 676.0 57.5 L 676.0 54.1 L 676.5 54.1 L 676.5 58.5 L 675.9 58.5 L 674.4 56.0 Q 674.2 55.7, 674.0 55.3 Q 673.9 55.0, 673.8 54.9 L 673.8 58.5 L 673.2 58.5 L 673.2 54.1 L 673.9 54.1 \" fill=\"#0000FF\"/>\n<path class=\"atom-14\" d=\"M 728.5 64.6 L 729.9 66.9 Q 730.1 67.1, 730.3 67.6 Q 730.5 68.0, 730.5 68.0 L 730.5 64.6 L 731.1 64.6 L 731.1 69.0 L 730.5 69.0 L 729.0 66.4 Q 728.8 66.1, 728.6 65.8 Q 728.4 65.5, 728.4 65.4 L 728.4 69.0 L 727.8 69.0 L 727.8 64.6 L 728.5 64.6 \" fill=\"#0000FF\"/>\n<path class=\"atom-17\" d=\"M 744.3 92.6 Q 744.3 91.6, 744.8 91.0 Q 745.3 90.4, 746.3 90.4 Q 747.2 90.4, 747.7 91.0 Q 748.3 91.6, 748.3 92.6 Q 748.3 93.7, 747.7 94.3 Q 747.2 94.9, 746.3 94.9 Q 745.3 94.9, 744.8 94.3 Q 744.3 93.7, 744.3 92.6 M 746.3 94.4 Q 746.9 94.4, 747.3 94.0 Q 747.6 93.5, 747.6 92.6 Q 747.6 91.8, 747.3 91.4 Q 746.9 90.9, 746.3 90.9 Q 745.6 90.9, 745.2 91.4 Q 744.9 91.8, 744.9 92.6 Q 744.9 93.5, 745.2 94.0 Q 745.6 94.4, 746.3 94.4 \" fill=\"#FF0000\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 51.5,197.7 L 54.9,202.8\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 54.9,202.8 L 58.2,208.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 54.1,196.0 L 57.5,201.1\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 57.5,201.1 L 60.8,206.3\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-1 atom-1 atom-2\" d=\"M 59.5,207.1 L 56.7,212.7\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-1 atom-1 atom-2\" d=\"M 56.7,212.7 L 53.8,218.3\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-9 atom-1 atom-10\" d=\"M 59.5,207.1 L 66.2,206.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-9 atom-1 atom-10\" d=\"M 66.2,206.8 L 72.8,206.4\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-2 atom-2 atom-3\" d=\"M 54.2,223.4 L 57.5,228.6\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-2 atom-2 atom-3\" d=\"M 57.5,228.6 L 60.9,233.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-3 atom-3 atom-4\" d=\"M 60.9,233.8 L 53.9,247.5\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-3 atom-3 atom-4\" d=\"M 62.6,237.2 L 57.7,246.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-22 atom-9 atom-3\" d=\"M 76.3,233.0 L 60.9,233.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-4 atom-4 atom-5\" d=\"M 53.9,247.5 L 62.3,260.4\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-5 atom-5 atom-6\" d=\"M 62.3,260.4 L 59.5,266.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-5 atom-5 atom-6\" d=\"M 59.5,266.0 L 56.6,271.6\" style=\"fill:none;fill-rule:evenodd;stroke:#33CCCC;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-6 atom-5 atom-7\" d=\"M 62.3,260.4 L 77.7,259.6\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-6 atom-5 atom-7\" d=\"M 64.5,257.2 L 75.2,256.7\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-7 atom-7 atom-8\" d=\"M 77.7,259.6 L 84.7,245.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-8 atom-8 atom-9\" d=\"M 84.7,245.9 L 76.3,233.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-8 atom-8 atom-9\" d=\"M 80.8,245.6 L 75.0,236.6\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-10 atom-10 atom-11\" d=\"M 76.6,208.9 L 79.9,214.1\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-10 atom-10 atom-11\" d=\"M 79.9,214.1 L 83.3,219.2\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-23 atom-22 atom-10\" d=\"M 81.9,192.6 L 79.0,198.2\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-23 atom-22 atom-10\" d=\"M 79.0,198.2 L 76.2,203.7\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-11 atom-11 atom-12\" d=\"M 83.3,219.2 L 98.7,218.4\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-12 atom-12 atom-13\" d=\"M 98.7,218.4 L 105.7,204.7\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-13 atom-13 atom-14\" d=\"M 105.7,204.7 L 121.1,203.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-20 atom-13 atom-21\" d=\"M 105.7,204.7 L 97.3,191.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-14 atom-14 atom-15\" d=\"M 121.1,203.9 L 124.4,209.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-14 atom-14 atom-15\" d=\"M 124.4,209.0 L 127.8,214.2\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-15 atom-15 atom-16\" d=\"M 128.2,219.4 L 125.3,224.9\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-15 atom-15 atom-16\" d=\"M 125.3,224.9 L 122.5,230.5\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-24 atom-20 atom-15\" d=\"M 144.9,216.0 L 138.2,216.3\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-24 atom-20 atom-15\" d=\"M 138.2,216.3 L 131.5,216.7\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-16 atom-16 atom-17\" d=\"M 122.5,230.5 L 130.9,243.4\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-17 atom-17 atom-18\" d=\"M 130.9,243.4 L 137.4,243.1\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-17 atom-17 atom-18\" d=\"M 137.4,243.1 L 143.9,242.8\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-18 atom-18 atom-19\" d=\"M 147.6,240.0 L 150.4,234.5\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-18 atom-18 atom-19\" d=\"M 150.4,234.5 L 153.3,228.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-19 atom-19 atom-20\" d=\"M 153.3,228.9 L 144.9,216.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-21 atom-21 atom-22\" d=\"M 97.3,191.8 L 81.9,192.6\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"atom-0\" d=\"M 49.1 194.2 Q 49.1 193.2, 49.6 192.6 Q 50.1 192.0, 51.1 192.0 Q 52.1 192.0, 52.6 192.6 Q 53.1 193.2, 53.1 194.2 Q 53.1 195.3, 52.6 195.9 Q 52.0 196.5, 51.1 196.5 Q 50.1 196.5, 49.6 195.9 Q 49.1 195.3, 49.1 194.2 M 51.1 196.0 Q 51.8 196.0, 52.1 195.5 Q 52.5 195.1, 52.5 194.2 Q 52.5 193.4, 52.1 192.9 Q 51.8 192.5, 51.1 192.5 Q 50.4 192.5, 50.1 192.9 Q 49.7 193.3, 49.7 194.2 Q 49.7 195.1, 50.1 195.5 Q 50.4 196.0, 51.1 196.0 \" fill=\"#FF0000\"/>\n<path class=\"atom-2\" d=\"M 46.9 218.7 L 47.5 218.7 L 47.5 220.5 L 49.7 220.5 L 49.7 218.7 L 50.3 218.7 L 50.3 223.0 L 49.7 223.0 L 49.7 221.0 L 47.5 221.0 L 47.5 223.0 L 46.9 223.0 L 46.9 218.7 \" fill=\"#0000FF\"/>\n<path class=\"atom-2\" d=\"M 51.5 218.7 L 53.0 221.0 Q 53.1 221.2, 53.3 221.6 Q 53.6 222.0, 53.6 222.1 L 53.6 218.7 L 54.2 218.7 L 54.2 223.0 L 53.6 223.0 L 52.0 220.5 Q 51.8 220.2, 51.7 219.9 Q 51.5 219.5, 51.4 219.4 L 51.4 223.0 L 50.8 223.0 L 50.8 218.7 L 51.5 218.7 \" fill=\"#0000FF\"/>\n<path class=\"atom-6\" d=\"M 54.0 272.0 L 56.6 272.0 L 56.6 272.5 L 54.6 272.5 L 54.6 273.8 L 56.4 273.8 L 56.4 274.3 L 54.6 274.3 L 54.6 276.4 L 54.0 276.4 L 54.0 272.0 \" fill=\"#33CCCC\"/>\n<path class=\"atom-10\" d=\"M 73.9 204.1 L 75.4 206.4 Q 75.5 206.7, 75.7 207.1 Q 75.9 207.5, 76.0 207.5 L 76.0 204.1 L 76.5 204.1 L 76.5 208.5 L 75.9 208.5 L 74.4 206.0 Q 74.2 205.7, 74.0 205.3 Q 73.9 205.0, 73.8 204.9 L 73.8 208.5 L 73.2 208.5 L 73.2 204.1 L 73.9 204.1 \" fill=\"#0000FF\"/>\n<path class=\"atom-15\" d=\"M 128.5 214.6 L 129.9 216.9 Q 130.1 217.1, 130.3 217.6 Q 130.5 218.0, 130.5 218.0 L 130.5 214.6 L 131.1 214.6 L 131.1 219.0 L 130.5 219.0 L 129.0 216.4 Q 128.8 216.1, 128.6 215.8 Q 128.4 215.5, 128.4 215.4 L 128.4 219.0 L 127.8 219.0 L 127.8 214.6 L 128.5 214.6 \" fill=\"#0000FF\"/>\n<path class=\"atom-18\" d=\"M 144.3 242.6 Q 144.3 241.6, 144.8 241.0 Q 145.3 240.4, 146.3 240.4 Q 147.2 240.4, 147.7 241.0 Q 148.3 241.6, 148.3 242.6 Q 148.3 243.7, 147.7 244.3 Q 147.2 244.9, 146.3 244.9 Q 145.3 244.9, 144.8 244.3 Q 144.3 243.7, 144.3 242.6 M 146.3 244.4 Q 146.9 244.4, 147.3 244.0 Q 147.6 243.5, 147.6 242.6 Q 147.6 241.8, 147.3 241.4 Q 146.9 240.9, 146.3 240.9 Q 145.6 240.9, 145.2 241.4 Q 144.9 241.8, 144.9 242.6 Q 144.9 243.5, 145.2 244.0 Q 145.6 244.4, 146.3 244.4 \" fill=\"#FF0000\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 251.5,197.7 L 254.9,202.8\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 254.9,202.8 L 258.2,208.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 254.1,196.0 L 257.5,201.1\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 257.5,201.1 L 260.8,206.3\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-1 atom-1 atom-2\" d=\"M 259.5,207.1 L 256.7,212.7\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-1 atom-1 atom-2\" d=\"M 256.7,212.7 L 253.8,218.3\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-9 atom-1 atom-10\" d=\"M 259.5,207.1 L 266.2,206.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-9 atom-1 atom-10\" d=\"M 266.2,206.8 L 272.8,206.4\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-2 atom-2 atom-3\" d=\"M 254.2,223.4 L 257.5,228.6\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-2 atom-2 atom-3\" d=\"M 257.5,228.6 L 260.9,233.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-3 atom-3 atom-4\" d=\"M 260.9,233.8 L 253.9,247.5\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-3 atom-3 atom-4\" d=\"M 262.6,237.2 L 257.7,246.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-22 atom-8 atom-3\" d=\"M 276.3,233.0 L 260.9,233.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-4 atom-4 atom-5\" d=\"M 253.9,247.5 L 262.3,260.4\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-5 atom-5 atom-6\" d=\"M 262.3,260.4 L 277.7,259.6\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-5 atom-5 atom-6\" d=\"M 264.5,257.2 L 275.2,256.7\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-6 atom-6 atom-7\" d=\"M 277.7,259.6 L 284.7,245.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-7 atom-7 atom-8\" d=\"M 284.7,245.9 L 276.3,233.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-7 atom-7 atom-8\" d=\"M 280.8,245.6 L 275.0,236.6\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-8 atom-8 atom-9\" d=\"M 276.3,233.0 L 278.2,230.7\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-8 atom-8 atom-9\" d=\"M 278.2,230.7 L 280.2,228.5\" style=\"fill:none;fill-rule:evenodd;stroke:#33CCCC;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-10 atom-10 atom-11\" d=\"M 276.6,208.9 L 279.9,214.1\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-10 atom-10 atom-11\" d=\"M 279.9,214.1 L 283.3,219.2\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-23 atom-22 atom-10\" d=\"M 281.9,192.6 L 279.0,198.2\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-23 atom-22 atom-10\" d=\"M 279.0,198.2 L 276.2,203.7\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-11 atom-11 atom-12\" d=\"M 283.3,219.2 L 298.7,218.4\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-12 atom-12 atom-13\" d=\"M 298.7,218.4 L 305.7,204.7\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-13 atom-13 atom-14\" d=\"M 305.7,204.7 L 321.1,203.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-20 atom-13 atom-21\" d=\"M 305.7,204.7 L 297.3,191.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-14 atom-14 atom-15\" d=\"M 321.1,203.9 L 324.4,209.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-14 atom-14 atom-15\" d=\"M 324.4,209.0 L 327.8,214.2\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-15 atom-15 atom-16\" d=\"M 328.2,219.4 L 325.3,224.9\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-15 atom-15 atom-16\" d=\"M 325.3,224.9 L 322.5,230.5\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-24 atom-20 atom-15\" d=\"M 344.9,216.0 L 338.2,216.3\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-24 atom-20 atom-15\" d=\"M 338.2,216.3 L 331.5,216.7\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-16 atom-16 atom-17\" d=\"M 322.5,230.5 L 330.9,243.4\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-17 atom-17 atom-18\" d=\"M 330.9,243.4 L 337.4,243.1\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-17 atom-17 atom-18\" d=\"M 337.4,243.1 L 343.9,242.8\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-18 atom-18 atom-19\" d=\"M 347.6,240.0 L 350.4,234.5\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-18 atom-18 atom-19\" d=\"M 350.4,234.5 L 353.3,228.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-19 atom-19 atom-20\" d=\"M 353.3,228.9 L 344.9,216.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-21 atom-21 atom-22\" d=\"M 297.3,191.8 L 281.9,192.6\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"atom-0\" d=\"M 249.1 194.2 Q 249.1 193.2, 249.6 192.6 Q 250.1 192.0, 251.1 192.0 Q 252.1 192.0, 252.6 192.6 Q 253.1 193.2, 253.1 194.2 Q 253.1 195.3, 252.6 195.9 Q 252.0 196.5, 251.1 196.5 Q 250.1 196.5, 249.6 195.9 Q 249.1 195.3, 249.1 194.2 M 251.1 196.0 Q 251.8 196.0, 252.1 195.5 Q 252.5 195.1, 252.5 194.2 Q 252.5 193.4, 252.1 192.9 Q 251.8 192.5, 251.1 192.5 Q 250.4 192.5, 250.1 192.9 Q 249.7 193.3, 249.7 194.2 Q 249.7 195.1, 250.1 195.5 Q 250.4 196.0, 251.1 196.0 \" fill=\"#FF0000\"/>\n<path class=\"atom-2\" d=\"M 246.9 218.7 L 247.5 218.7 L 247.5 220.5 L 249.7 220.5 L 249.7 218.7 L 250.3 218.7 L 250.3 223.0 L 249.7 223.0 L 249.7 221.0 L 247.5 221.0 L 247.5 223.0 L 246.9 223.0 L 246.9 218.7 \" fill=\"#0000FF\"/>\n<path class=\"atom-2\" d=\"M 251.5 218.7 L 253.0 221.0 Q 253.1 221.2, 253.3 221.6 Q 253.6 222.0, 253.6 222.1 L 253.6 218.7 L 254.2 218.7 L 254.2 223.0 L 253.6 223.0 L 252.0 220.5 Q 251.8 220.2, 251.7 219.9 Q 251.5 219.5, 251.4 219.4 L 251.4 223.0 L 250.8 223.0 L 250.8 218.7 L 251.5 218.7 \" fill=\"#0000FF\"/>\n<path class=\"atom-9\" d=\"M 280.4 224.6 L 283.0 224.6 L 283.0 225.1 L 281.0 225.1 L 281.0 226.4 L 282.7 226.4 L 282.7 226.9 L 281.0 226.9 L 281.0 229.0 L 280.4 229.0 L 280.4 224.6 \" fill=\"#33CCCC\"/>\n<path class=\"atom-10\" d=\"M 273.9 204.1 L 275.4 206.4 Q 275.5 206.7, 275.7 207.1 Q 275.9 207.5, 276.0 207.5 L 276.0 204.1 L 276.5 204.1 L 276.5 208.5 L 275.9 208.5 L 274.4 206.0 Q 274.2 205.7, 274.0 205.3 Q 273.9 205.0, 273.8 204.9 L 273.8 208.5 L 273.2 208.5 L 273.2 204.1 L 273.9 204.1 \" fill=\"#0000FF\"/>\n<path class=\"atom-15\" d=\"M 328.5 214.6 L 329.9 216.9 Q 330.1 217.1, 330.3 217.6 Q 330.5 218.0, 330.5 218.0 L 330.5 214.6 L 331.1 214.6 L 331.1 219.0 L 330.5 219.0 L 329.0 216.4 Q 328.8 216.1, 328.6 215.8 Q 328.4 215.5, 328.4 215.4 L 328.4 219.0 L 327.8 219.0 L 327.8 214.6 L 328.5 214.6 \" fill=\"#0000FF\"/>\n<path class=\"atom-18\" d=\"M 344.3 242.6 Q 344.3 241.6, 344.8 241.0 Q 345.3 240.4, 346.3 240.4 Q 347.2 240.4, 347.7 241.0 Q 348.3 241.6, 348.3 242.6 Q 348.3 243.7, 347.7 244.3 Q 347.2 244.9, 346.3 244.9 Q 345.3 244.9, 344.8 244.3 Q 344.3 243.7, 344.3 242.6 M 346.3 244.4 Q 346.9 244.4, 347.3 244.0 Q 347.6 243.5, 347.6 242.6 Q 347.6 241.8, 347.3 241.4 Q 346.9 240.9, 346.3 240.9 Q 345.6 240.9, 345.2 241.4 Q 344.9 241.8, 344.9 242.6 Q 344.9 243.5, 345.2 244.0 Q 345.6 244.4, 346.3 244.4 \" fill=\"#FF0000\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 594.2,263.6 L 587.7,263.6\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 587.7,263.6 L 581.2,263.6\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-1 atom-1 atom-2\" d=\"M 577.3,261.0 L 574.2,255.6\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-1 atom-1 atom-2\" d=\"M 574.2,255.6 L 571.1,250.2\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-2 atom-2 atom-3\" d=\"M 571.1,250.2 L 555.7,250.2\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-3 atom-3 atom-4\" d=\"M 555.7,250.2 L 552.6,244.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-3 atom-3 atom-4\" d=\"M 552.6,244.8 L 549.5,239.4\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-4 atom-4 atom-5\" d=\"M 549.5,234.3 L 552.6,228.9\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-4 atom-4 atom-5\" d=\"M 552.6,228.9 L 555.7,223.5\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-7 atom-4 atom-8\" d=\"M 545.9,236.9 L 539.3,236.9\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-7 atom-4 atom-8\" d=\"M 539.3,236.9 L 532.6,236.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-5 atom-5 atom-6\" d=\"M 555.7,223.5 L 571.1,223.5\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-6 atom-6 atom-7\" d=\"M 571.1,223.5 L 574.2,218.2\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-6 atom-6 atom-7\" d=\"M 574.2,218.2 L 577.3,212.8\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-8 atom-8 atom-9\" d=\"M 531.2,236.1 L 528.1,241.5\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-8 atom-8 atom-9\" d=\"M 528.1,241.5 L 525.0,246.9\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-8 atom-8 atom-9\" d=\"M 533.9,237.6 L 530.8,243.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-8 atom-8 atom-9\" d=\"M 530.8,243.0 L 527.7,248.4\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-9 atom-8 atom-10\" d=\"M 532.6,236.9 L 529.5,231.5\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-9 atom-8 atom-10\" d=\"M 529.5,231.5 L 526.3,226.1\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-10 atom-10 atom-11\" d=\"M 522.8,223.5 L 516.1,223.5\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-10 atom-10 atom-11\" d=\"M 516.1,223.5 L 509.4,223.5\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-11 atom-11 atom-12\" d=\"M 509.4,223.5 L 501.7,236.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-11 atom-11 atom-12\" d=\"M 505.6,224.0 L 500.2,233.3\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-17 atom-16 atom-11\" d=\"M 501.7,210.2 L 509.4,223.5\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-12 atom-12 atom-13\" d=\"M 501.7,236.9 L 486.3,236.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-13 atom-13 atom-14\" d=\"M 486.3,236.9 L 478.6,223.5\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-13 atom-13 atom-14\" d=\"M 487.8,233.3 L 482.4,224.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-14 atom-14 atom-15\" d=\"M 478.6,223.5 L 486.3,210.2\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-15 atom-15 atom-16\" d=\"M 486.3,210.2 L 501.7,210.2\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-15 atom-15 atom-16\" d=\"M 488.6,213.3 L 499.4,213.3\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-16 atom-16 atom-17\" d=\"M 501.7,210.2 L 504.8,204.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-16 atom-16 atom-17\" d=\"M 504.8,204.9 L 507.8,199.6\" style=\"fill:none;fill-rule:evenodd;stroke:#00CC00;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"atom-1\" d=\"M 576.8 263.6 Q 576.8 262.5, 577.3 261.9 Q 577.8 261.4, 578.8 261.4 Q 579.8 261.4, 580.3 261.9 Q 580.8 262.5, 580.8 263.6 Q 580.8 264.6, 580.3 265.2 Q 579.8 265.8, 578.8 265.8 Q 577.8 265.8, 577.3 265.2 Q 576.8 264.6, 576.8 263.6 M 578.8 265.3 Q 579.5 265.3, 579.8 264.9 Q 580.2 264.5, 580.2 263.6 Q 580.2 262.7, 579.8 262.3 Q 579.5 261.9, 578.8 261.9 Q 578.1 261.9, 577.8 262.3 Q 577.4 262.7, 577.4 263.6 Q 577.4 264.5, 577.8 264.9 Q 578.1 265.3, 578.8 265.3 \" fill=\"#FF0000\"/>\n<path class=\"atom-4\" d=\"M 547.0 234.7 L 548.4 237.0 Q 548.6 237.2, 548.8 237.6 Q 549.0 238.1, 549.1 238.1 L 549.1 234.7 L 549.6 234.7 L 549.6 239.1 L 549.0 239.1 L 547.5 236.5 Q 547.3 236.2, 547.1 235.9 Q 546.9 235.6, 546.9 235.4 L 546.9 239.1 L 546.3 239.1 L 546.3 234.7 L 547.0 234.7 \" fill=\"#0000FF\"/>\n<path class=\"atom-7\" d=\"M 576.8 210.2 Q 576.8 209.1, 577.3 208.6 Q 577.8 208.0, 578.8 208.0 Q 579.8 208.0, 580.3 208.6 Q 580.8 209.1, 580.8 210.2 Q 580.8 211.2, 580.3 211.9 Q 579.8 212.4, 578.8 212.4 Q 577.8 212.4, 577.3 211.9 Q 576.8 211.3, 576.8 210.2 M 578.8 212.0 Q 579.5 212.0, 579.8 211.5 Q 580.2 211.1, 580.2 210.2 Q 580.2 209.3, 579.8 208.9 Q 579.5 208.5, 578.8 208.5 Q 578.1 208.5, 577.8 208.9 Q 577.4 209.3, 577.4 210.2 Q 577.4 211.1, 577.8 211.5 Q 578.1 212.0, 578.8 212.0 \" fill=\"#FF0000\"/>\n<path class=\"atom-7\" d=\"M 581.3 208.0 L 581.9 208.0 L 581.9 209.9 L 584.2 209.9 L 584.2 208.0 L 584.8 208.0 L 584.8 212.4 L 584.2 212.4 L 584.2 210.4 L 581.9 210.4 L 581.9 212.4 L 581.3 212.4 L 581.3 208.0 \" fill=\"#FF0000\"/>\n<path class=\"atom-9\" d=\"M 522.9 250.2 Q 522.9 249.2, 523.4 248.6 Q 523.9 248.0, 524.9 248.0 Q 525.8 248.0, 526.3 248.6 Q 526.9 249.2, 526.9 250.2 Q 526.9 251.3, 526.3 251.9 Q 525.8 252.5, 524.9 252.5 Q 523.9 252.5, 523.4 251.9 Q 522.9 251.3, 522.9 250.2 M 524.9 252.0 Q 525.5 252.0, 525.9 251.6 Q 526.2 251.1, 526.2 250.2 Q 526.2 249.4, 525.9 248.9 Q 525.5 248.5, 524.9 248.5 Q 524.2 248.5, 523.8 248.9 Q 523.5 249.4, 523.5 250.2 Q 523.5 251.1, 523.8 251.6 Q 524.2 252.0, 524.9 252.0 \" fill=\"#FF0000\"/>\n<path class=\"atom-10\" d=\"M 523.9 221.3 L 525.3 223.7 Q 525.5 223.9, 525.7 224.3 Q 525.9 224.7, 525.9 224.7 L 525.9 221.3 L 526.5 221.3 L 526.5 225.7 L 525.9 225.7 L 524.4 223.2 Q 524.2 222.9, 524.0 222.5 Q 523.8 222.2, 523.8 222.1 L 523.8 225.7 L 523.2 225.7 L 523.2 221.3 L 523.9 221.3 \" fill=\"#0000FF\"/>\n<path class=\"atom-10\" d=\"M 527.0 221.3 L 527.6 221.3 L 527.6 223.2 L 529.9 223.2 L 529.9 221.3 L 530.5 221.3 L 530.5 225.7 L 529.9 225.7 L 529.9 223.7 L 527.6 223.7 L 527.6 225.7 L 527.0 225.7 L 527.0 221.3 \" fill=\"#0000FF\"/>\n<path class=\"atom-17\" d=\"M 507.8 197.0 Q 507.8 195.9, 508.3 195.3 Q 508.8 194.8, 509.8 194.8 Q 510.7 194.8, 511.1 195.4 L 510.7 195.7 Q 510.4 195.3, 509.8 195.3 Q 509.1 195.3, 508.7 195.7 Q 508.4 196.1, 508.4 197.0 Q 508.4 197.8, 508.8 198.3 Q 509.1 198.7, 509.8 198.7 Q 510.3 198.7, 510.9 198.4 L 511.0 198.9 Q 510.8 199.0, 510.5 199.1 Q 510.1 199.2, 509.7 199.2 Q 508.8 199.2, 508.3 198.6 Q 507.8 198.1, 507.8 197.0 \" fill=\"#00CC00\"/>\n<path class=\"atom-17\" d=\"M 511.7 194.5 L 512.2 194.5 L 512.2 199.2 L 511.7 199.2 L 511.7 194.5 \" fill=\"#00CC00\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 649.6,285.3 L 652.5,279.8\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 652.5,279.8 L 655.3,274.2\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 652.4,286.7 L 654.8,282.0\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 654.8,282.0 L 657.2,277.2\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 646.9,283.9 L 649.3,279.2\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 649.3,279.2 L 651.7,274.5\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-1 atom-1 atom-2\" d=\"M 655.3,274.2 L 662.3,260.4\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-2 atom-2 atom-3\" d=\"M 662.3,260.4 L 653.9,247.5\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-2 atom-2 atom-3\" d=\"M 663.6,256.8 L 657.8,247.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-23 atom-23 atom-2\" d=\"M 677.7,259.6 L 662.3,260.4\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-3 atom-3 atom-4\" d=\"M 653.9,247.5 L 660.9,233.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-4 atom-4 atom-5\" d=\"M 660.9,233.8 L 657.5,228.6\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-4 atom-4 atom-5\" d=\"M 657.5,228.6 L 654.2,223.4\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-20 atom-4 atom-21\" d=\"M 660.9,233.8 L 676.3,233.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-20 atom-4 atom-21\" d=\"M 663.4,236.7 L 674.1,236.2\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-5 atom-5 atom-6\" d=\"M 653.8,218.3 L 656.7,212.7\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-5 atom-5 atom-6\" d=\"M 656.7,212.7 L 659.5,207.1\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-6 atom-6 atom-7\" d=\"M 660.8,206.3 L 657.5,201.1\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-6 atom-6 atom-7\" d=\"M 657.5,201.1 L 654.1,196.0\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-6 atom-6 atom-7\" d=\"M 658.2,208.0 L 654.9,202.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-6 atom-6 atom-7\" d=\"M 654.9,202.8 L 651.5,197.7\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-7 atom-6 atom-8\" d=\"M 659.5,207.1 L 666.2,206.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-7 atom-6 atom-8\" d=\"M 666.2,206.8 L 672.8,206.4\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-8 atom-8 atom-9\" d=\"M 676.6,208.9 L 679.9,214.1\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-8 atom-8 atom-9\" d=\"M 679.9,214.1 L 683.3,219.2\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-24 atom-20 atom-8\" d=\"M 681.9,192.6 L 679.0,198.2\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-24 atom-20 atom-8\" d=\"M 679.0,198.2 L 676.2,203.7\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-9 atom-9 atom-10\" d=\"M 683.3,219.2 L 698.7,218.4\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-10 atom-10 atom-11\" d=\"M 698.7,218.4 L 705.7,204.7\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-11 atom-11 atom-12\" d=\"M 705.7,204.7 L 721.1,203.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-18 atom-11 atom-19\" d=\"M 705.7,204.7 L 697.3,191.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-12 atom-12 atom-13\" d=\"M 721.1,203.9 L 724.4,209.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-12 atom-12 atom-13\" d=\"M 724.4,209.0 L 727.8,214.2\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-13 atom-13 atom-14\" d=\"M 728.2,219.4 L 725.3,224.9\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-13 atom-13 atom-14\" d=\"M 725.3,224.9 L 722.5,230.5\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-25 atom-18 atom-13\" d=\"M 744.9,216.0 L 738.2,216.3\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-25 atom-18 atom-13\" d=\"M 738.2,216.3 L 731.5,216.7\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-14 atom-14 atom-15\" d=\"M 722.5,230.5 L 730.9,243.4\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-15 atom-15 atom-16\" d=\"M 730.9,243.4 L 737.4,243.1\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-15 atom-15 atom-16\" d=\"M 737.4,243.1 L 743.9,242.8\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-16 atom-16 atom-17\" d=\"M 747.6,240.0 L 750.4,234.5\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-16 atom-16 atom-17\" d=\"M 750.4,234.5 L 753.3,228.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-17 atom-17 atom-18\" d=\"M 753.3,228.9 L 744.9,216.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-19 atom-19 atom-20\" d=\"M 697.3,191.8 L 681.9,192.6\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-21 atom-21 atom-22\" d=\"M 676.3,233.0 L 684.7,245.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-22 atom-22 atom-23\" d=\"M 684.7,245.9 L 677.7,259.6\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-22 atom-22 atom-23\" d=\"M 680.9,246.6 L 676.0,256.2\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"atom-0\" d=\"M 647.4 285.7 L 648.8 288.0 Q 648.9 288.3, 649.2 288.7 Q 649.4 289.1, 649.4 289.1 L 649.4 285.7 L 650.0 285.7 L 650.0 290.1 L 649.4 290.1 L 647.8 287.6 Q 647.7 287.3, 647.5 286.9 Q 647.3 286.6, 647.2 286.5 L 647.2 290.1 L 646.7 290.1 L 646.7 285.7 L 647.4 285.7 \" fill=\"#0000FF\"/>\n<path class=\"atom-5\" d=\"M 646.9 218.7 L 647.5 218.7 L 647.5 220.5 L 649.7 220.5 L 649.7 218.7 L 650.3 218.7 L 650.3 223.0 L 649.7 223.0 L 649.7 221.0 L 647.5 221.0 L 647.5 223.0 L 646.9 223.0 L 646.9 218.7 \" fill=\"#0000FF\"/>\n<path class=\"atom-5\" d=\"M 651.5 218.7 L 653.0 221.0 Q 653.1 221.2, 653.3 221.6 Q 653.6 222.0, 653.6 222.1 L 653.6 218.7 L 654.2 218.7 L 654.2 223.0 L 653.6 223.0 L 652.0 220.5 Q 651.8 220.2, 651.7 219.9 Q 651.5 219.5, 651.4 219.4 L 651.4 223.0 L 650.8 223.0 L 650.8 218.7 L 651.5 218.7 \" fill=\"#0000FF\"/>\n<path class=\"atom-7\" d=\"M 649.1 194.2 Q 649.1 193.2, 649.6 192.6 Q 650.1 192.0, 651.1 192.0 Q 652.1 192.0, 652.6 192.6 Q 653.1 193.2, 653.1 194.2 Q 653.1 195.3, 652.6 195.9 Q 652.0 196.5, 651.1 196.5 Q 650.1 196.5, 649.6 195.9 Q 649.1 195.3, 649.1 194.2 M 651.1 196.0 Q 651.8 196.0, 652.1 195.5 Q 652.5 195.1, 652.5 194.2 Q 652.5 193.4, 652.1 192.9 Q 651.8 192.5, 651.1 192.5 Q 650.4 192.5, 650.1 192.9 Q 649.7 193.3, 649.7 194.2 Q 649.7 195.1, 650.1 195.5 Q 650.4 196.0, 651.1 196.0 \" fill=\"#FF0000\"/>\n<path class=\"atom-8\" d=\"M 673.9 204.1 L 675.4 206.4 Q 675.5 206.7, 675.7 207.1 Q 675.9 207.5, 676.0 207.5 L 676.0 204.1 L 676.5 204.1 L 676.5 208.5 L 675.9 208.5 L 674.4 206.0 Q 674.2 205.7, 674.0 205.3 Q 673.9 205.0, 673.8 204.9 L 673.8 208.5 L 673.2 208.5 L 673.2 204.1 L 673.9 204.1 \" fill=\"#0000FF\"/>\n<path class=\"atom-13\" d=\"M 728.5 214.6 L 729.9 216.9 Q 730.1 217.1, 730.3 217.6 Q 730.5 218.0, 730.5 218.0 L 730.5 214.6 L 731.1 214.6 L 731.1 219.0 L 730.5 219.0 L 729.0 216.4 Q 728.8 216.1, 728.6 215.8 Q 728.4 215.5, 728.4 215.4 L 728.4 219.0 L 727.8 219.0 L 727.8 214.6 L 728.5 214.6 \" fill=\"#0000FF\"/>\n<path class=\"atom-16\" d=\"M 744.3 242.6 Q 744.3 241.6, 744.8 241.0 Q 745.3 240.4, 746.3 240.4 Q 747.2 240.4, 747.7 241.0 Q 748.3 241.6, 748.3 242.6 Q 748.3 243.7, 747.7 244.3 Q 747.2 244.9, 746.3 244.9 Q 745.3 244.9, 744.8 244.3 Q 744.3 243.7, 744.3 242.6 M 746.3 244.4 Q 746.9 244.4, 747.3 244.0 Q 747.6 243.5, 747.6 242.6 Q 747.6 241.8, 747.3 241.4 Q 746.9 240.9, 746.3 240.9 Q 745.6 240.9, 745.2 241.4 Q 744.9 241.8, 744.9 242.6 Q 744.9 243.5, 745.2 244.0 Q 745.6 244.4, 746.3 244.4 \" fill=\"#FF0000\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 63.9,309.9 L 66.3,315.7\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 66.3,315.7 L 68.8,321.5\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-1 atom-1 atom-2\" d=\"M 72.0,324.3 L 78.6,325.1\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-1 atom-1 atom-2\" d=\"M 78.6,325.1 L 85.2,325.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-2 atom-1 atom-3\" d=\"M 68.0,326.6 L 64.3,331.5\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-2 atom-1 atom-3\" d=\"M 64.3,331.5 L 60.7,336.4\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-3 atom-3 atom-4\" d=\"M 60.7,336.4 L 66.8,350.6\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-4 atom-4 atom-5\" d=\"M 66.8,350.6 L 82.1,352.4\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-20 atom-20 atom-4\" d=\"M 57.5,362.9 L 66.8,350.6\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-5 atom-5 atom-6\" d=\"M 82.1,352.4 L 88.1,366.5\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-6 atom-6 atom-7\" d=\"M 88.1,366.5 L 84.5,371.4\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-6 atom-6 atom-7\" d=\"M 84.5,371.4 L 80.8,376.3\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-7 atom-7 atom-8\" d=\"M 80.0,381.5 L 82.5,387.3\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-7 atom-7 atom-8\" d=\"M 82.5,387.3 L 85.0,393.1\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-18 atom-7 atom-19\" d=\"M 76.9,378.6 L 70.2,377.9\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-18 atom-7 atom-19\" d=\"M 70.2,377.9 L 63.6,377.1\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-8 atom-8 atom-9\" d=\"M 83.7,392.1 L 80.1,397.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-8 atom-8 atom-9\" d=\"M 80.1,397.0 L 76.5,401.9\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-8 atom-8 atom-9\" d=\"M 86.2,394.0 L 82.6,398.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-8 atom-8 atom-9\" d=\"M 82.6,398.9 L 78.9,403.7\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-9 atom-8 atom-10\" d=\"M 85.0,393.1 L 91.6,393.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-9 atom-8 atom-10\" d=\"M 91.6,393.8 L 98.2,394.6\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-10 atom-10 atom-11\" d=\"M 102.2,392.3 L 105.9,387.4\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-10 atom-10 atom-11\" d=\"M 105.9,387.4 L 109.5,382.5\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-11 atom-11 atom-12\" d=\"M 109.5,382.5 L 124.8,384.4\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-11 atom-11 atom-12\" d=\"M 112.2,379.8 L 122.9,381.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-21 atom-18 atom-11\" d=\"M 103.4,368.4 L 109.5,382.5\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-12 atom-12 atom-13\" d=\"M 124.8,384.4 L 134.1,372.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-13 atom-13 atom-14\" d=\"M 134.1,372.0 L 128.0,357.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-13 atom-13 atom-14\" d=\"M 130.3,371.1 L 126.1,361.2\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-14 atom-14 atom-15\" d=\"M 128.0,357.9 L 131.6,353.1\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-14 atom-14 atom-15\" d=\"M 131.6,353.1 L 135.1,348.3\" style=\"fill:none;fill-rule:evenodd;stroke:#00CC00;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-15 atom-14 atom-16\" d=\"M 128.0,357.9 L 112.7,356.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-16 atom-16 atom-17\" d=\"M 112.7,356.0 L 110.0,349.7\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-16 atom-16 atom-17\" d=\"M 110.0,349.7 L 107.3,343.4\" style=\"fill:none;fill-rule:evenodd;stroke:#00CC00;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-17 atom-16 atom-18\" d=\"M 112.7,356.0 L 103.4,368.4\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-17 atom-16 atom-18\" d=\"M 113.8,359.7 L 107.3,368.4\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-19 atom-19 atom-20\" d=\"M 63.6,377.1 L 57.5,362.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"atom-1\" d=\"M 69.0 321.9 L 70.4 324.2 Q 70.5 324.4, 70.8 324.8 Q 71.0 325.2, 71.0 325.3 L 71.0 321.9 L 71.6 321.9 L 71.6 326.2 L 71.0 326.2 L 69.4 323.7 Q 69.3 323.4, 69.1 323.1 Q 68.9 322.7, 68.8 322.6 L 68.8 326.2 L 68.3 326.2 L 68.3 321.9 L 69.0 321.9 \" fill=\"#0000FF\"/>\n<path class=\"atom-7\" d=\"M 77.9 376.7 L 79.4 379.0 Q 79.5 379.2, 79.7 379.7 Q 80.0 380.1, 80.0 380.1 L 80.0 376.7 L 80.6 376.7 L 80.6 381.1 L 80.0 381.1 L 78.4 378.5 Q 78.3 378.2, 78.1 377.9 Q 77.9 377.6, 77.8 377.5 L 77.8 381.1 L 77.3 381.1 L 77.3 376.7 L 77.9 376.7 \" fill=\"#0000FF\"/>\n<path class=\"atom-9\" d=\"M 73.7 405.4 Q 73.7 404.4, 74.3 403.8 Q 74.8 403.2, 75.7 403.2 Q 76.7 403.2, 77.2 403.8 Q 77.7 404.4, 77.7 405.4 Q 77.7 406.5, 77.2 407.1 Q 76.7 407.7, 75.7 407.7 Q 74.8 407.7, 74.3 407.1 Q 73.7 406.5, 73.7 405.4 M 75.7 407.2 Q 76.4 407.2, 76.8 406.7 Q 77.1 406.3, 77.1 405.4 Q 77.1 404.6, 76.8 404.1 Q 76.4 403.7, 75.7 403.7 Q 75.1 403.7, 74.7 404.1 Q 74.4 404.5, 74.4 405.4 Q 74.4 406.3, 74.7 406.7 Q 75.1 407.2, 75.7 407.2 \" fill=\"#FF0000\"/>\n<path class=\"atom-10\" d=\"M 99.3 392.7 L 100.7 395.0 Q 100.9 395.2, 101.1 395.7 Q 101.3 396.1, 101.4 396.1 L 101.4 392.7 L 101.9 392.7 L 101.9 397.1 L 101.3 397.1 L 99.8 394.5 Q 99.6 394.2, 99.4 393.9 Q 99.3 393.6, 99.2 393.5 L 99.2 397.1 L 98.6 397.1 L 98.6 392.7 L 99.3 392.7 \" fill=\"#0000FF\"/>\n<path class=\"atom-10\" d=\"M 102.5 392.7 L 103.1 392.7 L 103.1 394.6 L 105.3 394.6 L 105.3 392.7 L 105.9 392.7 L 105.9 397.1 L 105.3 397.1 L 105.3 395.0 L 103.1 395.0 L 103.1 397.1 L 102.5 397.1 L 102.5 392.7 \" fill=\"#0000FF\"/>\n<path class=\"atom-15\" d=\"M 135.5 345.7 Q 135.5 344.6, 136.0 344.0 Q 136.6 343.4, 137.5 343.4 Q 138.4 343.4, 138.9 344.1 L 138.5 344.4 Q 138.1 343.9, 137.5 343.9 Q 136.9 343.9, 136.5 344.4 Q 136.2 344.8, 136.2 345.7 Q 136.2 346.5, 136.5 347.0 Q 136.9 347.4, 137.6 347.4 Q 138.1 347.4, 138.6 347.1 L 138.8 347.6 Q 138.6 347.7, 138.2 347.8 Q 137.9 347.9, 137.5 347.9 Q 136.6 347.9, 136.0 347.3 Q 135.5 346.8, 135.5 345.7 \" fill=\"#00CC00\"/>\n<path class=\"atom-15\" d=\"M 139.4 343.2 L 140.0 343.2 L 140.0 347.9 L 139.4 347.9 L 139.4 343.2 \" fill=\"#00CC00\"/>\n<path class=\"atom-17\" d=\"M 102.4 342.0 Q 102.4 340.9, 102.9 340.4 Q 103.4 339.8, 104.4 339.8 Q 105.3 339.8, 105.8 340.4 L 105.4 340.8 Q 105.0 340.3, 104.4 340.3 Q 103.8 340.3, 103.4 340.7 Q 103.1 341.2, 103.1 342.0 Q 103.1 342.9, 103.4 343.3 Q 103.8 343.8, 104.5 343.8 Q 105.0 343.8, 105.5 343.5 L 105.7 343.9 Q 105.5 344.1, 105.1 344.2 Q 104.8 344.3, 104.4 344.3 Q 103.4 344.3, 102.9 343.7 Q 102.4 343.1, 102.4 342.0 \" fill=\"#00CC00\"/>\n<path class=\"atom-17\" d=\"M 106.3 339.5 L 106.9 339.5 L 106.9 344.2 L 106.3 344.2 L 106.3 339.5 \" fill=\"#00CC00\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 308.5,408.0 L 305.1,402.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 305.1,402.9 L 301.8,397.7\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-1 atom-1 atom-2\" d=\"M 297.7,395.2 L 291.2,395.5\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-1 atom-1 atom-2\" d=\"M 291.2,395.5 L 284.7,395.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-2 atom-2 atom-3\" d=\"M 284.7,395.9 L 277.7,409.6\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-2 atom-2 atom-3\" d=\"M 280.9,396.6 L 276.0,406.2\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-23 atom-23 atom-2\" d=\"M 276.3,383.0 L 284.7,395.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-3 atom-3 atom-4\" d=\"M 277.7,409.6 L 262.3,410.4\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-4 atom-4 atom-5\" d=\"M 262.3,410.4 L 253.9,397.5\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-4 atom-4 atom-5\" d=\"M 263.6,406.8 L 257.8,397.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-5 atom-5 atom-6\" d=\"M 253.9,397.5 L 260.9,383.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-6 atom-6 atom-7\" d=\"M 260.9,383.8 L 257.5,378.6\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-6 atom-6 atom-7\" d=\"M 257.5,378.6 L 254.2,373.4\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-22 atom-6 atom-23\" d=\"M 260.9,383.8 L 276.3,383.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-22 atom-6 atom-23\" d=\"M 263.4,386.7 L 274.1,386.2\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-7 atom-7 atom-8\" d=\"M 253.8,368.3 L 256.7,362.7\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-7 atom-7 atom-8\" d=\"M 256.7,362.7 L 259.5,357.1\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-8 atom-8 atom-9\" d=\"M 260.8,356.3 L 257.5,351.1\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-8 atom-8 atom-9\" d=\"M 257.5,351.1 L 254.1,346.0\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-8 atom-8 atom-9\" d=\"M 258.2,358.0 L 254.9,352.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-8 atom-8 atom-9\" d=\"M 254.9,352.8 L 251.5,347.7\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-9 atom-8 atom-10\" d=\"M 259.5,357.1 L 266.2,356.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-9 atom-8 atom-10\" d=\"M 266.2,356.8 L 272.8,356.4\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-10 atom-10 atom-11\" d=\"M 276.6,358.9 L 279.9,364.1\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-10 atom-10 atom-11\" d=\"M 279.9,364.1 L 283.3,369.2\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-24 atom-22 atom-10\" d=\"M 281.9,342.6 L 279.0,348.2\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-24 atom-22 atom-10\" d=\"M 279.0,348.2 L 276.2,353.7\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-11 atom-11 atom-12\" d=\"M 283.3,369.2 L 298.7,368.4\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-12 atom-12 atom-13\" d=\"M 298.7,368.4 L 305.7,354.7\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-13 atom-13 atom-14\" d=\"M 305.7,354.7 L 321.1,353.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-20 atom-13 atom-21\" d=\"M 305.7,354.7 L 297.3,341.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-14 atom-14 atom-15\" d=\"M 321.1,353.9 L 324.4,359.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-14 atom-14 atom-15\" d=\"M 324.4,359.0 L 327.8,364.2\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-15 atom-15 atom-16\" d=\"M 328.2,369.4 L 325.3,374.9\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-15 atom-15 atom-16\" d=\"M 325.3,374.9 L 322.5,380.5\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-25 atom-20 atom-15\" d=\"M 344.9,366.0 L 338.2,366.3\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-25 atom-20 atom-15\" d=\"M 338.2,366.3 L 331.5,366.7\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-16 atom-16 atom-17\" d=\"M 322.5,380.5 L 330.9,393.4\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-17 atom-17 atom-18\" d=\"M 330.9,393.4 L 337.4,393.1\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-17 atom-17 atom-18\" d=\"M 337.4,393.1 L 343.9,392.8\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-18 atom-18 atom-19\" d=\"M 347.6,390.0 L 350.4,384.5\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-18 atom-18 atom-19\" d=\"M 350.4,384.5 L 353.3,378.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-19 atom-19 atom-20\" d=\"M 353.3,378.9 L 344.9,366.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-21 atom-21 atom-22\" d=\"M 297.3,341.8 L 281.9,342.6\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"atom-1\" d=\"M 298.1 395.1 Q 298.1 394.0, 298.6 393.5 Q 299.1 392.9, 300.1 392.9 Q 301.1 392.9, 301.6 393.5 Q 302.1 394.0, 302.1 395.1 Q 302.1 396.1, 301.6 396.8 Q 301.0 397.4, 300.1 397.4 Q 299.1 397.4, 298.6 396.8 Q 298.1 396.2, 298.1 395.1 M 300.1 396.9 Q 300.8 396.9, 301.1 396.4 Q 301.5 396.0, 301.5 395.1 Q 301.5 394.2, 301.1 393.8 Q 300.8 393.4, 300.1 393.4 Q 299.4 393.4, 299.1 393.8 Q 298.7 394.2, 298.7 395.1 Q 298.7 396.0, 299.1 396.4 Q 299.4 396.9, 300.1 396.9 \" fill=\"#FF0000\"/>\n<path class=\"atom-7\" d=\"M 246.9 368.7 L 247.5 368.7 L 247.5 370.5 L 249.7 370.5 L 249.7 368.7 L 250.3 368.7 L 250.3 373.0 L 249.7 373.0 L 249.7 371.0 L 247.5 371.0 L 247.5 373.0 L 246.9 373.0 L 246.9 368.7 \" fill=\"#0000FF\"/>\n<path class=\"atom-7\" d=\"M 251.5 368.7 L 253.0 371.0 Q 253.1 371.2, 253.3 371.6 Q 253.6 372.0, 253.6 372.1 L 253.6 368.7 L 254.2 368.7 L 254.2 373.0 L 253.6 373.0 L 252.0 370.5 Q 251.8 370.2, 251.7 369.9 Q 251.5 369.5, 251.4 369.4 L 251.4 373.0 L 250.8 373.0 L 250.8 368.7 L 251.5 368.7 \" fill=\"#0000FF\"/>\n<path class=\"atom-9\" d=\"M 249.1 344.2 Q 249.1 343.2, 249.6 342.6 Q 250.1 342.0, 251.1 342.0 Q 252.1 342.0, 252.6 342.6 Q 253.1 343.2, 253.1 344.2 Q 253.1 345.3, 252.6 345.9 Q 252.0 346.5, 251.1 346.5 Q 250.1 346.5, 249.6 345.9 Q 249.1 345.3, 249.1 344.2 M 251.1 346.0 Q 251.8 346.0, 252.1 345.5 Q 252.5 345.1, 252.5 344.2 Q 252.5 343.4, 252.1 342.9 Q 251.8 342.5, 251.1 342.5 Q 250.4 342.5, 250.1 342.9 Q 249.7 343.3, 249.7 344.2 Q 249.7 345.1, 250.1 345.5 Q 250.4 346.0, 251.1 346.0 \" fill=\"#FF0000\"/>\n<path class=\"atom-10\" d=\"M 273.9 354.1 L 275.4 356.4 Q 275.5 356.7, 275.7 357.1 Q 275.9 357.5, 276.0 357.5 L 276.0 354.1 L 276.5 354.1 L 276.5 358.5 L 275.9 358.5 L 274.4 356.0 Q 274.2 355.7, 274.0 355.3 Q 273.9 355.0, 273.8 354.9 L 273.8 358.5 L 273.2 358.5 L 273.2 354.1 L 273.9 354.1 \" fill=\"#0000FF\"/>\n<path class=\"atom-15\" d=\"M 328.5 364.6 L 329.9 366.9 Q 330.1 367.1, 330.3 367.6 Q 330.5 368.0, 330.5 368.0 L 330.5 364.6 L 331.1 364.6 L 331.1 369.0 L 330.5 369.0 L 329.0 366.4 Q 328.8 366.1, 328.6 365.8 Q 328.4 365.5, 328.4 365.4 L 328.4 369.0 L 327.8 369.0 L 327.8 364.6 L 328.5 364.6 \" fill=\"#0000FF\"/>\n<path class=\"atom-18\" d=\"M 344.3 392.6 Q 344.3 391.6, 344.8 391.0 Q 345.3 390.4, 346.3 390.4 Q 347.2 390.4, 347.7 391.0 Q 348.3 391.6, 348.3 392.6 Q 348.3 393.7, 347.7 394.3 Q 347.2 394.9, 346.3 394.9 Q 345.3 394.9, 344.8 394.3 Q 344.3 393.7, 344.3 392.6 M 346.3 394.4 Q 346.9 394.4, 347.3 394.0 Q 347.6 393.5, 347.6 392.6 Q 347.6 391.8, 347.3 391.4 Q 346.9 390.9, 346.3 390.9 Q 345.6 390.9, 345.2 391.4 Q 344.9 391.8, 344.9 392.6 Q 344.9 393.5, 345.2 394.0 Q 345.6 394.4, 346.3 394.4 \" fill=\"#FF0000\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 486.1,422.5 L 477.7,409.6\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-1 atom-1 atom-2\" d=\"M 477.7,409.6 L 462.3,410.4\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-1 atom-1 atom-2\" d=\"M 475.2,406.7 L 464.5,407.2\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-23 atom-22 atom-1\" d=\"M 484.7,395.9 L 477.7,409.6\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-2 atom-2 atom-3\" d=\"M 462.3,410.4 L 453.9,397.5\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-3 atom-3 atom-4\" d=\"M 453.9,397.5 L 460.9,383.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-3 atom-3 atom-4\" d=\"M 457.7,396.9 L 462.6,387.2\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-4 atom-4 atom-5\" d=\"M 460.9,383.8 L 457.5,378.6\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-4 atom-4 atom-5\" d=\"M 457.5,378.6 L 454.2,373.4\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-20 atom-4 atom-21\" d=\"M 460.9,383.8 L 476.3,383.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-5 atom-5 atom-6\" d=\"M 453.8,368.3 L 456.7,362.7\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-5 atom-5 atom-6\" d=\"M 456.7,362.7 L 459.5,357.1\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-6 atom-6 atom-7\" d=\"M 460.8,356.3 L 457.5,351.1\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-6 atom-6 atom-7\" d=\"M 457.5,351.1 L 454.1,346.0\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-6 atom-6 atom-7\" d=\"M 458.2,358.0 L 454.9,352.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-6 atom-6 atom-7\" d=\"M 454.9,352.8 L 451.5,347.7\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-7 atom-6 atom-8\" d=\"M 459.5,357.1 L 466.2,356.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-7 atom-6 atom-8\" d=\"M 466.2,356.8 L 472.8,356.4\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-8 atom-8 atom-9\" d=\"M 476.6,358.9 L 479.9,364.1\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-8 atom-8 atom-9\" d=\"M 479.9,364.1 L 483.3,369.2\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-24 atom-20 atom-8\" d=\"M 481.9,342.6 L 479.0,348.2\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-24 atom-20 atom-8\" d=\"M 479.0,348.2 L 476.2,353.7\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-9 atom-9 atom-10\" d=\"M 483.3,369.2 L 498.7,368.4\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-10 atom-10 atom-11\" d=\"M 498.7,368.4 L 505.7,354.7\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-11 atom-11 atom-12\" d=\"M 505.7,354.7 L 521.1,353.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-18 atom-11 atom-19\" d=\"M 505.7,354.7 L 497.3,341.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-12 atom-12 atom-13\" d=\"M 521.1,353.9 L 524.4,359.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-12 atom-12 atom-13\" d=\"M 524.4,359.0 L 527.8,364.2\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-13 atom-13 atom-14\" d=\"M 528.2,369.4 L 525.3,374.9\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-13 atom-13 atom-14\" d=\"M 525.3,374.9 L 522.5,380.5\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-25 atom-18 atom-13\" d=\"M 544.9,366.0 L 538.2,366.3\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-25 atom-18 atom-13\" d=\"M 538.2,366.3 L 531.5,366.7\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-14 atom-14 atom-15\" d=\"M 522.5,380.5 L 530.9,393.4\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-15 atom-15 atom-16\" d=\"M 530.9,393.4 L 537.4,393.1\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-15 atom-15 atom-16\" d=\"M 537.4,393.1 L 543.9,392.8\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-16 atom-16 atom-17\" d=\"M 547.6,390.0 L 550.4,384.5\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-16 atom-16 atom-17\" d=\"M 550.4,384.5 L 553.3,378.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-17 atom-17 atom-18\" d=\"M 553.3,378.9 L 544.9,366.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-19 atom-19 atom-20\" d=\"M 497.3,341.8 L 481.9,342.6\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-21 atom-21 atom-22\" d=\"M 476.3,383.0 L 484.7,395.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-21 atom-21 atom-22\" d=\"M 475.0,386.6 L 480.8,395.6\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-22 atom-22 atom-23\" d=\"M 484.7,395.9 L 491.5,395.5\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-22 atom-22 atom-23\" d=\"M 491.5,395.5 L 498.4,395.2\" style=\"fill:none;fill-rule:evenodd;stroke:#33CCCC;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"atom-5\" d=\"M 446.9 368.7 L 447.5 368.7 L 447.5 370.5 L 449.7 370.5 L 449.7 368.7 L 450.3 368.7 L 450.3 373.0 L 449.7 373.0 L 449.7 371.0 L 447.5 371.0 L 447.5 373.0 L 446.9 373.0 L 446.9 368.7 \" fill=\"#0000FF\"/>\n<path class=\"atom-5\" d=\"M 451.5 368.7 L 453.0 371.0 Q 453.1 371.2, 453.3 371.6 Q 453.6 372.0, 453.6 372.1 L 453.6 368.7 L 454.2 368.7 L 454.2 373.0 L 453.6 373.0 L 452.0 370.5 Q 451.8 370.2, 451.7 369.9 Q 451.5 369.5, 451.4 369.4 L 451.4 373.0 L 450.8 373.0 L 450.8 368.7 L 451.5 368.7 \" fill=\"#0000FF\"/>\n<path class=\"atom-7\" d=\"M 449.1 344.2 Q 449.1 343.2, 449.6 342.6 Q 450.1 342.0, 451.1 342.0 Q 452.1 342.0, 452.6 342.6 Q 453.1 343.2, 453.1 344.2 Q 453.1 345.3, 452.6 345.9 Q 452.0 346.5, 451.1 346.5 Q 450.1 346.5, 449.6 345.9 Q 449.1 345.3, 449.1 344.2 M 451.1 346.0 Q 451.8 346.0, 452.1 345.5 Q 452.5 345.1, 452.5 344.2 Q 452.5 343.4, 452.1 342.9 Q 451.8 342.5, 451.1 342.5 Q 450.4 342.5, 450.1 342.9 Q 449.7 343.3, 449.7 344.2 Q 449.7 345.1, 450.1 345.5 Q 450.4 346.0, 451.1 346.0 \" fill=\"#FF0000\"/>\n<path class=\"atom-8\" d=\"M 473.9 354.1 L 475.4 356.4 Q 475.5 356.7, 475.7 357.1 Q 475.9 357.5, 476.0 357.5 L 476.0 354.1 L 476.5 354.1 L 476.5 358.5 L 475.9 358.5 L 474.4 356.0 Q 474.2 355.7, 474.0 355.3 Q 473.9 355.0, 473.8 354.9 L 473.8 358.5 L 473.2 358.5 L 473.2 354.1 L 473.9 354.1 \" fill=\"#0000FF\"/>\n<path class=\"atom-13\" d=\"M 528.5 364.6 L 529.9 366.9 Q 530.1 367.1, 530.3 367.6 Q 530.5 368.0, 530.5 368.0 L 530.5 364.6 L 531.1 364.6 L 531.1 369.0 L 530.5 369.0 L 529.0 366.4 Q 528.8 366.1, 528.6 365.8 Q 528.4 365.5, 528.4 365.4 L 528.4 369.0 L 527.8 369.0 L 527.8 364.6 L 528.5 364.6 \" fill=\"#0000FF\"/>\n<path class=\"atom-16\" d=\"M 544.3 392.6 Q 544.3 391.6, 544.8 391.0 Q 545.3 390.4, 546.3 390.4 Q 547.2 390.4, 547.7 391.0 Q 548.3 391.6, 548.3 392.6 Q 548.3 393.7, 547.7 394.3 Q 547.2 394.9, 546.3 394.9 Q 545.3 394.9, 544.8 394.3 Q 544.3 393.7, 544.3 392.6 M 546.3 394.4 Q 546.9 394.4, 547.3 394.0 Q 547.6 393.5, 547.6 392.6 Q 547.6 391.8, 547.3 391.4 Q 546.9 390.9, 546.3 390.9 Q 545.6 390.9, 545.2 391.4 Q 544.9 391.8, 544.9 392.6 Q 544.9 393.5, 545.2 394.0 Q 545.6 394.4, 546.3 394.4 \" fill=\"#FF0000\"/>\n<path class=\"atom-23\" d=\"M 498.8 392.9 L 501.4 392.9 L 501.4 393.4 L 499.4 393.4 L 499.4 394.7 L 501.2 394.7 L 501.2 395.2 L 499.4 395.2 L 499.4 397.3 L 498.8 397.3 L 498.8 392.9 \" fill=\"#33CCCC\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 737.2,345.5 L 728.0,357.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-1 atom-1 atom-2\" d=\"M 728.0,357.9 L 734.1,372.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-1 atom-1 atom-2\" d=\"M 726.1,361.2 L 730.3,371.1\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-20 atom-20 atom-1\" d=\"M 712.7,356.0 L 728.0,357.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-2 atom-2 atom-3\" d=\"M 734.1,372.0 L 724.8,384.4\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-3 atom-3 atom-4\" d=\"M 724.8,384.4 L 709.5,382.5\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-3 atom-3 atom-4\" d=\"M 722.9,381.0 L 712.2,379.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-4 atom-4 atom-5\" d=\"M 709.5,382.5 L 705.9,387.4\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-4 atom-4 atom-5\" d=\"M 705.9,387.4 L 702.2,392.3\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-18 atom-4 atom-19\" d=\"M 709.5,382.5 L 703.4,368.4\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-5 atom-5 atom-6\" d=\"M 698.2,394.6 L 691.6,393.8\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-5 atom-5 atom-6\" d=\"M 691.6,393.8 L 685.0,393.1\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-6 atom-6 atom-7\" d=\"M 683.7,392.1 L 680.1,397.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-6 atom-6 atom-7\" d=\"M 680.1,397.0 L 676.5,401.9\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-6 atom-6 atom-7\" d=\"M 686.2,394.0 L 682.6,398.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-6 atom-6 atom-7\" d=\"M 682.6,398.9 L 678.9,403.7\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-7 atom-6 atom-8\" d=\"M 685.0,393.1 L 682.5,387.3\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-7 atom-6 atom-8\" d=\"M 682.5,387.3 L 680.0,381.5\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-8 atom-8 atom-9\" d=\"M 680.8,376.3 L 684.5,371.4\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-8 atom-8 atom-9\" d=\"M 684.5,371.4 L 688.1,366.5\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-21 atom-18 atom-8\" d=\"M 663.6,377.1 L 670.2,377.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-21 atom-18 atom-8\" d=\"M 670.2,377.9 L 676.9,378.6\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-9 atom-9 atom-10\" d=\"M 688.1,366.5 L 682.1,352.4\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-10 atom-10 atom-11\" d=\"M 682.1,352.4 L 666.8,350.6\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-11 atom-11 atom-12\" d=\"M 666.8,350.6 L 660.7,336.4\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-16 atom-11 atom-17\" d=\"M 666.8,350.6 L 657.5,362.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-12 atom-12 atom-13\" d=\"M 660.9,334.9 L 654.4,334.1\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-12 atom-12 atom-13\" d=\"M 654.4,334.1 L 648.0,333.3\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-12 atom-12 atom-13\" d=\"M 660.5,337.9 L 654.1,337.1\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-12 atom-12 atom-13\" d=\"M 654.1,337.1 L 647.6,336.4\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-13 atom-12 atom-14\" d=\"M 660.7,336.4 L 664.3,331.5\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-13 atom-12 atom-14\" d=\"M 664.3,331.5 L 668.0,326.6\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-14 atom-14 atom-15\" d=\"M 668.8,321.5 L 666.3,315.7\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-14 atom-14 atom-15\" d=\"M 666.3,315.7 L 663.9,309.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-15 atom-14 atom-16\" d=\"M 672.0,324.3 L 678.6,325.1\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-15 atom-14 atom-16\" d=\"M 678.6,325.1 L 685.2,325.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-17 atom-17 atom-18\" d=\"M 657.5,362.9 L 663.6,377.1\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-19 atom-19 atom-20\" d=\"M 703.4,368.4 L 712.7,356.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-19 atom-19 atom-20\" d=\"M 707.3,368.4 L 713.8,359.7\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"atom-5\" d=\"M 699.3 392.7 L 700.7 395.0 Q 700.9 395.2, 701.1 395.7 Q 701.3 396.1, 701.4 396.1 L 701.4 392.7 L 701.9 392.7 L 701.9 397.1 L 701.3 397.1 L 699.8 394.5 Q 699.6 394.2, 699.4 393.9 Q 699.3 393.6, 699.2 393.5 L 699.2 397.1 L 698.6 397.1 L 698.6 392.7 L 699.3 392.7 \" fill=\"#0000FF\"/>\n<path class=\"atom-5\" d=\"M 702.5 392.7 L 703.1 392.7 L 703.1 394.6 L 705.3 394.6 L 705.3 392.7 L 705.9 392.7 L 705.9 397.1 L 705.3 397.1 L 705.3 395.0 L 703.1 395.0 L 703.1 397.1 L 702.5 397.1 L 702.5 392.7 \" fill=\"#0000FF\"/>\n<path class=\"atom-7\" d=\"M 673.7 405.4 Q 673.7 404.4, 674.3 403.8 Q 674.8 403.2, 675.7 403.2 Q 676.7 403.2, 677.2 403.8 Q 677.7 404.4, 677.7 405.4 Q 677.7 406.5, 677.2 407.1 Q 676.7 407.7, 675.7 407.7 Q 674.8 407.7, 674.3 407.1 Q 673.7 406.5, 673.7 405.4 M 675.7 407.2 Q 676.4 407.2, 676.8 406.7 Q 677.1 406.3, 677.1 405.4 Q 677.1 404.6, 676.8 404.1 Q 676.4 403.7, 675.7 403.7 Q 675.1 403.7, 674.7 404.1 Q 674.4 404.5, 674.4 405.4 Q 674.4 406.3, 674.7 406.7 Q 675.1 407.2, 675.7 407.2 \" fill=\"#FF0000\"/>\n<path class=\"atom-8\" d=\"M 677.9 376.7 L 679.4 379.0 Q 679.5 379.2, 679.7 379.7 Q 680.0 380.1, 680.0 380.1 L 680.0 376.7 L 680.6 376.7 L 680.6 381.1 L 680.0 381.1 L 678.4 378.5 Q 678.3 378.2, 678.1 377.9 Q 677.9 377.6, 677.8 377.5 L 677.8 381.1 L 677.3 381.1 L 677.3 376.7 L 677.9 376.7 \" fill=\"#0000FF\"/>\n<path class=\"atom-13\" d=\"M 643.4 334.6 Q 643.4 333.5, 643.9 332.9 Q 644.4 332.4, 645.4 332.4 Q 646.4 332.4, 646.9 332.9 Q 647.4 333.5, 647.4 334.6 Q 647.4 335.6, 646.9 336.2 Q 646.3 336.8, 645.4 336.8 Q 644.4 336.8, 643.9 336.2 Q 643.4 335.6, 643.4 334.6 M 645.4 336.3 Q 646.1 336.3, 646.4 335.9 Q 646.8 335.5, 646.8 334.6 Q 646.8 333.7, 646.4 333.3 Q 646.1 332.8, 645.4 332.8 Q 644.7 332.8, 644.4 333.3 Q 644.0 333.7, 644.0 334.6 Q 644.0 335.5, 644.4 335.9 Q 644.7 336.3, 645.4 336.3 \" fill=\"#FF0000\"/>\n<path class=\"atom-14\" d=\"M 669.0 321.9 L 670.4 324.2 Q 670.5 324.4, 670.8 324.8 Q 671.0 325.2, 671.0 325.3 L 671.0 321.9 L 671.6 321.9 L 671.6 326.2 L 671.0 326.2 L 669.4 323.7 Q 669.3 323.4, 669.1 323.1 Q 668.9 322.7, 668.8 322.6 L 668.8 326.2 L 668.3 326.2 L 668.3 321.9 L 669.0 321.9 \" fill=\"#0000FF\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 67.9,479.0 L 69.3,485.2\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 69.3,485.2 L 70.7,491.4\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 70.9,478.3 L 72.3,484.5\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 72.3,484.5 L 73.7,490.7\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-1 atom-1 atom-2\" d=\"M 72.2,491.0 L 67.5,495.3\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-1 atom-1 atom-2\" d=\"M 67.5,495.3 L 62.9,499.6\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-11 atom-1 atom-12\" d=\"M 72.2,491.0 L 78.5,493.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-11 atom-1 atom-12\" d=\"M 78.5,493.0 L 84.8,495.0\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-2 atom-2 atom-3\" d=\"M 61.4,504.1 L 62.8,510.3\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-2 atom-2 atom-3\" d=\"M 62.8,510.3 L 64.3,516.5\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-3 atom-3 atom-4\" d=\"M 64.3,516.5 L 79.0,521.1\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-3 atom-3 atom-4\" d=\"M 65.5,520.2 L 75.9,523.4\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-24 atom-11 atom-3\" d=\"M 52.9,527.0 L 64.3,516.5\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-4 atom-4 atom-5\" d=\"M 79.0,521.1 L 82.4,536.1\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-5 atom-5 atom-6\" d=\"M 82.4,536.1 L 71.1,546.6\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-5 atom-5 atom-6\" d=\"M 78.6,535.4 L 70.7,542.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-6 atom-6 atom-7\" d=\"M 71.1,546.6 L 71.2,553.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-6 atom-6 atom-7\" d=\"M 71.2,553.0 L 71.2,559.4\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-26 atom-10 atom-6\" d=\"M 56.3,542.0 L 71.1,546.6\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-7 atom-7 atom-8\" d=\"M 68.9,562.8 L 62.8,564.9\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-7 atom-7 atom-8\" d=\"M 62.8,564.9 L 56.7,567.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-8 atom-8 atom-9\" d=\"M 56.7,567.0 L 53.1,562.1\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-8 atom-8 atom-9\" d=\"M 53.1,562.1 L 49.4,557.3\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-9 atom-9 atom-10\" d=\"M 49.3,552.0 L 52.8,547.0\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-9 atom-9 atom-10\" d=\"M 52.8,547.0 L 56.3,542.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-10 atom-10 atom-11\" d=\"M 56.3,542.0 L 52.9,527.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-10 atom-10 atom-11\" d=\"M 58.8,539.1 L 56.5,528.6\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-12 atom-12 atom-13\" d=\"M 87.5,498.2 L 88.9,504.4\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-12 atom-12 atom-13\" d=\"M 88.9,504.4 L 90.3,510.6\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-25 atom-24 atom-12\" d=\"M 98.2,485.1 L 93.6,489.4\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-25 atom-24 atom-12\" d=\"M 93.6,489.4 L 88.9,493.7\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-13 atom-13 atom-14\" d=\"M 90.3,510.6 L 105.0,515.2\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-14 atom-14 atom-15\" d=\"M 105.0,515.2 L 116.3,504.7\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-15 atom-15 atom-16\" d=\"M 116.3,504.7 L 131.0,509.3\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-22 atom-15 atom-23\" d=\"M 116.3,504.7 L 112.9,489.7\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-16 atom-16 atom-17\" d=\"M 131.0,509.3 L 132.5,515.5\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-16 atom-16 atom-17\" d=\"M 132.5,515.5 L 133.9,521.8\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-17 atom-17 atom-18\" d=\"M 132.4,526.2 L 127.8,530.5\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-17 atom-17 atom-18\" d=\"M 127.8,530.5 L 123.1,534.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-27 atom-22 atom-17\" d=\"M 149.2,528.9 L 142.8,526.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-27 atom-22 atom-17\" d=\"M 142.8,526.9 L 136.5,525.0\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-18 atom-18 atom-19\" d=\"M 123.1,534.8 L 126.5,549.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-19 atom-19 atom-20\" d=\"M 126.5,549.8 L 132.7,551.7\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-19 atom-19 atom-20\" d=\"M 132.7,551.7 L 138.9,553.7\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-20 atom-20 atom-21\" d=\"M 143.7,552.2 L 148.1,548.1\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-20 atom-20 atom-21\" d=\"M 148.1,548.1 L 152.6,543.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-21 atom-21 atom-22\" d=\"M 152.6,543.9 L 149.2,528.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-23 atom-23 atom-24\" d=\"M 112.9,489.7 L 98.2,485.1\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"atom-0\" d=\"M 66.7 476.0 Q 66.7 475.0, 67.3 474.4 Q 67.8 473.8, 68.8 473.8 Q 69.7 473.8, 70.2 474.4 Q 70.8 475.0, 70.8 476.0 Q 70.8 477.1, 70.2 477.7 Q 69.7 478.3, 68.8 478.3 Q 67.8 478.3, 67.3 477.7 Q 66.7 477.1, 66.7 476.0 M 68.8 477.8 Q 69.4 477.8, 69.8 477.3 Q 70.1 476.9, 70.1 476.0 Q 70.1 475.2, 69.8 474.7 Q 69.4 474.3, 68.8 474.3 Q 68.1 474.3, 67.7 474.7 Q 67.4 475.2, 67.4 476.0 Q 67.4 476.9, 67.7 477.3 Q 68.1 477.8, 68.8 477.8 \" fill=\"#FF0000\"/>\n<path class=\"atom-2\" d=\"M 55.3 499.3 L 55.9 499.3 L 55.9 501.2 L 58.1 501.2 L 58.1 499.3 L 58.7 499.3 L 58.7 503.7 L 58.1 503.7 L 58.1 501.7 L 55.9 501.7 L 55.9 503.7 L 55.3 503.7 L 55.3 499.3 \" fill=\"#0000FF\"/>\n<path class=\"atom-2\" d=\"M 59.9 499.3 L 61.3 501.6 Q 61.5 501.9, 61.7 502.3 Q 61.9 502.7, 61.9 502.7 L 61.9 499.3 L 62.5 499.3 L 62.5 503.7 L 61.9 503.7 L 60.4 501.2 Q 60.2 500.9, 60.0 500.5 Q 59.8 500.2, 59.8 500.1 L 59.8 503.7 L 59.2 503.7 L 59.2 499.3 L 59.9 499.3 \" fill=\"#0000FF\"/>\n<path class=\"atom-7\" d=\"M 69.3 562.0 Q 69.3 561.0, 69.8 560.4 Q 70.3 559.8, 71.3 559.8 Q 72.2 559.8, 72.8 560.4 Q 73.3 561.0, 73.3 562.0 Q 73.3 563.1, 72.8 563.7 Q 72.2 564.3, 71.3 564.3 Q 70.3 564.3, 69.8 563.7 Q 69.3 563.1, 69.3 562.0 M 71.3 563.8 Q 71.9 563.8, 72.3 563.4 Q 72.7 562.9, 72.7 562.0 Q 72.7 561.2, 72.3 560.7 Q 71.9 560.3, 71.3 560.3 Q 70.6 560.3, 70.2 560.7 Q 69.9 561.2, 69.9 562.0 Q 69.9 562.9, 70.2 563.4 Q 70.6 563.8, 71.3 563.8 \" fill=\"#FF0000\"/>\n<path class=\"atom-9\" d=\"M 45.4 554.6 Q 45.4 553.6, 46.0 553.0 Q 46.5 552.4, 47.5 552.4 Q 48.4 552.4, 48.9 553.0 Q 49.5 553.6, 49.5 554.6 Q 49.5 555.7, 48.9 556.3 Q 48.4 556.9, 47.5 556.9 Q 46.5 556.9, 46.0 556.3 Q 45.4 555.7, 45.4 554.6 M 47.5 556.4 Q 48.1 556.4, 48.5 556.0 Q 48.8 555.5, 48.8 554.6 Q 48.8 553.8, 48.5 553.3 Q 48.1 552.9, 47.5 552.9 Q 46.8 552.9, 46.4 553.3 Q 46.1 553.8, 46.1 554.6 Q 46.1 555.5, 46.4 556.0 Q 46.8 556.4, 47.5 556.4 \" fill=\"#FF0000\"/>\n<path class=\"atom-12\" d=\"M 85.9 493.4 L 87.3 495.7 Q 87.5 496.0, 87.7 496.4 Q 87.9 496.8, 88.0 496.8 L 88.0 493.4 L 88.5 493.4 L 88.5 497.8 L 87.9 497.8 L 86.4 495.3 Q 86.2 495.0, 86.0 494.6 Q 85.8 494.3, 85.8 494.2 L 85.8 497.8 L 85.2 497.8 L 85.2 493.4 L 85.9 493.4 \" fill=\"#0000FF\"/>\n<path class=\"atom-17\" d=\"M 133.5 522.1 L 134.9 524.5 Q 135.1 524.7, 135.3 525.1 Q 135.5 525.5, 135.5 525.5 L 135.5 522.1 L 136.1 522.1 L 136.1 526.5 L 135.5 526.5 L 134.0 524.0 Q 133.8 523.7, 133.6 523.4 Q 133.4 523.0, 133.4 522.9 L 133.4 526.5 L 132.8 526.5 L 132.8 522.1 L 133.5 522.1 \" fill=\"#0000FF\"/>\n<path class=\"atom-20\" d=\"M 139.3 554.4 Q 139.3 553.4, 139.8 552.8 Q 140.3 552.2, 141.3 552.2 Q 142.2 552.2, 142.7 552.8 Q 143.3 553.4, 143.3 554.4 Q 143.3 555.5, 142.7 556.1 Q 142.2 556.7, 141.3 556.7 Q 140.3 556.7, 139.8 556.1 Q 139.3 555.5, 139.3 554.4 M 141.3 556.2 Q 141.9 556.2, 142.3 555.7 Q 142.7 555.3, 142.7 554.4 Q 142.7 553.6, 142.3 553.1 Q 141.9 552.7, 141.3 552.7 Q 140.6 552.7, 140.2 553.1 Q 139.9 553.5, 139.9 554.4 Q 139.9 555.3, 140.2 555.7 Q 140.6 556.2, 141.3 556.2 \" fill=\"#FF0000\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 220.9,495.1 L 236.2,496.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-1 atom-1 atom-2\" d=\"M 236.2,496.9 L 238.6,502.7\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-1 atom-1 atom-2\" d=\"M 238.6,502.7 L 241.1,508.5\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-2 atom-2 atom-3\" d=\"M 244.6,511.4 L 251.1,512.1\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-2 atom-2 atom-3\" d=\"M 251.1,512.1 L 257.5,512.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-3 atom-3 atom-4\" d=\"M 257.5,512.9 L 266.8,500.6\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-20 atom-20 atom-3\" d=\"M 263.6,527.1 L 257.5,512.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-4 atom-4 atom-5\" d=\"M 266.8,500.6 L 282.1,502.4\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-5 atom-5 atom-6\" d=\"M 282.1,502.4 L 288.1,516.5\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-6 atom-6 atom-7\" d=\"M 288.1,516.5 L 284.5,521.4\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-6 atom-6 atom-7\" d=\"M 284.5,521.4 L 280.8,526.3\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-7 atom-7 atom-8\" d=\"M 280.0,531.5 L 282.5,537.3\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-7 atom-7 atom-8\" d=\"M 282.5,537.3 L 285.0,543.1\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-19 atom-7 atom-20\" d=\"M 276.9,528.6 L 270.2,527.9\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-19 atom-7 atom-20\" d=\"M 270.2,527.9 L 263.6,527.1\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-8 atom-8 atom-9\" d=\"M 283.7,542.1 L 280.1,547.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-8 atom-8 atom-9\" d=\"M 280.1,547.0 L 276.5,551.9\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-8 atom-8 atom-9\" d=\"M 286.2,544.0 L 282.6,548.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-8 atom-8 atom-9\" d=\"M 282.6,548.9 L 278.9,553.7\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-9 atom-8 atom-10\" d=\"M 285.0,543.1 L 291.6,543.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-9 atom-8 atom-10\" d=\"M 291.6,543.8 L 298.2,544.6\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-10 atom-10 atom-11\" d=\"M 302.2,542.3 L 305.9,537.4\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-10 atom-10 atom-11\" d=\"M 305.9,537.4 L 309.5,532.5\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-11 atom-11 atom-12\" d=\"M 309.5,532.5 L 324.8,534.4\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-11 atom-11 atom-12\" d=\"M 312.2,529.8 L 322.9,531.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-21 atom-18 atom-11\" d=\"M 303.4,518.4 L 309.5,532.5\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-12 atom-12 atom-13\" d=\"M 324.8,534.4 L 330.9,548.5\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-13 atom-12 atom-14\" d=\"M 324.8,534.4 L 334.1,522.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-14 atom-14 atom-15\" d=\"M 334.1,522.0 L 328.0,507.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-14 atom-14 atom-15\" d=\"M 330.3,521.1 L 326.1,511.2\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-15 atom-15 atom-16\" d=\"M 328.0,507.9 L 337.2,495.5\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-16 atom-15 atom-17\" d=\"M 328.0,507.9 L 312.7,506.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-17 atom-17 atom-18\" d=\"M 312.7,506.0 L 303.4,518.4\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-17 atom-17 atom-18\" d=\"M 313.8,509.7 L 307.3,518.4\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-18 atom-18 atom-19\" d=\"M 303.4,518.4 L 299.9,517.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-18 atom-18 atom-19\" d=\"M 299.9,517.0 L 296.3,515.6\" style=\"fill:none;fill-rule:evenodd;stroke:#00CC00;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"atom-2\" d=\"M 240.2 511.1 Q 240.2 510.0, 240.7 509.4 Q 241.3 508.9, 242.2 508.9 Q 243.2 508.9, 243.7 509.4 Q 244.2 510.0, 244.2 511.1 Q 244.2 512.1, 243.7 512.7 Q 243.2 513.3, 242.2 513.3 Q 241.3 513.3, 240.7 512.7 Q 240.2 512.1, 240.2 511.1 M 242.2 512.9 Q 242.9 512.9, 243.3 512.4 Q 243.6 512.0, 243.6 511.1 Q 243.6 510.2, 243.3 509.8 Q 242.9 509.4, 242.2 509.4 Q 241.6 509.4, 241.2 509.8 Q 240.8 510.2, 240.8 511.1 Q 240.8 512.0, 241.2 512.4 Q 241.6 512.9, 242.2 512.9 \" fill=\"#FF0000\"/>\n<path class=\"atom-7\" d=\"M 277.9 526.7 L 279.4 529.0 Q 279.5 529.2, 279.7 529.7 Q 280.0 530.1, 280.0 530.1 L 280.0 526.7 L 280.6 526.7 L 280.6 531.1 L 280.0 531.1 L 278.4 528.5 Q 278.3 528.2, 278.1 527.9 Q 277.9 527.6, 277.8 527.5 L 277.8 531.1 L 277.3 531.1 L 277.3 526.7 L 277.9 526.7 \" fill=\"#0000FF\"/>\n<path class=\"atom-9\" d=\"M 273.7 555.4 Q 273.7 554.4, 274.3 553.8 Q 274.8 553.2, 275.7 553.2 Q 276.7 553.2, 277.2 553.8 Q 277.7 554.4, 277.7 555.4 Q 277.7 556.5, 277.2 557.1 Q 276.7 557.7, 275.7 557.7 Q 274.8 557.7, 274.3 557.1 Q 273.7 556.5, 273.7 555.4 M 275.7 557.2 Q 276.4 557.2, 276.8 556.7 Q 277.1 556.3, 277.1 555.4 Q 277.1 554.6, 276.8 554.1 Q 276.4 553.7, 275.7 553.7 Q 275.1 553.7, 274.7 554.1 Q 274.4 554.5, 274.4 555.4 Q 274.4 556.3, 274.7 556.7 Q 275.1 557.2, 275.7 557.2 \" fill=\"#FF0000\"/>\n<path class=\"atom-10\" d=\"M 299.3 542.7 L 300.7 545.0 Q 300.9 545.2, 301.1 545.7 Q 301.3 546.1, 301.4 546.1 L 301.4 542.7 L 301.9 542.7 L 301.9 547.1 L 301.3 547.1 L 299.8 544.5 Q 299.6 544.2, 299.4 543.9 Q 299.3 543.6, 299.2 543.5 L 299.2 547.1 L 298.6 547.1 L 298.6 542.7 L 299.3 542.7 \" fill=\"#0000FF\"/>\n<path class=\"atom-10\" d=\"M 302.5 542.7 L 303.1 542.7 L 303.1 544.6 L 305.3 544.6 L 305.3 542.7 L 305.9 542.7 L 305.9 547.1 L 305.3 547.1 L 305.3 545.0 L 303.1 545.0 L 303.1 547.1 L 302.5 547.1 L 302.5 542.7 \" fill=\"#0000FF\"/>\n<path class=\"atom-19\" d=\"M 291.6 515.6 Q 291.6 514.5, 292.1 514.0 Q 292.6 513.4, 293.6 513.4 Q 294.5 513.4, 295.0 514.0 L 294.6 514.4 Q 294.2 513.9, 293.6 513.9 Q 292.9 513.9, 292.6 514.3 Q 292.2 514.8, 292.2 515.6 Q 292.2 516.5, 292.6 516.9 Q 293.0 517.4, 293.7 517.4 Q 294.1 517.4, 294.7 517.1 L 294.9 517.5 Q 294.6 517.7, 294.3 517.8 Q 294.0 517.9, 293.6 517.9 Q 292.6 517.9, 292.1 517.3 Q 291.6 516.7, 291.6 515.6 \" fill=\"#00CC00\"/>\n<path class=\"atom-19\" d=\"M 295.5 513.1 L 296.1 513.1 L 296.1 517.8 L 295.5 517.8 L 295.5 513.1 \" fill=\"#00CC00\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 544.5,485.7 L 540.9,490.6\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 540.9,490.6 L 537.2,495.5\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 542.1,483.9 L 539.0,488.0\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 539.0,488.0 L 535.8,492.2\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 547.0,487.6 L 543.9,491.7\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 543.9,491.7 L 540.8,495.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-1 atom-1 atom-2\" d=\"M 537.2,495.5 L 528.0,507.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-2 atom-2 atom-3\" d=\"M 528.0,507.9 L 534.1,522.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-2 atom-2 atom-3\" d=\"M 526.1,511.2 L 530.3,521.1\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-21 atom-21 atom-2\" d=\"M 512.7,506.0 L 528.0,507.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-3 atom-3 atom-4\" d=\"M 534.1,522.0 L 524.8,534.4\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-4 atom-4 atom-5\" d=\"M 524.8,534.4 L 509.5,532.5\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-4 atom-4 atom-5\" d=\"M 522.9,531.0 L 512.2,529.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-5 atom-5 atom-6\" d=\"M 509.5,532.5 L 505.9,537.4\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-5 atom-5 atom-6\" d=\"M 505.9,537.4 L 502.2,542.3\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-19 atom-5 atom-20\" d=\"M 509.5,532.5 L 503.4,518.4\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-6 atom-6 atom-7\" d=\"M 498.2,544.6 L 491.6,543.8\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-6 atom-6 atom-7\" d=\"M 491.6,543.8 L 485.0,543.1\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-7 atom-7 atom-8\" d=\"M 483.7,542.1 L 480.1,547.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-7 atom-7 atom-8\" d=\"M 480.1,547.0 L 476.5,551.9\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-7 atom-7 atom-8\" d=\"M 486.2,544.0 L 482.6,548.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-7 atom-7 atom-8\" d=\"M 482.6,548.9 L 478.9,553.7\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-8 atom-7 atom-9\" d=\"M 485.0,543.1 L 482.5,537.3\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-8 atom-7 atom-9\" d=\"M 482.5,537.3 L 480.0,531.5\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-9 atom-9 atom-10\" d=\"M 480.8,526.3 L 484.5,521.4\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-9 atom-9 atom-10\" d=\"M 484.5,521.4 L 488.1,516.5\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-22 atom-19 atom-9\" d=\"M 463.6,527.1 L 470.2,527.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-22 atom-19 atom-9\" d=\"M 470.2,527.9 L 476.9,528.6\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-10 atom-10 atom-11\" d=\"M 488.1,516.5 L 482.1,502.4\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-11 atom-11 atom-12\" d=\"M 482.1,502.4 L 466.8,500.6\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-12 atom-12 atom-13\" d=\"M 466.8,500.6 L 457.5,512.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-13 atom-13 atom-14\" d=\"M 457.5,512.9 L 442.2,511.1\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-18 atom-13 atom-19\" d=\"M 457.5,512.9 L 463.6,527.1\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-14 atom-14 atom-15\" d=\"M 442.2,511.1 L 439.7,505.3\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-14 atom-14 atom-15\" d=\"M 439.7,505.3 L 437.3,499.5\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-15 atom-15 atom-16\" d=\"M 434.1,496.7 L 427.5,495.9\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-15 atom-15 atom-16\" d=\"M 427.5,495.9 L 420.9,495.1\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-16 atom-16 atom-17\" d=\"M 420.9,495.1 L 418.4,489.3\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-16 atom-16 atom-17\" d=\"M 418.4,489.3 L 415.9,483.5\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-17 atom-16 atom-18\" d=\"M 419.6,494.2 L 416.0,499.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-17 atom-16 atom-18\" d=\"M 416.0,499.0 L 412.3,503.9\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-17 atom-16 atom-18\" d=\"M 422.1,496.0 L 418.4,500.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-17 atom-16 atom-18\" d=\"M 418.4,500.9 L 414.8,505.8\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-20 atom-20 atom-21\" d=\"M 503.4,518.4 L 512.7,506.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-20 atom-20 atom-21\" d=\"M 507.3,518.4 L 513.8,509.7\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"atom-0\" d=\"M 545.5 481.0 L 546.9 483.3 Q 547.1 483.5, 547.3 483.9 Q 547.5 484.4, 547.5 484.4 L 547.5 481.0 L 548.1 481.0 L 548.1 485.4 L 547.5 485.4 L 546.0 482.8 Q 545.8 482.5, 545.6 482.2 Q 545.4 481.9, 545.4 481.7 L 545.4 485.4 L 544.8 485.4 L 544.8 481.0 L 545.5 481.0 \" fill=\"#0000FF\"/>\n<path class=\"atom-6\" d=\"M 499.3 542.7 L 500.7 545.0 Q 500.9 545.2, 501.1 545.7 Q 501.3 546.1, 501.4 546.1 L 501.4 542.7 L 501.9 542.7 L 501.9 547.1 L 501.3 547.1 L 499.8 544.5 Q 499.6 544.2, 499.4 543.9 Q 499.3 543.6, 499.2 543.5 L 499.2 547.1 L 498.6 547.1 L 498.6 542.7 L 499.3 542.7 \" fill=\"#0000FF\"/>\n<path class=\"atom-6\" d=\"M 502.5 542.7 L 503.1 542.7 L 503.1 544.6 L 505.3 544.6 L 505.3 542.7 L 505.9 542.7 L 505.9 547.1 L 505.3 547.1 L 505.3 545.0 L 503.1 545.0 L 503.1 547.1 L 502.5 547.1 L 502.5 542.7 \" fill=\"#0000FF\"/>\n<path class=\"atom-8\" d=\"M 473.7 555.4 Q 473.7 554.4, 474.3 553.8 Q 474.8 553.2, 475.7 553.2 Q 476.7 553.2, 477.2 553.8 Q 477.7 554.4, 477.7 555.4 Q 477.7 556.5, 477.2 557.1 Q 476.7 557.7, 475.7 557.7 Q 474.8 557.7, 474.3 557.1 Q 473.7 556.5, 473.7 555.4 M 475.7 557.2 Q 476.4 557.2, 476.8 556.7 Q 477.1 556.3, 477.1 555.4 Q 477.1 554.6, 476.8 554.1 Q 476.4 553.7, 475.7 553.7 Q 475.1 553.7, 474.7 554.1 Q 474.4 554.5, 474.4 555.4 Q 474.4 556.3, 474.7 556.7 Q 475.1 557.2, 475.7 557.2 \" fill=\"#FF0000\"/>\n<path class=\"atom-9\" d=\"M 477.9 526.7 L 479.4 529.0 Q 479.5 529.2, 479.7 529.7 Q 480.0 530.1, 480.0 530.1 L 480.0 526.7 L 480.6 526.7 L 480.6 531.1 L 480.0 531.1 L 478.4 528.5 Q 478.3 528.2, 478.1 527.9 Q 477.9 527.6, 477.8 527.5 L 477.8 531.1 L 477.3 531.1 L 477.3 526.7 L 477.9 526.7 \" fill=\"#0000FF\"/>\n<path class=\"atom-15\" d=\"M 435.2 494.7 L 436.6 497.0 Q 436.8 497.3, 437.0 497.7 Q 437.2 498.1, 437.2 498.1 L 437.2 494.7 L 437.8 494.7 L 437.8 499.1 L 437.2 499.1 L 435.7 496.6 Q 435.5 496.3, 435.3 495.9 Q 435.1 495.6, 435.1 495.5 L 435.1 499.1 L 434.5 499.1 L 434.5 494.7 L 435.2 494.7 \" fill=\"#0000FF\"/>\n<path class=\"atom-15\" d=\"M 438.3 494.7 L 438.9 494.7 L 438.9 496.6 L 441.2 496.6 L 441.2 494.7 L 441.8 494.7 L 441.8 499.1 L 441.2 499.1 L 441.2 497.1 L 438.9 497.1 L 438.9 499.1 L 438.3 499.1 L 438.3 494.7 \" fill=\"#0000FF\"/>\n<path class=\"atom-17\" d=\"M 407.1 478.7 L 407.6 478.7 L 407.6 480.6 L 409.9 480.6 L 409.9 478.7 L 410.5 478.7 L 410.5 483.1 L 409.9 483.1 L 409.9 481.1 L 407.6 481.1 L 407.6 483.1 L 407.1 483.1 L 407.1 478.7 \" fill=\"#0000FF\"/>\n<path class=\"atom-17\" d=\"M 410.7 482.9 Q 410.8 482.7, 411.0 482.5 Q 411.3 482.4, 411.6 482.4 Q 412.1 482.4, 412.3 482.6 Q 412.6 482.8, 412.6 483.3 Q 412.6 483.7, 412.2 484.1 Q 411.9 484.5, 411.3 485.0 L 412.6 485.0 L 412.6 485.3 L 410.7 485.3 L 410.7 485.0 Q 411.2 484.6, 411.5 484.3 Q 411.8 484.1, 412.0 483.8 Q 412.2 483.5, 412.2 483.3 Q 412.2 483.0, 412.0 482.8 Q 411.9 482.7, 411.6 482.7 Q 411.4 482.7, 411.3 482.8 Q 411.1 482.9, 411.0 483.1 L 410.7 482.9 \" fill=\"#0000FF\"/>\n<path class=\"atom-17\" d=\"M 413.8 478.7 L 415.2 481.0 Q 415.4 481.3, 415.6 481.7 Q 415.8 482.1, 415.9 482.1 L 415.9 478.7 L 416.4 478.7 L 416.4 483.1 L 415.8 483.1 L 414.3 480.6 Q 414.1 480.3, 413.9 479.9 Q 413.7 479.6, 413.7 479.5 L 413.7 483.1 L 413.1 483.1 L 413.1 478.7 L 413.8 478.7 \" fill=\"#0000FF\"/>\n<path class=\"atom-18\" d=\"M 409.6 507.4 Q 409.6 506.4, 410.1 505.8 Q 410.7 505.2, 411.6 505.2 Q 412.6 505.2, 413.1 505.8 Q 413.6 506.4, 413.6 507.4 Q 413.6 508.5, 413.1 509.1 Q 412.6 509.7, 411.6 509.7 Q 410.7 509.7, 410.1 509.1 Q 409.6 508.5, 409.6 507.4 M 411.6 509.2 Q 412.3 509.2, 412.6 508.8 Q 413.0 508.3, 413.0 507.4 Q 413.0 506.6, 412.6 506.1 Q 412.3 505.7, 411.6 505.7 Q 411.0 505.7, 410.6 506.1 Q 410.2 506.6, 410.2 507.4 Q 410.2 508.3, 410.6 508.8 Q 411.0 509.2, 411.6 509.2 \" fill=\"#FF0000\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 666.3,477.9 L 653.7,486.7\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-1 atom-1 atom-2\" d=\"M 653.7,486.7 L 654.2,493.1\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-1 atom-1 atom-2\" d=\"M 654.2,493.1 L 654.7,499.5\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-2 atom-2 atom-3\" d=\"M 652.9,503.8 L 648.1,508.0\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-2 atom-2 atom-3\" d=\"M 648.1,508.0 L 643.2,512.1\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-18 atom-18 atom-2\" d=\"M 668.1,510.1 L 662.5,506.7\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-18 atom-18 atom-2\" d=\"M 662.5,506.7 L 657.0,503.3\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-3 atom-3 atom-4\" d=\"M 643.2,512.1 L 649.2,526.3\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-4 atom-4 atom-5\" d=\"M 649.2,526.3 L 664.5,525.1\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-5 atom-5 atom-6\" d=\"M 664.5,525.1 L 674.6,536.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-17 atom-5 atom-18\" d=\"M 664.5,525.1 L 668.1,510.1\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-6 atom-6 atom-7\" d=\"M 674.6,536.8 L 681.2,535.5\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-6 atom-6 atom-7\" d=\"M 681.2,535.5 L 687.7,534.3\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-7 atom-7 atom-8\" d=\"M 691.8,536.3 L 695.8,540.9\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-7 atom-7 atom-8\" d=\"M 695.8,540.9 L 699.8,545.6\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-8 atom-8 atom-9\" d=\"M 698.3,545.1 L 696.2,551.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-8 atom-8 atom-9\" d=\"M 696.2,551.0 L 694.2,557.0\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-8 atom-8 atom-9\" d=\"M 701.3,546.1 L 699.2,552.1\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-8 atom-8 atom-9\" d=\"M 699.2,552.1 L 697.1,558.0\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-9 atom-8 atom-10\" d=\"M 699.8,545.6 L 706.3,544.3\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-9 atom-8 atom-10\" d=\"M 706.3,544.3 L 712.9,543.1\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-10 atom-10 atom-11\" d=\"M 715.8,540.1 L 717.9,534.2\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-10 atom-10 atom-11\" d=\"M 717.9,534.2 L 720.0,528.2\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-11 atom-11 atom-12\" d=\"M 720.0,528.2 L 735.2,525.3\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-11 atom-11 atom-12\" d=\"M 721.7,524.7 L 732.3,522.7\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-19 atom-17 atom-11\" d=\"M 710.0,516.5 L 720.0,528.2\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-12 atom-12 atom-13\" d=\"M 735.2,525.3 L 740.3,510.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-13 atom-13 atom-14\" d=\"M 740.3,510.8 L 730.2,499.1\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-13 atom-13 atom-14\" d=\"M 736.4,511.0 L 729.4,502.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-14 atom-14 atom-15\" d=\"M 730.2,499.1 L 732.3,493.2\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-14 atom-14 atom-15\" d=\"M 732.3,493.2 L 734.3,487.3\" style=\"fill:none;fill-rule:evenodd;stroke:#00CC00;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-15 atom-14 atom-16\" d=\"M 730.2,499.1 L 715.1,501.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-16 atom-16 atom-17\" d=\"M 715.1,501.9 L 710.0,516.5\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-16 atom-16 atom-17\" d=\"M 717.2,505.1 L 713.7,515.3\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"atom-2\" d=\"M 654.0 499.9 L 655.4 502.2 Q 655.5 502.4, 655.8 502.8 Q 656.0 503.2, 656.0 503.3 L 656.0 499.9 L 656.6 499.9 L 656.6 504.2 L 656.0 504.2 L 654.4 501.7 Q 654.3 501.4, 654.1 501.1 Q 653.9 500.7, 653.8 500.6 L 653.8 504.2 L 653.3 504.2 L 653.3 499.9 L 654.0 499.9 \" fill=\"#0000FF\"/>\n<path class=\"atom-7\" d=\"M 688.8 531.7 L 690.2 534.0 Q 690.4 534.2, 690.6 534.7 Q 690.8 535.1, 690.8 535.1 L 690.8 531.7 L 691.4 531.7 L 691.4 536.1 L 690.8 536.1 L 689.3 533.5 Q 689.1 533.2, 688.9 532.9 Q 688.7 532.6, 688.7 532.5 L 688.7 536.1 L 688.1 536.1 L 688.1 531.7 L 688.8 531.7 \" fill=\"#0000FF\"/>\n<path class=\"atom-7\" d=\"M 688.0 526.9 L 688.6 526.9 L 688.6 528.8 L 690.9 528.8 L 690.9 526.9 L 691.5 526.9 L 691.5 531.3 L 690.9 531.3 L 690.9 529.3 L 688.6 529.3 L 688.6 531.3 L 688.0 531.3 L 688.0 526.9 \" fill=\"#0000FF\"/>\n<path class=\"atom-9\" d=\"M 692.7 560.1 Q 692.7 559.1, 693.2 558.5 Q 693.7 557.9, 694.7 557.9 Q 695.7 557.9, 696.2 558.5 Q 696.7 559.1, 696.7 560.1 Q 696.7 561.2, 696.2 561.8 Q 695.7 562.4, 694.7 562.4 Q 693.7 562.4, 693.2 561.8 Q 692.7 561.2, 692.7 560.1 M 694.7 561.9 Q 695.4 561.9, 695.7 561.5 Q 696.1 561.0, 696.1 560.1 Q 696.1 559.3, 695.7 558.8 Q 695.4 558.4, 694.7 558.4 Q 694.0 558.4, 693.7 558.8 Q 693.3 559.3, 693.3 560.1 Q 693.3 561.0, 693.7 561.5 Q 694.0 561.9, 694.7 561.9 \" fill=\"#FF0000\"/>\n<path class=\"atom-10\" d=\"M 714.0 540.5 L 715.4 542.8 Q 715.5 543.1, 715.8 543.5 Q 716.0 543.9, 716.0 543.9 L 716.0 540.5 L 716.6 540.5 L 716.6 544.9 L 716.0 544.9 L 714.5 542.4 Q 714.3 542.1, 714.1 541.7 Q 713.9 541.4, 713.9 541.3 L 713.9 544.9 L 713.3 544.9 L 713.3 540.5 L 714.0 540.5 \" fill=\"#0000FF\"/>\n<path class=\"atom-10\" d=\"M 717.1 540.5 L 717.7 540.5 L 717.7 542.4 L 719.9 542.4 L 719.9 540.5 L 720.5 540.5 L 720.5 544.9 L 719.9 544.9 L 719.9 542.9 L 717.7 542.9 L 717.7 544.9 L 717.1 544.9 L 717.1 540.5 \" fill=\"#0000FF\"/>\n<path class=\"atom-15\" d=\"M 733.6 484.7 Q 733.6 483.6, 734.1 483.0 Q 734.7 482.4, 735.6 482.4 Q 736.5 482.4, 737.0 483.1 L 736.6 483.4 Q 736.2 483.0, 735.6 483.0 Q 735.0 483.0, 734.6 483.4 Q 734.3 483.8, 734.3 484.7 Q 734.3 485.5, 734.6 486.0 Q 735.0 486.4, 735.7 486.4 Q 736.2 486.4, 736.7 486.1 L 736.9 486.6 Q 736.7 486.7, 736.3 486.8 Q 736.0 486.9, 735.6 486.9 Q 734.7 486.9, 734.1 486.3 Q 733.6 485.8, 733.6 484.7 \" fill=\"#00CC00\"/>\n<path class=\"atom-15\" d=\"M 737.5 482.2 L 738.1 482.2 L 738.1 486.9 L 737.5 486.9 L 737.5 482.2 \" fill=\"#00CC00\"/>\n</svg>",
"text/plain": [
"<IPython.core.display.SVG object>"
]
},
"metadata": {},
"output_type": "display_data"
}
],
"source": [
"# Test with anonymous graph generation\n",
"# with the anonymous scaffold, bond order are discarded, meaning that we expected confusion between \n",
"# aromatic and aliphatic rings sometimes, but it does not seem to happen\n",
"aligned_mols, mol_groups = partition_and_align_mols(molecules_with_confs, partition='anongraph-scaffold')\n",
"display(dm.to_image(aligned_mols[:16], mol_size=(200, 150)))"
]
},
{
"cell_type": "code",
"execution_count": 13,
"metadata": {},
"outputs": [
{
"data": {
"image/svg+xml": "<svg baseProfile=\"full\" height=\"600px\" version=\"1.1\" viewBox=\"0 0 800 600\" width=\"800px\" xml:space=\"preserve\" xmlns=\"http://www.w3.org/2000/svg\" xmlns:rdkit=\"http://www.rdkit.org/xml\" xmlns:xlink=\"http://www.w3.org/1999/xlink\">\n<!-- END OF HEADER -->\n<rect height=\"600.0\" style=\"opacity:1.0;fill:#FFFFFF;stroke:none\" width=\"800.0\" x=\"0.0\" y=\"0.0\"> </rect>\n<rect height=\"600.0\" style=\"opacity:1.0;fill:#FFFFFF;stroke:none\" width=\"800.0\" x=\"0.0\" y=\"0.0\"> </rect>\n<rect height=\"600.0\" style=\"opacity:1.0;fill:#FFFFFF;stroke:none\" width=\"800.0\" x=\"0.0\" y=\"0.0\"> </rect>\n<rect height=\"600.0\" style=\"opacity:1.0;fill:#FFFFFF;stroke:none\" width=\"800.0\" x=\"0.0\" y=\"0.0\"> </rect>\n<rect height=\"600.0\" style=\"opacity:1.0;fill:#FFFFFF;stroke:none\" width=\"800.0\" x=\"0.0\" y=\"0.0\"> </rect>\n<rect height=\"600.0\" style=\"opacity:1.0;fill:#FFFFFF;stroke:none\" width=\"800.0\" x=\"0.0\" y=\"0.0\"> </rect>\n<rect height=\"600.0\" style=\"opacity:1.0;fill:#FFFFFF;stroke:none\" width=\"800.0\" x=\"0.0\" y=\"0.0\"> </rect>\n<rect height=\"600.0\" style=\"opacity:1.0;fill:#FFFFFF;stroke:none\" width=\"800.0\" x=\"0.0\" y=\"0.0\"> </rect>\n<rect height=\"600.0\" style=\"opacity:1.0;fill:#FFFFFF;stroke:none\" width=\"800.0\" x=\"0.0\" y=\"0.0\"> </rect>\n<rect height=\"600.0\" style=\"opacity:1.0;fill:#FFFFFF;stroke:none\" width=\"800.0\" x=\"0.0\" y=\"0.0\"> </rect>\n<rect height=\"600.0\" style=\"opacity:1.0;fill:#FFFFFF;stroke:none\" width=\"800.0\" x=\"0.0\" y=\"0.0\"> </rect>\n<rect height=\"600.0\" style=\"opacity:1.0;fill:#FFFFFF;stroke:none\" width=\"800.0\" x=\"0.0\" y=\"0.0\"> </rect>\n<rect height=\"600.0\" style=\"opacity:1.0;fill:#FFFFFF;stroke:none\" width=\"800.0\" x=\"0.0\" y=\"0.0\"> </rect>\n<rect height=\"600.0\" style=\"opacity:1.0;fill:#FFFFFF;stroke:none\" width=\"800.0\" x=\"0.0\" y=\"0.0\"> </rect>\n<rect height=\"600.0\" style=\"opacity:1.0;fill:#FFFFFF;stroke:none\" width=\"800.0\" x=\"0.0\" y=\"0.0\"> </rect>\n<rect height=\"600.0\" style=\"opacity:1.0;fill:#FFFFFF;stroke:none\" width=\"800.0\" x=\"0.0\" y=\"0.0\"> </rect>\n<rect height=\"600.0\" style=\"opacity:1.0;fill:#FFFFFF;stroke:none\" width=\"800.0\" x=\"0.0\" y=\"0.0\"> </rect>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 51.5,47.7 L 54.9,52.8\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 54.9,52.8 L 58.2,58.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 54.1,46.0 L 57.5,51.1\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 57.5,51.1 L 60.8,56.3\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-1 atom-1 atom-2\" d=\"M 59.5,57.1 L 56.7,62.7\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-1 atom-1 atom-2\" d=\"M 56.7,62.7 L 53.8,68.3\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-9 atom-1 atom-10\" d=\"M 59.5,57.1 L 66.2,56.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-9 atom-1 atom-10\" d=\"M 66.2,56.8 L 72.8,56.4\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-2 atom-2 atom-3\" d=\"M 54.2,73.4 L 57.5,78.6\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-2 atom-2 atom-3\" d=\"M 57.5,78.6 L 60.9,83.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-3 atom-3 atom-4\" d=\"M 60.9,83.8 L 53.9,97.5\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-3 atom-3 atom-4\" d=\"M 62.6,87.2 L 57.7,96.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-22 atom-8 atom-3\" d=\"M 76.3,83.0 L 60.9,83.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-4 atom-4 atom-5\" d=\"M 53.9,97.5 L 62.3,110.4\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-5 atom-5 atom-6\" d=\"M 62.3,110.4 L 77.7,109.6\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-5 atom-5 atom-6\" d=\"M 64.5,107.2 L 75.2,106.7\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-6 atom-6 atom-7\" d=\"M 77.7,109.6 L 84.7,95.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-7 atom-7 atom-8\" d=\"M 84.7,95.9 L 76.3,83.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-7 atom-7 atom-8\" d=\"M 80.8,95.6 L 75.0,86.6\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-8 atom-8 atom-9\" d=\"M 76.3,83.0 L 78.0,81.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-8 atom-8 atom-9\" d=\"M 78.0,81.0 L 79.8,79.0\" style=\"fill:none;fill-rule:evenodd;stroke:#00CC00;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-10 atom-10 atom-11\" d=\"M 76.6,58.9 L 79.9,64.1\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-10 atom-10 atom-11\" d=\"M 79.9,64.1 L 83.3,69.2\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-23 atom-22 atom-10\" d=\"M 81.9,42.6 L 79.0,48.2\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-23 atom-22 atom-10\" d=\"M 79.0,48.2 L 76.2,53.7\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-11 atom-11 atom-12\" d=\"M 83.3,69.2 L 98.7,68.4\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-12 atom-12 atom-13\" d=\"M 98.7,68.4 L 105.7,54.7\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-13 atom-13 atom-14\" d=\"M 105.7,54.7 L 121.1,53.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-20 atom-13 atom-21\" d=\"M 105.7,54.7 L 97.3,41.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-14 atom-14 atom-15\" d=\"M 121.1,53.9 L 124.4,59.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-14 atom-14 atom-15\" d=\"M 124.4,59.0 L 127.8,64.2\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-15 atom-15 atom-16\" d=\"M 128.2,69.4 L 125.3,74.9\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-15 atom-15 atom-16\" d=\"M 125.3,74.9 L 122.5,80.5\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-24 atom-20 atom-15\" d=\"M 144.9,66.0 L 138.2,66.3\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-24 atom-20 atom-15\" d=\"M 138.2,66.3 L 131.5,66.7\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-16 atom-16 atom-17\" d=\"M 122.5,80.5 L 130.9,93.4\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-17 atom-17 atom-18\" d=\"M 130.9,93.4 L 137.4,93.1\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-17 atom-17 atom-18\" d=\"M 137.4,93.1 L 143.9,92.8\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-18 atom-18 atom-19\" d=\"M 147.6,90.0 L 150.4,84.5\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-18 atom-18 atom-19\" d=\"M 150.4,84.5 L 153.3,78.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-19 atom-19 atom-20\" d=\"M 153.3,78.9 L 144.9,66.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-21 atom-21 atom-22\" d=\"M 97.3,41.8 L 81.9,42.6\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"atom-0\" d=\"M 49.1 44.2 Q 49.1 43.2, 49.6 42.6 Q 50.1 42.0, 51.1 42.0 Q 52.1 42.0, 52.6 42.6 Q 53.1 43.2, 53.1 44.2 Q 53.1 45.3, 52.6 45.9 Q 52.0 46.5, 51.1 46.5 Q 50.1 46.5, 49.6 45.9 Q 49.1 45.3, 49.1 44.2 M 51.1 46.0 Q 51.8 46.0, 52.1 45.5 Q 52.5 45.1, 52.5 44.2 Q 52.5 43.4, 52.1 42.9 Q 51.8 42.5, 51.1 42.5 Q 50.4 42.5, 50.1 42.9 Q 49.7 43.3, 49.7 44.2 Q 49.7 45.1, 50.1 45.5 Q 50.4 46.0, 51.1 46.0 \" fill=\"#FF0000\"/>\n<path class=\"atom-2\" d=\"M 46.9 68.7 L 47.5 68.7 L 47.5 70.5 L 49.7 70.5 L 49.7 68.7 L 50.3 68.7 L 50.3 73.0 L 49.7 73.0 L 49.7 71.0 L 47.5 71.0 L 47.5 73.0 L 46.9 73.0 L 46.9 68.7 \" fill=\"#0000FF\"/>\n<path class=\"atom-2\" d=\"M 51.5 68.7 L 53.0 71.0 Q 53.1 71.2, 53.3 71.6 Q 53.6 72.0, 53.6 72.1 L 53.6 68.7 L 54.2 68.7 L 54.2 73.0 L 53.6 73.0 L 52.0 70.5 Q 51.8 70.2, 51.7 69.9 Q 51.5 69.5, 51.4 69.4 L 51.4 73.0 L 50.8 73.0 L 50.8 68.7 L 51.5 68.7 \" fill=\"#0000FF\"/>\n<path class=\"atom-9\" d=\"M 80.0 76.9 Q 80.0 75.8, 80.5 75.3 Q 81.0 74.7, 82.0 74.7 Q 82.9 74.7, 83.3 75.3 L 82.9 75.7 Q 82.6 75.2, 82.0 75.2 Q 81.3 75.2, 81.0 75.7 Q 80.6 76.1, 80.6 76.9 Q 80.6 77.8, 81.0 78.2 Q 81.3 78.7, 82.0 78.7 Q 82.5 78.7, 83.1 78.4 L 83.2 78.9 Q 83.0 79.0, 82.7 79.1 Q 82.3 79.2, 81.9 79.2 Q 81.0 79.2, 80.5 78.6 Q 80.0 78.0, 80.0 76.9 \" fill=\"#00CC00\"/>\n<path class=\"atom-9\" d=\"M 83.9 74.4 L 84.4 74.4 L 84.4 79.1 L 83.9 79.1 L 83.9 74.4 \" fill=\"#00CC00\"/>\n<path class=\"atom-10\" d=\"M 73.9 54.1 L 75.4 56.4 Q 75.5 56.7, 75.7 57.1 Q 75.9 57.5, 76.0 57.5 L 76.0 54.1 L 76.5 54.1 L 76.5 58.5 L 75.9 58.5 L 74.4 56.0 Q 74.2 55.7, 74.0 55.3 Q 73.9 55.0, 73.8 54.9 L 73.8 58.5 L 73.2 58.5 L 73.2 54.1 L 73.9 54.1 \" fill=\"#0000FF\"/>\n<path class=\"atom-15\" d=\"M 128.5 64.6 L 129.9 66.9 Q 130.1 67.1, 130.3 67.6 Q 130.5 68.0, 130.5 68.0 L 130.5 64.6 L 131.1 64.6 L 131.1 69.0 L 130.5 69.0 L 129.0 66.4 Q 128.8 66.1, 128.6 65.8 Q 128.4 65.5, 128.4 65.4 L 128.4 69.0 L 127.8 69.0 L 127.8 64.6 L 128.5 64.6 \" fill=\"#0000FF\"/>\n<path class=\"atom-18\" d=\"M 144.3 92.6 Q 144.3 91.6, 144.8 91.0 Q 145.3 90.4, 146.3 90.4 Q 147.2 90.4, 147.7 91.0 Q 148.3 91.6, 148.3 92.6 Q 148.3 93.7, 147.7 94.3 Q 147.2 94.9, 146.3 94.9 Q 145.3 94.9, 144.8 94.3 Q 144.3 93.7, 144.3 92.6 M 146.3 94.4 Q 146.9 94.4, 147.3 94.0 Q 147.6 93.5, 147.6 92.6 Q 147.6 91.8, 147.3 91.4 Q 146.9 90.9, 146.3 90.9 Q 145.6 90.9, 145.2 91.4 Q 144.9 91.8, 144.9 92.6 Q 144.9 93.5, 145.2 94.0 Q 145.6 94.4, 146.3 94.4 \" fill=\"#FF0000\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 251.5,47.7 L 254.9,52.8\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 254.9,52.8 L 258.2,58.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 254.1,46.0 L 257.5,51.1\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 257.5,51.1 L 260.8,56.3\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-1 atom-1 atom-2\" d=\"M 259.5,57.1 L 256.7,62.7\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-1 atom-1 atom-2\" d=\"M 256.7,62.7 L 253.8,68.3\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-9 atom-1 atom-10\" d=\"M 259.5,57.1 L 266.2,56.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-9 atom-1 atom-10\" d=\"M 266.2,56.8 L 272.8,56.4\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-2 atom-2 atom-3\" d=\"M 254.2,73.4 L 257.5,78.6\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-2 atom-2 atom-3\" d=\"M 257.5,78.6 L 260.9,83.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-3 atom-3 atom-4\" d=\"M 260.9,83.8 L 253.9,97.5\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-3 atom-3 atom-4\" d=\"M 262.6,87.2 L 257.7,96.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-22 atom-9 atom-3\" d=\"M 276.3,83.0 L 260.9,83.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-4 atom-4 atom-5\" d=\"M 253.9,97.5 L 262.3,110.4\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-5 atom-5 atom-6\" d=\"M 262.3,110.4 L 277.7,109.6\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-5 atom-5 atom-6\" d=\"M 264.5,107.2 L 275.2,106.7\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-6 atom-6 atom-7\" d=\"M 277.7,109.6 L 281.1,114.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-6 atom-6 atom-7\" d=\"M 281.1,114.8 L 284.4,120.0\" style=\"fill:none;fill-rule:evenodd;stroke:#33CCCC;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-7 atom-6 atom-8\" d=\"M 277.7,109.6 L 284.7,95.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-8 atom-8 atom-9\" d=\"M 284.7,95.9 L 276.3,83.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-8 atom-8 atom-9\" d=\"M 280.8,95.6 L 275.0,86.6\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-10 atom-10 atom-11\" d=\"M 276.6,58.9 L 279.9,64.1\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-10 atom-10 atom-11\" d=\"M 279.9,64.1 L 283.3,69.2\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-23 atom-22 atom-10\" d=\"M 281.9,42.6 L 279.0,48.2\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-23 atom-22 atom-10\" d=\"M 279.0,48.2 L 276.2,53.7\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-11 atom-11 atom-12\" d=\"M 283.3,69.2 L 298.7,68.4\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-12 atom-12 atom-13\" d=\"M 298.7,68.4 L 305.7,54.7\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-13 atom-13 atom-14\" d=\"M 305.7,54.7 L 321.1,53.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-20 atom-13 atom-21\" d=\"M 305.7,54.7 L 297.3,41.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-14 atom-14 atom-15\" d=\"M 321.1,53.9 L 324.4,59.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-14 atom-14 atom-15\" d=\"M 324.4,59.0 L 327.8,64.2\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-15 atom-15 atom-16\" d=\"M 328.2,69.4 L 325.3,74.9\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-15 atom-15 atom-16\" d=\"M 325.3,74.9 L 322.5,80.5\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-24 atom-20 atom-15\" d=\"M 344.9,66.0 L 338.2,66.3\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-24 atom-20 atom-15\" d=\"M 338.2,66.3 L 331.5,66.7\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-16 atom-16 atom-17\" d=\"M 322.5,80.5 L 330.9,93.4\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-17 atom-17 atom-18\" d=\"M 330.9,93.4 L 337.4,93.1\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-17 atom-17 atom-18\" d=\"M 337.4,93.1 L 343.9,92.8\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-18 atom-18 atom-19\" d=\"M 347.6,90.0 L 350.4,84.5\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-18 atom-18 atom-19\" d=\"M 350.4,84.5 L 353.3,78.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-19 atom-19 atom-20\" d=\"M 353.3,78.9 L 344.9,66.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-21 atom-21 atom-22\" d=\"M 297.3,41.8 L 281.9,42.6\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"atom-0\" d=\"M 249.1 44.2 Q 249.1 43.2, 249.6 42.6 Q 250.1 42.0, 251.1 42.0 Q 252.1 42.0, 252.6 42.6 Q 253.1 43.2, 253.1 44.2 Q 253.1 45.3, 252.6 45.9 Q 252.0 46.5, 251.1 46.5 Q 250.1 46.5, 249.6 45.9 Q 249.1 45.3, 249.1 44.2 M 251.1 46.0 Q 251.8 46.0, 252.1 45.5 Q 252.5 45.1, 252.5 44.2 Q 252.5 43.4, 252.1 42.9 Q 251.8 42.5, 251.1 42.5 Q 250.4 42.5, 250.1 42.9 Q 249.7 43.3, 249.7 44.2 Q 249.7 45.1, 250.1 45.5 Q 250.4 46.0, 251.1 46.0 \" fill=\"#FF0000\"/>\n<path class=\"atom-2\" d=\"M 246.9 68.7 L 247.5 68.7 L 247.5 70.5 L 249.7 70.5 L 249.7 68.7 L 250.3 68.7 L 250.3 73.0 L 249.7 73.0 L 249.7 71.0 L 247.5 71.0 L 247.5 73.0 L 246.9 73.0 L 246.9 68.7 \" fill=\"#0000FF\"/>\n<path class=\"atom-2\" d=\"M 251.5 68.7 L 253.0 71.0 Q 253.1 71.2, 253.3 71.6 Q 253.6 72.0, 253.6 72.1 L 253.6 68.7 L 254.2 68.7 L 254.2 73.0 L 253.6 73.0 L 252.0 70.5 Q 251.8 70.2, 251.7 69.9 Q 251.5 69.5, 251.4 69.4 L 251.4 73.0 L 250.8 73.0 L 250.8 68.7 L 251.5 68.7 \" fill=\"#0000FF\"/>\n<path class=\"atom-7\" d=\"M 284.8 120.4 L 287.4 120.4 L 287.4 120.9 L 285.4 120.9 L 285.4 122.2 L 287.2 122.2 L 287.2 122.7 L 285.4 122.7 L 285.4 124.7 L 284.8 124.7 L 284.8 120.4 \" fill=\"#33CCCC\"/>\n<path class=\"atom-10\" d=\"M 273.9 54.1 L 275.4 56.4 Q 275.5 56.7, 275.7 57.1 Q 275.9 57.5, 276.0 57.5 L 276.0 54.1 L 276.5 54.1 L 276.5 58.5 L 275.9 58.5 L 274.4 56.0 Q 274.2 55.7, 274.0 55.3 Q 273.9 55.0, 273.8 54.9 L 273.8 58.5 L 273.2 58.5 L 273.2 54.1 L 273.9 54.1 \" fill=\"#0000FF\"/>\n<path class=\"atom-15\" d=\"M 328.5 64.6 L 329.9 66.9 Q 330.1 67.1, 330.3 67.6 Q 330.5 68.0, 330.5 68.0 L 330.5 64.6 L 331.1 64.6 L 331.1 69.0 L 330.5 69.0 L 329.0 66.4 Q 328.8 66.1, 328.6 65.8 Q 328.4 65.5, 328.4 65.4 L 328.4 69.0 L 327.8 69.0 L 327.8 64.6 L 328.5 64.6 \" fill=\"#0000FF\"/>\n<path class=\"atom-18\" d=\"M 344.3 92.6 Q 344.3 91.6, 344.8 91.0 Q 345.3 90.4, 346.3 90.4 Q 347.2 90.4, 347.7 91.0 Q 348.3 91.6, 348.3 92.6 Q 348.3 93.7, 347.7 94.3 Q 347.2 94.9, 346.3 94.9 Q 345.3 94.9, 344.8 94.3 Q 344.3 93.7, 344.3 92.6 M 346.3 94.4 Q 346.9 94.4, 347.3 94.0 Q 347.6 93.5, 347.6 92.6 Q 347.6 91.8, 347.3 91.4 Q 346.9 90.9, 346.3 90.9 Q 345.6 90.9, 345.2 91.4 Q 344.9 91.8, 344.9 92.6 Q 344.9 93.5, 345.2 94.0 Q 345.6 94.4, 346.3 94.4 \" fill=\"#FF0000\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 492.8,132.9 L 489.5,127.7\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 489.5,127.7 L 486.1,122.5\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 495.4,131.2 L 492.6,126.8\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 492.6,126.8 L 489.7,122.4\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 490.2,134.6 L 487.4,130.2\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 487.4,130.2 L 484.5,125.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-1 atom-1 atom-2\" d=\"M 486.1,122.5 L 477.7,109.6\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-2 atom-2 atom-3\" d=\"M 477.7,109.6 L 462.3,110.4\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-2 atom-2 atom-3\" d=\"M 475.2,106.7 L 464.5,107.2\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-23 atom-23 atom-2\" d=\"M 484.7,95.9 L 477.7,109.6\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-3 atom-3 atom-4\" d=\"M 462.3,110.4 L 453.9,97.5\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-4 atom-4 atom-5\" d=\"M 453.9,97.5 L 460.9,83.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-4 atom-4 atom-5\" d=\"M 457.7,96.9 L 462.6,87.2\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-5 atom-5 atom-6\" d=\"M 460.9,83.8 L 457.5,78.6\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-5 atom-5 atom-6\" d=\"M 457.5,78.6 L 454.2,73.4\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-21 atom-5 atom-22\" d=\"M 460.9,83.8 L 476.3,83.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-6 atom-6 atom-7\" d=\"M 453.8,68.3 L 456.7,62.7\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-6 atom-6 atom-7\" d=\"M 456.7,62.7 L 459.5,57.1\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-7 atom-7 atom-8\" d=\"M 460.8,56.3 L 457.5,51.1\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-7 atom-7 atom-8\" d=\"M 457.5,51.1 L 454.1,46.0\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-7 atom-7 atom-8\" d=\"M 458.2,58.0 L 454.9,52.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-7 atom-7 atom-8\" d=\"M 454.9,52.8 L 451.5,47.7\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-8 atom-7 atom-9\" d=\"M 459.5,57.1 L 466.2,56.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-8 atom-7 atom-9\" d=\"M 466.2,56.8 L 472.8,56.4\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-9 atom-9 atom-10\" d=\"M 476.6,58.9 L 479.9,64.1\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-9 atom-9 atom-10\" d=\"M 479.9,64.1 L 483.3,69.2\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-24 atom-21 atom-9\" d=\"M 481.9,42.6 L 479.0,48.2\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-24 atom-21 atom-9\" d=\"M 479.0,48.2 L 476.2,53.7\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-10 atom-10 atom-11\" d=\"M 483.3,69.2 L 498.7,68.4\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-11 atom-11 atom-12\" d=\"M 498.7,68.4 L 505.7,54.7\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-12 atom-12 atom-13\" d=\"M 505.7,54.7 L 521.1,53.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-19 atom-12 atom-20\" d=\"M 505.7,54.7 L 497.3,41.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-13 atom-13 atom-14\" d=\"M 521.1,53.9 L 524.4,59.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-13 atom-13 atom-14\" d=\"M 524.4,59.0 L 527.8,64.2\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-14 atom-14 atom-15\" d=\"M 528.2,69.4 L 525.3,74.9\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-14 atom-14 atom-15\" d=\"M 525.3,74.9 L 522.5,80.5\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-25 atom-19 atom-14\" d=\"M 544.9,66.0 L 538.2,66.3\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-25 atom-19 atom-14\" d=\"M 538.2,66.3 L 531.5,66.7\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-15 atom-15 atom-16\" d=\"M 522.5,80.5 L 530.9,93.4\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-16 atom-16 atom-17\" d=\"M 530.9,93.4 L 537.4,93.1\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-16 atom-16 atom-17\" d=\"M 537.4,93.1 L 543.9,92.8\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-17 atom-17 atom-18\" d=\"M 547.6,90.0 L 550.4,84.5\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-17 atom-17 atom-18\" d=\"M 550.4,84.5 L 553.3,78.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-18 atom-18 atom-19\" d=\"M 553.3,78.9 L 544.9,66.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-20 atom-20 atom-21\" d=\"M 497.3,41.8 L 481.9,42.6\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-22 atom-22 atom-23\" d=\"M 476.3,83.0 L 484.7,95.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-22 atom-22 atom-23\" d=\"M 475.0,86.6 L 480.8,95.6\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"atom-0\" d=\"M 493.5 133.3 L 495.0 135.6 Q 495.1 135.8, 495.3 136.2 Q 495.6 136.7, 495.6 136.7 L 495.6 133.3 L 496.2 133.3 L 496.2 137.7 L 495.6 137.7 L 494.0 135.1 Q 493.8 134.8, 493.7 134.5 Q 493.5 134.2, 493.4 134.0 L 493.4 137.7 L 492.8 137.7 L 492.8 133.3 L 493.5 133.3 \" fill=\"#0000FF\"/>\n<path class=\"atom-6\" d=\"M 446.9 68.7 L 447.5 68.7 L 447.5 70.5 L 449.7 70.5 L 449.7 68.7 L 450.3 68.7 L 450.3 73.0 L 449.7 73.0 L 449.7 71.0 L 447.5 71.0 L 447.5 73.0 L 446.9 73.0 L 446.9 68.7 \" fill=\"#0000FF\"/>\n<path class=\"atom-6\" d=\"M 451.5 68.7 L 453.0 71.0 Q 453.1 71.2, 453.3 71.6 Q 453.6 72.0, 453.6 72.1 L 453.6 68.7 L 454.2 68.7 L 454.2 73.0 L 453.6 73.0 L 452.0 70.5 Q 451.8 70.2, 451.7 69.9 Q 451.5 69.5, 451.4 69.4 L 451.4 73.0 L 450.8 73.0 L 450.8 68.7 L 451.5 68.7 \" fill=\"#0000FF\"/>\n<path class=\"atom-8\" d=\"M 449.1 44.2 Q 449.1 43.2, 449.6 42.6 Q 450.1 42.0, 451.1 42.0 Q 452.1 42.0, 452.6 42.6 Q 453.1 43.2, 453.1 44.2 Q 453.1 45.3, 452.6 45.9 Q 452.0 46.5, 451.1 46.5 Q 450.1 46.5, 449.6 45.9 Q 449.1 45.3, 449.1 44.2 M 451.1 46.0 Q 451.8 46.0, 452.1 45.5 Q 452.5 45.1, 452.5 44.2 Q 452.5 43.4, 452.1 42.9 Q 451.8 42.5, 451.1 42.5 Q 450.4 42.5, 450.1 42.9 Q 449.7 43.3, 449.7 44.2 Q 449.7 45.1, 450.1 45.5 Q 450.4 46.0, 451.1 46.0 \" fill=\"#FF0000\"/>\n<path class=\"atom-9\" d=\"M 473.9 54.1 L 475.4 56.4 Q 475.5 56.7, 475.7 57.1 Q 475.9 57.5, 476.0 57.5 L 476.0 54.1 L 476.5 54.1 L 476.5 58.5 L 475.9 58.5 L 474.4 56.0 Q 474.2 55.7, 474.0 55.3 Q 473.9 55.0, 473.8 54.9 L 473.8 58.5 L 473.2 58.5 L 473.2 54.1 L 473.9 54.1 \" fill=\"#0000FF\"/>\n<path class=\"atom-14\" d=\"M 528.5 64.6 L 529.9 66.9 Q 530.1 67.1, 530.3 67.6 Q 530.5 68.0, 530.5 68.0 L 530.5 64.6 L 531.1 64.6 L 531.1 69.0 L 530.5 69.0 L 529.0 66.4 Q 528.8 66.1, 528.6 65.8 Q 528.4 65.5, 528.4 65.4 L 528.4 69.0 L 527.8 69.0 L 527.8 64.6 L 528.5 64.6 \" fill=\"#0000FF\"/>\n<path class=\"atom-17\" d=\"M 544.3 92.6 Q 544.3 91.6, 544.8 91.0 Q 545.3 90.4, 546.3 90.4 Q 547.2 90.4, 547.7 91.0 Q 548.3 91.6, 548.3 92.6 Q 548.3 93.7, 547.7 94.3 Q 547.2 94.9, 546.3 94.9 Q 545.3 94.9, 544.8 94.3 Q 544.3 93.7, 544.3 92.6 M 546.3 94.4 Q 546.9 94.4, 547.3 94.0 Q 547.6 93.5, 547.6 92.6 Q 547.6 91.8, 547.3 91.4 Q 546.9 90.9, 546.3 90.9 Q 545.6 90.9, 545.2 91.4 Q 544.9 91.8, 544.9 92.6 Q 544.9 93.5, 545.2 94.0 Q 545.6 94.4, 546.3 94.4 \" fill=\"#FF0000\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 700.1,95.1 L 684.7,95.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-1 atom-1 atom-2\" d=\"M 684.7,95.9 L 677.7,109.6\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-1 atom-1 atom-2\" d=\"M 680.9,96.6 L 676.0,106.2\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-22 atom-22 atom-1\" d=\"M 676.3,83.0 L 684.7,95.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-2 atom-2 atom-3\" d=\"M 677.7,109.6 L 662.3,110.4\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-3 atom-3 atom-4\" d=\"M 662.3,110.4 L 653.9,97.5\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-3 atom-3 atom-4\" d=\"M 663.6,106.8 L 657.8,97.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-4 atom-4 atom-5\" d=\"M 653.9,97.5 L 660.9,83.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-5 atom-5 atom-6\" d=\"M 660.9,83.8 L 657.5,78.6\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-5 atom-5 atom-6\" d=\"M 657.5,78.6 L 654.2,73.4\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-21 atom-5 atom-22\" d=\"M 660.9,83.8 L 676.3,83.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-21 atom-5 atom-22\" d=\"M 663.4,86.7 L 674.1,86.2\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-6 atom-6 atom-7\" d=\"M 653.8,68.3 L 656.7,62.7\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-6 atom-6 atom-7\" d=\"M 656.7,62.7 L 659.5,57.1\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-7 atom-7 atom-8\" d=\"M 660.8,56.3 L 657.5,51.1\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-7 atom-7 atom-8\" d=\"M 657.5,51.1 L 654.1,46.0\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-7 atom-7 atom-8\" d=\"M 658.2,58.0 L 654.9,52.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-7 atom-7 atom-8\" d=\"M 654.9,52.8 L 651.5,47.7\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-8 atom-7 atom-9\" d=\"M 659.5,57.1 L 666.2,56.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-8 atom-7 atom-9\" d=\"M 666.2,56.8 L 672.8,56.4\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-9 atom-9 atom-10\" d=\"M 676.6,58.9 L 679.9,64.1\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-9 atom-9 atom-10\" d=\"M 679.9,64.1 L 683.3,69.2\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-23 atom-21 atom-9\" d=\"M 681.9,42.6 L 679.0,48.2\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-23 atom-21 atom-9\" d=\"M 679.0,48.2 L 676.2,53.7\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-10 atom-10 atom-11\" d=\"M 683.3,69.2 L 698.7,68.4\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-11 atom-11 atom-12\" d=\"M 698.7,68.4 L 705.7,54.7\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-12 atom-12 atom-13\" d=\"M 705.7,54.7 L 721.1,53.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-19 atom-12 atom-20\" d=\"M 705.7,54.7 L 697.3,41.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-13 atom-13 atom-14\" d=\"M 721.1,53.9 L 724.4,59.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-13 atom-13 atom-14\" d=\"M 724.4,59.0 L 727.8,64.2\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-14 atom-14 atom-15\" d=\"M 728.2,69.4 L 725.3,74.9\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-14 atom-14 atom-15\" d=\"M 725.3,74.9 L 722.5,80.5\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-24 atom-19 atom-14\" d=\"M 744.9,66.0 L 738.2,66.3\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-24 atom-19 atom-14\" d=\"M 738.2,66.3 L 731.5,66.7\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-15 atom-15 atom-16\" d=\"M 722.5,80.5 L 730.9,93.4\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-16 atom-16 atom-17\" d=\"M 730.9,93.4 L 737.4,93.1\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-16 atom-16 atom-17\" d=\"M 737.4,93.1 L 743.9,92.8\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-17 atom-17 atom-18\" d=\"M 747.6,90.0 L 750.4,84.5\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-17 atom-17 atom-18\" d=\"M 750.4,84.5 L 753.3,78.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-18 atom-18 atom-19\" d=\"M 753.3,78.9 L 744.9,66.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-20 atom-20 atom-21\" d=\"M 697.3,41.8 L 681.9,42.6\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"atom-6\" d=\"M 646.9 68.7 L 647.5 68.7 L 647.5 70.5 L 649.7 70.5 L 649.7 68.7 L 650.3 68.7 L 650.3 73.0 L 649.7 73.0 L 649.7 71.0 L 647.5 71.0 L 647.5 73.0 L 646.9 73.0 L 646.9 68.7 \" fill=\"#0000FF\"/>\n<path class=\"atom-6\" d=\"M 651.5 68.7 L 653.0 71.0 Q 653.1 71.2, 653.3 71.6 Q 653.6 72.0, 653.6 72.1 L 653.6 68.7 L 654.2 68.7 L 654.2 73.0 L 653.6 73.0 L 652.0 70.5 Q 651.8 70.2, 651.7 69.9 Q 651.5 69.5, 651.4 69.4 L 651.4 73.0 L 650.8 73.0 L 650.8 68.7 L 651.5 68.7 \" fill=\"#0000FF\"/>\n<path class=\"atom-8\" d=\"M 649.1 44.2 Q 649.1 43.2, 649.6 42.6 Q 650.1 42.0, 651.1 42.0 Q 652.1 42.0, 652.6 42.6 Q 653.1 43.2, 653.1 44.2 Q 653.1 45.3, 652.6 45.9 Q 652.0 46.5, 651.1 46.5 Q 650.1 46.5, 649.6 45.9 Q 649.1 45.3, 649.1 44.2 M 651.1 46.0 Q 651.8 46.0, 652.1 45.5 Q 652.5 45.1, 652.5 44.2 Q 652.5 43.4, 652.1 42.9 Q 651.8 42.5, 651.1 42.5 Q 650.4 42.5, 650.1 42.9 Q 649.7 43.3, 649.7 44.2 Q 649.7 45.1, 650.1 45.5 Q 650.4 46.0, 651.1 46.0 \" fill=\"#FF0000\"/>\n<path class=\"atom-9\" d=\"M 673.9 54.1 L 675.4 56.4 Q 675.5 56.7, 675.7 57.1 Q 675.9 57.5, 676.0 57.5 L 676.0 54.1 L 676.5 54.1 L 676.5 58.5 L 675.9 58.5 L 674.4 56.0 Q 674.2 55.7, 674.0 55.3 Q 673.9 55.0, 673.8 54.9 L 673.8 58.5 L 673.2 58.5 L 673.2 54.1 L 673.9 54.1 \" fill=\"#0000FF\"/>\n<path class=\"atom-14\" d=\"M 728.5 64.6 L 729.9 66.9 Q 730.1 67.1, 730.3 67.6 Q 730.5 68.0, 730.5 68.0 L 730.5 64.6 L 731.1 64.6 L 731.1 69.0 L 730.5 69.0 L 729.0 66.4 Q 728.8 66.1, 728.6 65.8 Q 728.4 65.5, 728.4 65.4 L 728.4 69.0 L 727.8 69.0 L 727.8 64.6 L 728.5 64.6 \" fill=\"#0000FF\"/>\n<path class=\"atom-17\" d=\"M 744.3 92.6 Q 744.3 91.6, 744.8 91.0 Q 745.3 90.4, 746.3 90.4 Q 747.2 90.4, 747.7 91.0 Q 748.3 91.6, 748.3 92.6 Q 748.3 93.7, 747.7 94.3 Q 747.2 94.9, 746.3 94.9 Q 745.3 94.9, 744.8 94.3 Q 744.3 93.7, 744.3 92.6 M 746.3 94.4 Q 746.9 94.4, 747.3 94.0 Q 747.6 93.5, 747.6 92.6 Q 747.6 91.8, 747.3 91.4 Q 746.9 90.9, 746.3 90.9 Q 745.6 90.9, 745.2 91.4 Q 744.9 91.8, 744.9 92.6 Q 744.9 93.5, 745.2 94.0 Q 745.6 94.4, 746.3 94.4 \" fill=\"#FF0000\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 51.5,197.7 L 54.9,202.8\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 54.9,202.8 L 58.2,208.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 54.1,196.0 L 57.5,201.1\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 57.5,201.1 L 60.8,206.3\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-1 atom-1 atom-2\" d=\"M 59.5,207.1 L 56.7,212.7\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-1 atom-1 atom-2\" d=\"M 56.7,212.7 L 53.8,218.3\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-9 atom-1 atom-10\" d=\"M 59.5,207.1 L 66.2,206.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-9 atom-1 atom-10\" d=\"M 66.2,206.8 L 72.8,206.4\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-2 atom-2 atom-3\" d=\"M 54.2,223.4 L 57.5,228.6\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-2 atom-2 atom-3\" d=\"M 57.5,228.6 L 60.9,233.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-3 atom-3 atom-4\" d=\"M 60.9,233.8 L 53.9,247.5\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-3 atom-3 atom-4\" d=\"M 62.6,237.2 L 57.7,246.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-22 atom-9 atom-3\" d=\"M 76.3,233.0 L 60.9,233.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-4 atom-4 atom-5\" d=\"M 53.9,247.5 L 62.3,260.4\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-5 atom-5 atom-6\" d=\"M 62.3,260.4 L 59.5,266.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-5 atom-5 atom-6\" d=\"M 59.5,266.0 L 56.6,271.6\" style=\"fill:none;fill-rule:evenodd;stroke:#33CCCC;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-6 atom-5 atom-7\" d=\"M 62.3,260.4 L 77.7,259.6\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-6 atom-5 atom-7\" d=\"M 64.5,257.2 L 75.2,256.7\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-7 atom-7 atom-8\" d=\"M 77.7,259.6 L 84.7,245.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-8 atom-8 atom-9\" d=\"M 84.7,245.9 L 76.3,233.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-8 atom-8 atom-9\" d=\"M 80.8,245.6 L 75.0,236.6\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-10 atom-10 atom-11\" d=\"M 76.6,208.9 L 79.9,214.1\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-10 atom-10 atom-11\" d=\"M 79.9,214.1 L 83.3,219.2\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-23 atom-22 atom-10\" d=\"M 81.9,192.6 L 79.0,198.2\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-23 atom-22 atom-10\" d=\"M 79.0,198.2 L 76.2,203.7\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-11 atom-11 atom-12\" d=\"M 83.3,219.2 L 98.7,218.4\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-12 atom-12 atom-13\" d=\"M 98.7,218.4 L 105.7,204.7\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-13 atom-13 atom-14\" d=\"M 105.7,204.7 L 121.1,203.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-20 atom-13 atom-21\" d=\"M 105.7,204.7 L 97.3,191.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-14 atom-14 atom-15\" d=\"M 121.1,203.9 L 124.4,209.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-14 atom-14 atom-15\" d=\"M 124.4,209.0 L 127.8,214.2\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-15 atom-15 atom-16\" d=\"M 128.2,219.4 L 125.3,224.9\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-15 atom-15 atom-16\" d=\"M 125.3,224.9 L 122.5,230.5\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-24 atom-20 atom-15\" d=\"M 144.9,216.0 L 138.2,216.3\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-24 atom-20 atom-15\" d=\"M 138.2,216.3 L 131.5,216.7\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-16 atom-16 atom-17\" d=\"M 122.5,230.5 L 130.9,243.4\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-17 atom-17 atom-18\" d=\"M 130.9,243.4 L 137.4,243.1\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-17 atom-17 atom-18\" d=\"M 137.4,243.1 L 143.9,242.8\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-18 atom-18 atom-19\" d=\"M 147.6,240.0 L 150.4,234.5\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-18 atom-18 atom-19\" d=\"M 150.4,234.5 L 153.3,228.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-19 atom-19 atom-20\" d=\"M 153.3,228.9 L 144.9,216.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-21 atom-21 atom-22\" d=\"M 97.3,191.8 L 81.9,192.6\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"atom-0\" d=\"M 49.1 194.2 Q 49.1 193.2, 49.6 192.6 Q 50.1 192.0, 51.1 192.0 Q 52.1 192.0, 52.6 192.6 Q 53.1 193.2, 53.1 194.2 Q 53.1 195.3, 52.6 195.9 Q 52.0 196.5, 51.1 196.5 Q 50.1 196.5, 49.6 195.9 Q 49.1 195.3, 49.1 194.2 M 51.1 196.0 Q 51.8 196.0, 52.1 195.5 Q 52.5 195.1, 52.5 194.2 Q 52.5 193.4, 52.1 192.9 Q 51.8 192.5, 51.1 192.5 Q 50.4 192.5, 50.1 192.9 Q 49.7 193.3, 49.7 194.2 Q 49.7 195.1, 50.1 195.5 Q 50.4 196.0, 51.1 196.0 \" fill=\"#FF0000\"/>\n<path class=\"atom-2\" d=\"M 46.9 218.7 L 47.5 218.7 L 47.5 220.5 L 49.7 220.5 L 49.7 218.7 L 50.3 218.7 L 50.3 223.0 L 49.7 223.0 L 49.7 221.0 L 47.5 221.0 L 47.5 223.0 L 46.9 223.0 L 46.9 218.7 \" fill=\"#0000FF\"/>\n<path class=\"atom-2\" d=\"M 51.5 218.7 L 53.0 221.0 Q 53.1 221.2, 53.3 221.6 Q 53.6 222.0, 53.6 222.1 L 53.6 218.7 L 54.2 218.7 L 54.2 223.0 L 53.6 223.0 L 52.0 220.5 Q 51.8 220.2, 51.7 219.9 Q 51.5 219.5, 51.4 219.4 L 51.4 223.0 L 50.8 223.0 L 50.8 218.7 L 51.5 218.7 \" fill=\"#0000FF\"/>\n<path class=\"atom-6\" d=\"M 54.0 272.0 L 56.6 272.0 L 56.6 272.5 L 54.6 272.5 L 54.6 273.8 L 56.4 273.8 L 56.4 274.3 L 54.6 274.3 L 54.6 276.4 L 54.0 276.4 L 54.0 272.0 \" fill=\"#33CCCC\"/>\n<path class=\"atom-10\" d=\"M 73.9 204.1 L 75.4 206.4 Q 75.5 206.7, 75.7 207.1 Q 75.9 207.5, 76.0 207.5 L 76.0 204.1 L 76.5 204.1 L 76.5 208.5 L 75.9 208.5 L 74.4 206.0 Q 74.2 205.7, 74.0 205.3 Q 73.9 205.0, 73.8 204.9 L 73.8 208.5 L 73.2 208.5 L 73.2 204.1 L 73.9 204.1 \" fill=\"#0000FF\"/>\n<path class=\"atom-15\" d=\"M 128.5 214.6 L 129.9 216.9 Q 130.1 217.1, 130.3 217.6 Q 130.5 218.0, 130.5 218.0 L 130.5 214.6 L 131.1 214.6 L 131.1 219.0 L 130.5 219.0 L 129.0 216.4 Q 128.8 216.1, 128.6 215.8 Q 128.4 215.5, 128.4 215.4 L 128.4 219.0 L 127.8 219.0 L 127.8 214.6 L 128.5 214.6 \" fill=\"#0000FF\"/>\n<path class=\"atom-18\" d=\"M 144.3 242.6 Q 144.3 241.6, 144.8 241.0 Q 145.3 240.4, 146.3 240.4 Q 147.2 240.4, 147.7 241.0 Q 148.3 241.6, 148.3 242.6 Q 148.3 243.7, 147.7 244.3 Q 147.2 244.9, 146.3 244.9 Q 145.3 244.9, 144.8 244.3 Q 144.3 243.7, 144.3 242.6 M 146.3 244.4 Q 146.9 244.4, 147.3 244.0 Q 147.6 243.5, 147.6 242.6 Q 147.6 241.8, 147.3 241.4 Q 146.9 240.9, 146.3 240.9 Q 145.6 240.9, 145.2 241.4 Q 144.9 241.8, 144.9 242.6 Q 144.9 243.5, 145.2 244.0 Q 145.6 244.4, 146.3 244.4 \" fill=\"#FF0000\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 251.5,197.7 L 254.9,202.8\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 254.9,202.8 L 258.2,208.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 254.1,196.0 L 257.5,201.1\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 257.5,201.1 L 260.8,206.3\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-1 atom-1 atom-2\" d=\"M 259.5,207.1 L 256.7,212.7\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-1 atom-1 atom-2\" d=\"M 256.7,212.7 L 253.8,218.3\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-9 atom-1 atom-10\" d=\"M 259.5,207.1 L 266.2,206.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-9 atom-1 atom-10\" d=\"M 266.2,206.8 L 272.8,206.4\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-2 atom-2 atom-3\" d=\"M 254.2,223.4 L 257.5,228.6\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-2 atom-2 atom-3\" d=\"M 257.5,228.6 L 260.9,233.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-3 atom-3 atom-4\" d=\"M 260.9,233.8 L 253.9,247.5\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-3 atom-3 atom-4\" d=\"M 262.6,237.2 L 257.7,246.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-22 atom-8 atom-3\" d=\"M 276.3,233.0 L 260.9,233.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-4 atom-4 atom-5\" d=\"M 253.9,247.5 L 262.3,260.4\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-5 atom-5 atom-6\" d=\"M 262.3,260.4 L 277.7,259.6\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-5 atom-5 atom-6\" d=\"M 264.5,257.2 L 275.2,256.7\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-6 atom-6 atom-7\" d=\"M 277.7,259.6 L 284.7,245.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-7 atom-7 atom-8\" d=\"M 284.7,245.9 L 276.3,233.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-7 atom-7 atom-8\" d=\"M 280.8,245.6 L 275.0,236.6\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-8 atom-8 atom-9\" d=\"M 276.3,233.0 L 278.2,230.7\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-8 atom-8 atom-9\" d=\"M 278.2,230.7 L 280.2,228.5\" style=\"fill:none;fill-rule:evenodd;stroke:#33CCCC;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-10 atom-10 atom-11\" d=\"M 276.6,208.9 L 279.9,214.1\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-10 atom-10 atom-11\" d=\"M 279.9,214.1 L 283.3,219.2\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-23 atom-22 atom-10\" d=\"M 281.9,192.6 L 279.0,198.2\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-23 atom-22 atom-10\" d=\"M 279.0,198.2 L 276.2,203.7\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-11 atom-11 atom-12\" d=\"M 283.3,219.2 L 298.7,218.4\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-12 atom-12 atom-13\" d=\"M 298.7,218.4 L 305.7,204.7\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-13 atom-13 atom-14\" d=\"M 305.7,204.7 L 321.1,203.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-20 atom-13 atom-21\" d=\"M 305.7,204.7 L 297.3,191.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-14 atom-14 atom-15\" d=\"M 321.1,203.9 L 324.4,209.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-14 atom-14 atom-15\" d=\"M 324.4,209.0 L 327.8,214.2\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-15 atom-15 atom-16\" d=\"M 328.2,219.4 L 325.3,224.9\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-15 atom-15 atom-16\" d=\"M 325.3,224.9 L 322.5,230.5\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-24 atom-20 atom-15\" d=\"M 344.9,216.0 L 338.2,216.3\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-24 atom-20 atom-15\" d=\"M 338.2,216.3 L 331.5,216.7\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-16 atom-16 atom-17\" d=\"M 322.5,230.5 L 330.9,243.4\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-17 atom-17 atom-18\" d=\"M 330.9,243.4 L 337.4,243.1\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-17 atom-17 atom-18\" d=\"M 337.4,243.1 L 343.9,242.8\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-18 atom-18 atom-19\" d=\"M 347.6,240.0 L 350.4,234.5\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-18 atom-18 atom-19\" d=\"M 350.4,234.5 L 353.3,228.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-19 atom-19 atom-20\" d=\"M 353.3,228.9 L 344.9,216.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-21 atom-21 atom-22\" d=\"M 297.3,191.8 L 281.9,192.6\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"atom-0\" d=\"M 249.1 194.2 Q 249.1 193.2, 249.6 192.6 Q 250.1 192.0, 251.1 192.0 Q 252.1 192.0, 252.6 192.6 Q 253.1 193.2, 253.1 194.2 Q 253.1 195.3, 252.6 195.9 Q 252.0 196.5, 251.1 196.5 Q 250.1 196.5, 249.6 195.9 Q 249.1 195.3, 249.1 194.2 M 251.1 196.0 Q 251.8 196.0, 252.1 195.5 Q 252.5 195.1, 252.5 194.2 Q 252.5 193.4, 252.1 192.9 Q 251.8 192.5, 251.1 192.5 Q 250.4 192.5, 250.1 192.9 Q 249.7 193.3, 249.7 194.2 Q 249.7 195.1, 250.1 195.5 Q 250.4 196.0, 251.1 196.0 \" fill=\"#FF0000\"/>\n<path class=\"atom-2\" d=\"M 246.9 218.7 L 247.5 218.7 L 247.5 220.5 L 249.7 220.5 L 249.7 218.7 L 250.3 218.7 L 250.3 223.0 L 249.7 223.0 L 249.7 221.0 L 247.5 221.0 L 247.5 223.0 L 246.9 223.0 L 246.9 218.7 \" fill=\"#0000FF\"/>\n<path class=\"atom-2\" d=\"M 251.5 218.7 L 253.0 221.0 Q 253.1 221.2, 253.3 221.6 Q 253.6 222.0, 253.6 222.1 L 253.6 218.7 L 254.2 218.7 L 254.2 223.0 L 253.6 223.0 L 252.0 220.5 Q 251.8 220.2, 251.7 219.9 Q 251.5 219.5, 251.4 219.4 L 251.4 223.0 L 250.8 223.0 L 250.8 218.7 L 251.5 218.7 \" fill=\"#0000FF\"/>\n<path class=\"atom-9\" d=\"M 280.4 224.6 L 283.0 224.6 L 283.0 225.1 L 281.0 225.1 L 281.0 226.4 L 282.7 226.4 L 282.7 226.9 L 281.0 226.9 L 281.0 229.0 L 280.4 229.0 L 280.4 224.6 \" fill=\"#33CCCC\"/>\n<path class=\"atom-10\" d=\"M 273.9 204.1 L 275.4 206.4 Q 275.5 206.7, 275.7 207.1 Q 275.9 207.5, 276.0 207.5 L 276.0 204.1 L 276.5 204.1 L 276.5 208.5 L 275.9 208.5 L 274.4 206.0 Q 274.2 205.7, 274.0 205.3 Q 273.9 205.0, 273.8 204.9 L 273.8 208.5 L 273.2 208.5 L 273.2 204.1 L 273.9 204.1 \" fill=\"#0000FF\"/>\n<path class=\"atom-15\" d=\"M 328.5 214.6 L 329.9 216.9 Q 330.1 217.1, 330.3 217.6 Q 330.5 218.0, 330.5 218.0 L 330.5 214.6 L 331.1 214.6 L 331.1 219.0 L 330.5 219.0 L 329.0 216.4 Q 328.8 216.1, 328.6 215.8 Q 328.4 215.5, 328.4 215.4 L 328.4 219.0 L 327.8 219.0 L 327.8 214.6 L 328.5 214.6 \" fill=\"#0000FF\"/>\n<path class=\"atom-18\" d=\"M 344.3 242.6 Q 344.3 241.6, 344.8 241.0 Q 345.3 240.4, 346.3 240.4 Q 347.2 240.4, 347.7 241.0 Q 348.3 241.6, 348.3 242.6 Q 348.3 243.7, 347.7 244.3 Q 347.2 244.9, 346.3 244.9 Q 345.3 244.9, 344.8 244.3 Q 344.3 243.7, 344.3 242.6 M 346.3 244.4 Q 346.9 244.4, 347.3 244.0 Q 347.6 243.5, 347.6 242.6 Q 347.6 241.8, 347.3 241.4 Q 346.9 240.9, 346.3 240.9 Q 345.6 240.9, 345.2 241.4 Q 344.9 241.8, 344.9 242.6 Q 344.9 243.5, 345.2 244.0 Q 345.6 244.4, 346.3 244.4 \" fill=\"#FF0000\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 594.2,263.6 L 587.7,263.6\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 587.7,263.6 L 581.2,263.6\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-1 atom-1 atom-2\" d=\"M 577.3,261.0 L 574.2,255.6\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-1 atom-1 atom-2\" d=\"M 574.2,255.6 L 571.1,250.2\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-2 atom-2 atom-3\" d=\"M 571.1,250.2 L 555.7,250.2\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-3 atom-3 atom-4\" d=\"M 555.7,250.2 L 552.6,244.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-3 atom-3 atom-4\" d=\"M 552.6,244.8 L 549.5,239.4\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-4 atom-4 atom-5\" d=\"M 549.5,234.3 L 552.6,228.9\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-4 atom-4 atom-5\" d=\"M 552.6,228.9 L 555.7,223.5\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-7 atom-4 atom-8\" d=\"M 545.9,236.9 L 539.3,236.9\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-7 atom-4 atom-8\" d=\"M 539.3,236.9 L 532.6,236.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-5 atom-5 atom-6\" d=\"M 555.7,223.5 L 571.1,223.5\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-6 atom-6 atom-7\" d=\"M 571.1,223.5 L 574.2,218.2\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-6 atom-6 atom-7\" d=\"M 574.2,218.2 L 577.3,212.8\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-8 atom-8 atom-9\" d=\"M 531.2,236.1 L 528.1,241.5\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-8 atom-8 atom-9\" d=\"M 528.1,241.5 L 525.0,246.9\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-8 atom-8 atom-9\" d=\"M 533.9,237.6 L 530.8,243.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-8 atom-8 atom-9\" d=\"M 530.8,243.0 L 527.7,248.4\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-9 atom-8 atom-10\" d=\"M 532.6,236.9 L 529.5,231.5\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-9 atom-8 atom-10\" d=\"M 529.5,231.5 L 526.3,226.1\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-10 atom-10 atom-11\" d=\"M 522.8,223.5 L 516.1,223.5\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-10 atom-10 atom-11\" d=\"M 516.1,223.5 L 509.4,223.5\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-11 atom-11 atom-12\" d=\"M 509.4,223.5 L 501.7,236.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-11 atom-11 atom-12\" d=\"M 505.6,224.0 L 500.2,233.3\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-17 atom-16 atom-11\" d=\"M 501.7,210.2 L 509.4,223.5\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-12 atom-12 atom-13\" d=\"M 501.7,236.9 L 486.3,236.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-13 atom-13 atom-14\" d=\"M 486.3,236.9 L 478.6,223.5\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-13 atom-13 atom-14\" d=\"M 487.8,233.3 L 482.4,224.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-14 atom-14 atom-15\" d=\"M 478.6,223.5 L 486.3,210.2\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-15 atom-15 atom-16\" d=\"M 486.3,210.2 L 501.7,210.2\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-15 atom-15 atom-16\" d=\"M 488.6,213.3 L 499.4,213.3\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-16 atom-16 atom-17\" d=\"M 501.7,210.2 L 504.8,204.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-16 atom-16 atom-17\" d=\"M 504.8,204.9 L 507.8,199.6\" style=\"fill:none;fill-rule:evenodd;stroke:#00CC00;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"atom-1\" d=\"M 576.8 263.6 Q 576.8 262.5, 577.3 261.9 Q 577.8 261.4, 578.8 261.4 Q 579.8 261.4, 580.3 261.9 Q 580.8 262.5, 580.8 263.6 Q 580.8 264.6, 580.3 265.2 Q 579.8 265.8, 578.8 265.8 Q 577.8 265.8, 577.3 265.2 Q 576.8 264.6, 576.8 263.6 M 578.8 265.3 Q 579.5 265.3, 579.8 264.9 Q 580.2 264.5, 580.2 263.6 Q 580.2 262.7, 579.8 262.3 Q 579.5 261.9, 578.8 261.9 Q 578.1 261.9, 577.8 262.3 Q 577.4 262.7, 577.4 263.6 Q 577.4 264.5, 577.8 264.9 Q 578.1 265.3, 578.8 265.3 \" fill=\"#FF0000\"/>\n<path class=\"atom-4\" d=\"M 547.0 234.7 L 548.4 237.0 Q 548.6 237.2, 548.8 237.6 Q 549.0 238.1, 549.1 238.1 L 549.1 234.7 L 549.6 234.7 L 549.6 239.1 L 549.0 239.1 L 547.5 236.5 Q 547.3 236.2, 547.1 235.9 Q 546.9 235.6, 546.9 235.4 L 546.9 239.1 L 546.3 239.1 L 546.3 234.7 L 547.0 234.7 \" fill=\"#0000FF\"/>\n<path class=\"atom-7\" d=\"M 576.8 210.2 Q 576.8 209.1, 577.3 208.6 Q 577.8 208.0, 578.8 208.0 Q 579.8 208.0, 580.3 208.6 Q 580.8 209.1, 580.8 210.2 Q 580.8 211.2, 580.3 211.9 Q 579.8 212.4, 578.8 212.4 Q 577.8 212.4, 577.3 211.9 Q 576.8 211.3, 576.8 210.2 M 578.8 212.0 Q 579.5 212.0, 579.8 211.5 Q 580.2 211.1, 580.2 210.2 Q 580.2 209.3, 579.8 208.9 Q 579.5 208.5, 578.8 208.5 Q 578.1 208.5, 577.8 208.9 Q 577.4 209.3, 577.4 210.2 Q 577.4 211.1, 577.8 211.5 Q 578.1 212.0, 578.8 212.0 \" fill=\"#FF0000\"/>\n<path class=\"atom-7\" d=\"M 581.3 208.0 L 581.9 208.0 L 581.9 209.9 L 584.2 209.9 L 584.2 208.0 L 584.8 208.0 L 584.8 212.4 L 584.2 212.4 L 584.2 210.4 L 581.9 210.4 L 581.9 212.4 L 581.3 212.4 L 581.3 208.0 \" fill=\"#FF0000\"/>\n<path class=\"atom-9\" d=\"M 522.9 250.2 Q 522.9 249.2, 523.4 248.6 Q 523.9 248.0, 524.9 248.0 Q 525.8 248.0, 526.3 248.6 Q 526.9 249.2, 526.9 250.2 Q 526.9 251.3, 526.3 251.9 Q 525.8 252.5, 524.9 252.5 Q 523.9 252.5, 523.4 251.9 Q 522.9 251.3, 522.9 250.2 M 524.9 252.0 Q 525.5 252.0, 525.9 251.6 Q 526.2 251.1, 526.2 250.2 Q 526.2 249.4, 525.9 248.9 Q 525.5 248.5, 524.9 248.5 Q 524.2 248.5, 523.8 248.9 Q 523.5 249.4, 523.5 250.2 Q 523.5 251.1, 523.8 251.6 Q 524.2 252.0, 524.9 252.0 \" fill=\"#FF0000\"/>\n<path class=\"atom-10\" d=\"M 523.9 221.3 L 525.3 223.7 Q 525.5 223.9, 525.7 224.3 Q 525.9 224.7, 525.9 224.7 L 525.9 221.3 L 526.5 221.3 L 526.5 225.7 L 525.9 225.7 L 524.4 223.2 Q 524.2 222.9, 524.0 222.5 Q 523.8 222.2, 523.8 222.1 L 523.8 225.7 L 523.2 225.7 L 523.2 221.3 L 523.9 221.3 \" fill=\"#0000FF\"/>\n<path class=\"atom-10\" d=\"M 527.0 221.3 L 527.6 221.3 L 527.6 223.2 L 529.9 223.2 L 529.9 221.3 L 530.5 221.3 L 530.5 225.7 L 529.9 225.7 L 529.9 223.7 L 527.6 223.7 L 527.6 225.7 L 527.0 225.7 L 527.0 221.3 \" fill=\"#0000FF\"/>\n<path class=\"atom-17\" d=\"M 507.8 197.0 Q 507.8 195.9, 508.3 195.3 Q 508.8 194.8, 509.8 194.8 Q 510.7 194.8, 511.1 195.4 L 510.7 195.7 Q 510.4 195.3, 509.8 195.3 Q 509.1 195.3, 508.7 195.7 Q 508.4 196.1, 508.4 197.0 Q 508.4 197.8, 508.8 198.3 Q 509.1 198.7, 509.8 198.7 Q 510.3 198.7, 510.9 198.4 L 511.0 198.9 Q 510.8 199.0, 510.5 199.1 Q 510.1 199.2, 509.7 199.2 Q 508.8 199.2, 508.3 198.6 Q 507.8 198.1, 507.8 197.0 \" fill=\"#00CC00\"/>\n<path class=\"atom-17\" d=\"M 511.7 194.5 L 512.2 194.5 L 512.2 199.2 L 511.7 199.2 L 511.7 194.5 \" fill=\"#00CC00\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 649.6,285.3 L 652.5,279.8\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 652.5,279.8 L 655.3,274.2\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 652.4,286.7 L 654.8,282.0\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 654.8,282.0 L 657.2,277.2\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 646.9,283.9 L 649.3,279.2\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 649.3,279.2 L 651.7,274.5\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-1 atom-1 atom-2\" d=\"M 655.3,274.2 L 662.3,260.4\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-2 atom-2 atom-3\" d=\"M 662.3,260.4 L 653.9,247.5\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-2 atom-2 atom-3\" d=\"M 663.6,256.8 L 657.8,247.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-23 atom-23 atom-2\" d=\"M 677.7,259.6 L 662.3,260.4\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-3 atom-3 atom-4\" d=\"M 653.9,247.5 L 660.9,233.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-4 atom-4 atom-5\" d=\"M 660.9,233.8 L 657.5,228.6\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-4 atom-4 atom-5\" d=\"M 657.5,228.6 L 654.2,223.4\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-20 atom-4 atom-21\" d=\"M 660.9,233.8 L 676.3,233.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-20 atom-4 atom-21\" d=\"M 663.4,236.7 L 674.1,236.2\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-5 atom-5 atom-6\" d=\"M 653.8,218.3 L 656.7,212.7\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-5 atom-5 atom-6\" d=\"M 656.7,212.7 L 659.5,207.1\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-6 atom-6 atom-7\" d=\"M 660.8,206.3 L 657.5,201.1\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-6 atom-6 atom-7\" d=\"M 657.5,201.1 L 654.1,196.0\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-6 atom-6 atom-7\" d=\"M 658.2,208.0 L 654.9,202.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-6 atom-6 atom-7\" d=\"M 654.9,202.8 L 651.5,197.7\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-7 atom-6 atom-8\" d=\"M 659.5,207.1 L 666.2,206.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-7 atom-6 atom-8\" d=\"M 666.2,206.8 L 672.8,206.4\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-8 atom-8 atom-9\" d=\"M 676.6,208.9 L 679.9,214.1\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-8 atom-8 atom-9\" d=\"M 679.9,214.1 L 683.3,219.2\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-24 atom-20 atom-8\" d=\"M 681.9,192.6 L 679.0,198.2\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-24 atom-20 atom-8\" d=\"M 679.0,198.2 L 676.2,203.7\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-9 atom-9 atom-10\" d=\"M 683.3,219.2 L 698.7,218.4\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-10 atom-10 atom-11\" d=\"M 698.7,218.4 L 705.7,204.7\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-11 atom-11 atom-12\" d=\"M 705.7,204.7 L 721.1,203.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-18 atom-11 atom-19\" d=\"M 705.7,204.7 L 697.3,191.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-12 atom-12 atom-13\" d=\"M 721.1,203.9 L 724.4,209.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-12 atom-12 atom-13\" d=\"M 724.4,209.0 L 727.8,214.2\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-13 atom-13 atom-14\" d=\"M 728.2,219.4 L 725.3,224.9\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-13 atom-13 atom-14\" d=\"M 725.3,224.9 L 722.5,230.5\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-25 atom-18 atom-13\" d=\"M 744.9,216.0 L 738.2,216.3\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-25 atom-18 atom-13\" d=\"M 738.2,216.3 L 731.5,216.7\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-14 atom-14 atom-15\" d=\"M 722.5,230.5 L 730.9,243.4\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-15 atom-15 atom-16\" d=\"M 730.9,243.4 L 737.4,243.1\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-15 atom-15 atom-16\" d=\"M 737.4,243.1 L 743.9,242.8\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-16 atom-16 atom-17\" d=\"M 747.6,240.0 L 750.4,234.5\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-16 atom-16 atom-17\" d=\"M 750.4,234.5 L 753.3,228.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-17 atom-17 atom-18\" d=\"M 753.3,228.9 L 744.9,216.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-19 atom-19 atom-20\" d=\"M 697.3,191.8 L 681.9,192.6\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-21 atom-21 atom-22\" d=\"M 676.3,233.0 L 684.7,245.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-22 atom-22 atom-23\" d=\"M 684.7,245.9 L 677.7,259.6\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-22 atom-22 atom-23\" d=\"M 680.9,246.6 L 676.0,256.2\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"atom-0\" d=\"M 647.4 285.7 L 648.8 288.0 Q 648.9 288.3, 649.2 288.7 Q 649.4 289.1, 649.4 289.1 L 649.4 285.7 L 650.0 285.7 L 650.0 290.1 L 649.4 290.1 L 647.8 287.6 Q 647.7 287.3, 647.5 286.9 Q 647.3 286.6, 647.2 286.5 L 647.2 290.1 L 646.7 290.1 L 646.7 285.7 L 647.4 285.7 \" fill=\"#0000FF\"/>\n<path class=\"atom-5\" d=\"M 646.9 218.7 L 647.5 218.7 L 647.5 220.5 L 649.7 220.5 L 649.7 218.7 L 650.3 218.7 L 650.3 223.0 L 649.7 223.0 L 649.7 221.0 L 647.5 221.0 L 647.5 223.0 L 646.9 223.0 L 646.9 218.7 \" fill=\"#0000FF\"/>\n<path class=\"atom-5\" d=\"M 651.5 218.7 L 653.0 221.0 Q 653.1 221.2, 653.3 221.6 Q 653.6 222.0, 653.6 222.1 L 653.6 218.7 L 654.2 218.7 L 654.2 223.0 L 653.6 223.0 L 652.0 220.5 Q 651.8 220.2, 651.7 219.9 Q 651.5 219.5, 651.4 219.4 L 651.4 223.0 L 650.8 223.0 L 650.8 218.7 L 651.5 218.7 \" fill=\"#0000FF\"/>\n<path class=\"atom-7\" d=\"M 649.1 194.2 Q 649.1 193.2, 649.6 192.6 Q 650.1 192.0, 651.1 192.0 Q 652.1 192.0, 652.6 192.6 Q 653.1 193.2, 653.1 194.2 Q 653.1 195.3, 652.6 195.9 Q 652.0 196.5, 651.1 196.5 Q 650.1 196.5, 649.6 195.9 Q 649.1 195.3, 649.1 194.2 M 651.1 196.0 Q 651.8 196.0, 652.1 195.5 Q 652.5 195.1, 652.5 194.2 Q 652.5 193.4, 652.1 192.9 Q 651.8 192.5, 651.1 192.5 Q 650.4 192.5, 650.1 192.9 Q 649.7 193.3, 649.7 194.2 Q 649.7 195.1, 650.1 195.5 Q 650.4 196.0, 651.1 196.0 \" fill=\"#FF0000\"/>\n<path class=\"atom-8\" d=\"M 673.9 204.1 L 675.4 206.4 Q 675.5 206.7, 675.7 207.1 Q 675.9 207.5, 676.0 207.5 L 676.0 204.1 L 676.5 204.1 L 676.5 208.5 L 675.9 208.5 L 674.4 206.0 Q 674.2 205.7, 674.0 205.3 Q 673.9 205.0, 673.8 204.9 L 673.8 208.5 L 673.2 208.5 L 673.2 204.1 L 673.9 204.1 \" fill=\"#0000FF\"/>\n<path class=\"atom-13\" d=\"M 728.5 214.6 L 729.9 216.9 Q 730.1 217.1, 730.3 217.6 Q 730.5 218.0, 730.5 218.0 L 730.5 214.6 L 731.1 214.6 L 731.1 219.0 L 730.5 219.0 L 729.0 216.4 Q 728.8 216.1, 728.6 215.8 Q 728.4 215.5, 728.4 215.4 L 728.4 219.0 L 727.8 219.0 L 727.8 214.6 L 728.5 214.6 \" fill=\"#0000FF\"/>\n<path class=\"atom-16\" d=\"M 744.3 242.6 Q 744.3 241.6, 744.8 241.0 Q 745.3 240.4, 746.3 240.4 Q 747.2 240.4, 747.7 241.0 Q 748.3 241.6, 748.3 242.6 Q 748.3 243.7, 747.7 244.3 Q 747.2 244.9, 746.3 244.9 Q 745.3 244.9, 744.8 244.3 Q 744.3 243.7, 744.3 242.6 M 746.3 244.4 Q 746.9 244.4, 747.3 244.0 Q 747.6 243.5, 747.6 242.6 Q 747.6 241.8, 747.3 241.4 Q 746.9 240.9, 746.3 240.9 Q 745.6 240.9, 745.2 241.4 Q 744.9 241.8, 744.9 242.6 Q 744.9 243.5, 745.2 244.0 Q 745.6 244.4, 746.3 244.4 \" fill=\"#FF0000\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 63.9,309.9 L 66.3,315.7\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 66.3,315.7 L 68.8,321.5\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-1 atom-1 atom-2\" d=\"M 72.0,324.3 L 78.6,325.1\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-1 atom-1 atom-2\" d=\"M 78.6,325.1 L 85.2,325.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-2 atom-1 atom-3\" d=\"M 68.0,326.6 L 64.3,331.5\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-2 atom-1 atom-3\" d=\"M 64.3,331.5 L 60.7,336.4\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-3 atom-3 atom-4\" d=\"M 60.7,336.4 L 66.8,350.6\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-4 atom-4 atom-5\" d=\"M 66.8,350.6 L 82.1,352.4\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-20 atom-20 atom-4\" d=\"M 57.5,362.9 L 66.8,350.6\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-5 atom-5 atom-6\" d=\"M 82.1,352.4 L 88.1,366.5\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-6 atom-6 atom-7\" d=\"M 88.1,366.5 L 84.5,371.4\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-6 atom-6 atom-7\" d=\"M 84.5,371.4 L 80.8,376.3\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-7 atom-7 atom-8\" d=\"M 80.0,381.5 L 82.5,387.3\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-7 atom-7 atom-8\" d=\"M 82.5,387.3 L 85.0,393.1\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-18 atom-7 atom-19\" d=\"M 76.9,378.6 L 70.2,377.9\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-18 atom-7 atom-19\" d=\"M 70.2,377.9 L 63.6,377.1\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-8 atom-8 atom-9\" d=\"M 83.7,392.1 L 80.1,397.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-8 atom-8 atom-9\" d=\"M 80.1,397.0 L 76.5,401.9\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-8 atom-8 atom-9\" d=\"M 86.2,394.0 L 82.6,398.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-8 atom-8 atom-9\" d=\"M 82.6,398.9 L 78.9,403.7\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-9 atom-8 atom-10\" d=\"M 85.0,393.1 L 91.6,393.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-9 atom-8 atom-10\" d=\"M 91.6,393.8 L 98.2,394.6\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-10 atom-10 atom-11\" d=\"M 102.2,392.3 L 105.9,387.4\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-10 atom-10 atom-11\" d=\"M 105.9,387.4 L 109.5,382.5\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-11 atom-11 atom-12\" d=\"M 109.5,382.5 L 124.8,384.4\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-11 atom-11 atom-12\" d=\"M 112.2,379.8 L 122.9,381.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-21 atom-18 atom-11\" d=\"M 103.4,368.4 L 109.5,382.5\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-12 atom-12 atom-13\" d=\"M 124.8,384.4 L 134.1,372.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-13 atom-13 atom-14\" d=\"M 134.1,372.0 L 128.0,357.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-13 atom-13 atom-14\" d=\"M 130.3,371.1 L 126.1,361.2\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-14 atom-14 atom-15\" d=\"M 128.0,357.9 L 131.6,353.1\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-14 atom-14 atom-15\" d=\"M 131.6,353.1 L 135.1,348.3\" style=\"fill:none;fill-rule:evenodd;stroke:#00CC00;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-15 atom-14 atom-16\" d=\"M 128.0,357.9 L 112.7,356.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-16 atom-16 atom-17\" d=\"M 112.7,356.0 L 110.0,349.7\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-16 atom-16 atom-17\" d=\"M 110.0,349.7 L 107.3,343.4\" style=\"fill:none;fill-rule:evenodd;stroke:#00CC00;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-17 atom-16 atom-18\" d=\"M 112.7,356.0 L 103.4,368.4\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-17 atom-16 atom-18\" d=\"M 113.8,359.7 L 107.3,368.4\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-19 atom-19 atom-20\" d=\"M 63.6,377.1 L 57.5,362.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"atom-1\" d=\"M 69.0 321.9 L 70.4 324.2 Q 70.5 324.4, 70.8 324.8 Q 71.0 325.2, 71.0 325.3 L 71.0 321.9 L 71.6 321.9 L 71.6 326.2 L 71.0 326.2 L 69.4 323.7 Q 69.3 323.4, 69.1 323.1 Q 68.9 322.7, 68.8 322.6 L 68.8 326.2 L 68.3 326.2 L 68.3 321.9 L 69.0 321.9 \" fill=\"#0000FF\"/>\n<path class=\"atom-7\" d=\"M 77.9 376.7 L 79.4 379.0 Q 79.5 379.2, 79.7 379.7 Q 80.0 380.1, 80.0 380.1 L 80.0 376.7 L 80.6 376.7 L 80.6 381.1 L 80.0 381.1 L 78.4 378.5 Q 78.3 378.2, 78.1 377.9 Q 77.9 377.6, 77.8 377.5 L 77.8 381.1 L 77.3 381.1 L 77.3 376.7 L 77.9 376.7 \" fill=\"#0000FF\"/>\n<path class=\"atom-9\" d=\"M 73.7 405.4 Q 73.7 404.4, 74.3 403.8 Q 74.8 403.2, 75.7 403.2 Q 76.7 403.2, 77.2 403.8 Q 77.7 404.4, 77.7 405.4 Q 77.7 406.5, 77.2 407.1 Q 76.7 407.7, 75.7 407.7 Q 74.8 407.7, 74.3 407.1 Q 73.7 406.5, 73.7 405.4 M 75.7 407.2 Q 76.4 407.2, 76.8 406.7 Q 77.1 406.3, 77.1 405.4 Q 77.1 404.6, 76.8 404.1 Q 76.4 403.7, 75.7 403.7 Q 75.1 403.7, 74.7 404.1 Q 74.4 404.5, 74.4 405.4 Q 74.4 406.3, 74.7 406.7 Q 75.1 407.2, 75.7 407.2 \" fill=\"#FF0000\"/>\n<path class=\"atom-10\" d=\"M 99.3 392.7 L 100.7 395.0 Q 100.9 395.2, 101.1 395.7 Q 101.3 396.1, 101.4 396.1 L 101.4 392.7 L 101.9 392.7 L 101.9 397.1 L 101.3 397.1 L 99.8 394.5 Q 99.6 394.2, 99.4 393.9 Q 99.3 393.6, 99.2 393.5 L 99.2 397.1 L 98.6 397.1 L 98.6 392.7 L 99.3 392.7 \" fill=\"#0000FF\"/>\n<path class=\"atom-10\" d=\"M 102.5 392.7 L 103.1 392.7 L 103.1 394.6 L 105.3 394.6 L 105.3 392.7 L 105.9 392.7 L 105.9 397.1 L 105.3 397.1 L 105.3 395.0 L 103.1 395.0 L 103.1 397.1 L 102.5 397.1 L 102.5 392.7 \" fill=\"#0000FF\"/>\n<path class=\"atom-15\" d=\"M 135.5 345.7 Q 135.5 344.6, 136.0 344.0 Q 136.6 343.4, 137.5 343.4 Q 138.4 343.4, 138.9 344.1 L 138.5 344.4 Q 138.1 343.9, 137.5 343.9 Q 136.9 343.9, 136.5 344.4 Q 136.2 344.8, 136.2 345.7 Q 136.2 346.5, 136.5 347.0 Q 136.9 347.4, 137.6 347.4 Q 138.1 347.4, 138.6 347.1 L 138.8 347.6 Q 138.6 347.7, 138.2 347.8 Q 137.9 347.9, 137.5 347.9 Q 136.6 347.9, 136.0 347.3 Q 135.5 346.8, 135.5 345.7 \" fill=\"#00CC00\"/>\n<path class=\"atom-15\" d=\"M 139.4 343.2 L 140.0 343.2 L 140.0 347.9 L 139.4 347.9 L 139.4 343.2 \" fill=\"#00CC00\"/>\n<path class=\"atom-17\" d=\"M 102.4 342.0 Q 102.4 340.9, 102.9 340.4 Q 103.4 339.8, 104.4 339.8 Q 105.3 339.8, 105.8 340.4 L 105.4 340.8 Q 105.0 340.3, 104.4 340.3 Q 103.8 340.3, 103.4 340.7 Q 103.1 341.2, 103.1 342.0 Q 103.1 342.9, 103.4 343.3 Q 103.8 343.8, 104.5 343.8 Q 105.0 343.8, 105.5 343.5 L 105.7 343.9 Q 105.5 344.1, 105.1 344.2 Q 104.8 344.3, 104.4 344.3 Q 103.4 344.3, 102.9 343.7 Q 102.4 343.1, 102.4 342.0 \" fill=\"#00CC00\"/>\n<path class=\"atom-17\" d=\"M 106.3 339.5 L 106.9 339.5 L 106.9 344.2 L 106.3 344.2 L 106.3 339.5 \" fill=\"#00CC00\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 308.5,408.0 L 305.1,402.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 305.1,402.9 L 301.8,397.7\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-1 atom-1 atom-2\" d=\"M 297.7,395.2 L 291.2,395.5\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-1 atom-1 atom-2\" d=\"M 291.2,395.5 L 284.7,395.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-2 atom-2 atom-3\" d=\"M 284.7,395.9 L 277.7,409.6\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-2 atom-2 atom-3\" d=\"M 280.9,396.6 L 276.0,406.2\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-23 atom-23 atom-2\" d=\"M 276.3,383.0 L 284.7,395.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-3 atom-3 atom-4\" d=\"M 277.7,409.6 L 262.3,410.4\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-4 atom-4 atom-5\" d=\"M 262.3,410.4 L 253.9,397.5\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-4 atom-4 atom-5\" d=\"M 263.6,406.8 L 257.8,397.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-5 atom-5 atom-6\" d=\"M 253.9,397.5 L 260.9,383.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-6 atom-6 atom-7\" d=\"M 260.9,383.8 L 257.5,378.6\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-6 atom-6 atom-7\" d=\"M 257.5,378.6 L 254.2,373.4\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-22 atom-6 atom-23\" d=\"M 260.9,383.8 L 276.3,383.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-22 atom-6 atom-23\" d=\"M 263.4,386.7 L 274.1,386.2\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-7 atom-7 atom-8\" d=\"M 253.8,368.3 L 256.7,362.7\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-7 atom-7 atom-8\" d=\"M 256.7,362.7 L 259.5,357.1\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-8 atom-8 atom-9\" d=\"M 260.8,356.3 L 257.5,351.1\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-8 atom-8 atom-9\" d=\"M 257.5,351.1 L 254.1,346.0\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-8 atom-8 atom-9\" d=\"M 258.2,358.0 L 254.9,352.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-8 atom-8 atom-9\" d=\"M 254.9,352.8 L 251.5,347.7\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-9 atom-8 atom-10\" d=\"M 259.5,357.1 L 266.2,356.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-9 atom-8 atom-10\" d=\"M 266.2,356.8 L 272.8,356.4\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-10 atom-10 atom-11\" d=\"M 276.6,358.9 L 279.9,364.1\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-10 atom-10 atom-11\" d=\"M 279.9,364.1 L 283.3,369.2\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-24 atom-22 atom-10\" d=\"M 281.9,342.6 L 279.0,348.2\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-24 atom-22 atom-10\" d=\"M 279.0,348.2 L 276.2,353.7\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-11 atom-11 atom-12\" d=\"M 283.3,369.2 L 298.7,368.4\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-12 atom-12 atom-13\" d=\"M 298.7,368.4 L 305.7,354.7\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-13 atom-13 atom-14\" d=\"M 305.7,354.7 L 321.1,353.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-20 atom-13 atom-21\" d=\"M 305.7,354.7 L 297.3,341.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-14 atom-14 atom-15\" d=\"M 321.1,353.9 L 324.4,359.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-14 atom-14 atom-15\" d=\"M 324.4,359.0 L 327.8,364.2\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-15 atom-15 atom-16\" d=\"M 328.2,369.4 L 325.3,374.9\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-15 atom-15 atom-16\" d=\"M 325.3,374.9 L 322.5,380.5\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-25 atom-20 atom-15\" d=\"M 344.9,366.0 L 338.2,366.3\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-25 atom-20 atom-15\" d=\"M 338.2,366.3 L 331.5,366.7\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-16 atom-16 atom-17\" d=\"M 322.5,380.5 L 330.9,393.4\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-17 atom-17 atom-18\" d=\"M 330.9,393.4 L 337.4,393.1\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-17 atom-17 atom-18\" d=\"M 337.4,393.1 L 343.9,392.8\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-18 atom-18 atom-19\" d=\"M 347.6,390.0 L 350.4,384.5\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-18 atom-18 atom-19\" d=\"M 350.4,384.5 L 353.3,378.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-19 atom-19 atom-20\" d=\"M 353.3,378.9 L 344.9,366.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-21 atom-21 atom-22\" d=\"M 297.3,341.8 L 281.9,342.6\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"atom-1\" d=\"M 298.1 395.1 Q 298.1 394.0, 298.6 393.5 Q 299.1 392.9, 300.1 392.9 Q 301.1 392.9, 301.6 393.5 Q 302.1 394.0, 302.1 395.1 Q 302.1 396.1, 301.6 396.8 Q 301.0 397.4, 300.1 397.4 Q 299.1 397.4, 298.6 396.8 Q 298.1 396.2, 298.1 395.1 M 300.1 396.9 Q 300.8 396.9, 301.1 396.4 Q 301.5 396.0, 301.5 395.1 Q 301.5 394.2, 301.1 393.8 Q 300.8 393.4, 300.1 393.4 Q 299.4 393.4, 299.1 393.8 Q 298.7 394.2, 298.7 395.1 Q 298.7 396.0, 299.1 396.4 Q 299.4 396.9, 300.1 396.9 \" fill=\"#FF0000\"/>\n<path class=\"atom-7\" d=\"M 246.9 368.7 L 247.5 368.7 L 247.5 370.5 L 249.7 370.5 L 249.7 368.7 L 250.3 368.7 L 250.3 373.0 L 249.7 373.0 L 249.7 371.0 L 247.5 371.0 L 247.5 373.0 L 246.9 373.0 L 246.9 368.7 \" fill=\"#0000FF\"/>\n<path class=\"atom-7\" d=\"M 251.5 368.7 L 253.0 371.0 Q 253.1 371.2, 253.3 371.6 Q 253.6 372.0, 253.6 372.1 L 253.6 368.7 L 254.2 368.7 L 254.2 373.0 L 253.6 373.0 L 252.0 370.5 Q 251.8 370.2, 251.7 369.9 Q 251.5 369.5, 251.4 369.4 L 251.4 373.0 L 250.8 373.0 L 250.8 368.7 L 251.5 368.7 \" fill=\"#0000FF\"/>\n<path class=\"atom-9\" d=\"M 249.1 344.2 Q 249.1 343.2, 249.6 342.6 Q 250.1 342.0, 251.1 342.0 Q 252.1 342.0, 252.6 342.6 Q 253.1 343.2, 253.1 344.2 Q 253.1 345.3, 252.6 345.9 Q 252.0 346.5, 251.1 346.5 Q 250.1 346.5, 249.6 345.9 Q 249.1 345.3, 249.1 344.2 M 251.1 346.0 Q 251.8 346.0, 252.1 345.5 Q 252.5 345.1, 252.5 344.2 Q 252.5 343.4, 252.1 342.9 Q 251.8 342.5, 251.1 342.5 Q 250.4 342.5, 250.1 342.9 Q 249.7 343.3, 249.7 344.2 Q 249.7 345.1, 250.1 345.5 Q 250.4 346.0, 251.1 346.0 \" fill=\"#FF0000\"/>\n<path class=\"atom-10\" d=\"M 273.9 354.1 L 275.4 356.4 Q 275.5 356.7, 275.7 357.1 Q 275.9 357.5, 276.0 357.5 L 276.0 354.1 L 276.5 354.1 L 276.5 358.5 L 275.9 358.5 L 274.4 356.0 Q 274.2 355.7, 274.0 355.3 Q 273.9 355.0, 273.8 354.9 L 273.8 358.5 L 273.2 358.5 L 273.2 354.1 L 273.9 354.1 \" fill=\"#0000FF\"/>\n<path class=\"atom-15\" d=\"M 328.5 364.6 L 329.9 366.9 Q 330.1 367.1, 330.3 367.6 Q 330.5 368.0, 330.5 368.0 L 330.5 364.6 L 331.1 364.6 L 331.1 369.0 L 330.5 369.0 L 329.0 366.4 Q 328.8 366.1, 328.6 365.8 Q 328.4 365.5, 328.4 365.4 L 328.4 369.0 L 327.8 369.0 L 327.8 364.6 L 328.5 364.6 \" fill=\"#0000FF\"/>\n<path class=\"atom-18\" d=\"M 344.3 392.6 Q 344.3 391.6, 344.8 391.0 Q 345.3 390.4, 346.3 390.4 Q 347.2 390.4, 347.7 391.0 Q 348.3 391.6, 348.3 392.6 Q 348.3 393.7, 347.7 394.3 Q 347.2 394.9, 346.3 394.9 Q 345.3 394.9, 344.8 394.3 Q 344.3 393.7, 344.3 392.6 M 346.3 394.4 Q 346.9 394.4, 347.3 394.0 Q 347.6 393.5, 347.6 392.6 Q 347.6 391.8, 347.3 391.4 Q 346.9 390.9, 346.3 390.9 Q 345.6 390.9, 345.2 391.4 Q 344.9 391.8, 344.9 392.6 Q 344.9 393.5, 345.2 394.0 Q 345.6 394.4, 346.3 394.4 \" fill=\"#FF0000\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 486.1,422.5 L 477.7,409.6\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-1 atom-1 atom-2\" d=\"M 477.7,409.6 L 462.3,410.4\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-1 atom-1 atom-2\" d=\"M 475.2,406.7 L 464.5,407.2\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-23 atom-22 atom-1\" d=\"M 484.7,395.9 L 477.7,409.6\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-2 atom-2 atom-3\" d=\"M 462.3,410.4 L 453.9,397.5\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-3 atom-3 atom-4\" d=\"M 453.9,397.5 L 460.9,383.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-3 atom-3 atom-4\" d=\"M 457.7,396.9 L 462.6,387.2\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-4 atom-4 atom-5\" d=\"M 460.9,383.8 L 457.5,378.6\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-4 atom-4 atom-5\" d=\"M 457.5,378.6 L 454.2,373.4\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-20 atom-4 atom-21\" d=\"M 460.9,383.8 L 476.3,383.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-5 atom-5 atom-6\" d=\"M 453.8,368.3 L 456.7,362.7\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-5 atom-5 atom-6\" d=\"M 456.7,362.7 L 459.5,357.1\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-6 atom-6 atom-7\" d=\"M 460.8,356.3 L 457.5,351.1\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-6 atom-6 atom-7\" d=\"M 457.5,351.1 L 454.1,346.0\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-6 atom-6 atom-7\" d=\"M 458.2,358.0 L 454.9,352.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-6 atom-6 atom-7\" d=\"M 454.9,352.8 L 451.5,347.7\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-7 atom-6 atom-8\" d=\"M 459.5,357.1 L 466.2,356.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-7 atom-6 atom-8\" d=\"M 466.2,356.8 L 472.8,356.4\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-8 atom-8 atom-9\" d=\"M 476.6,358.9 L 479.9,364.1\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-8 atom-8 atom-9\" d=\"M 479.9,364.1 L 483.3,369.2\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-24 atom-20 atom-8\" d=\"M 481.9,342.6 L 479.0,348.2\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-24 atom-20 atom-8\" d=\"M 479.0,348.2 L 476.2,353.7\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-9 atom-9 atom-10\" d=\"M 483.3,369.2 L 498.7,368.4\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-10 atom-10 atom-11\" d=\"M 498.7,368.4 L 505.7,354.7\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-11 atom-11 atom-12\" d=\"M 505.7,354.7 L 521.1,353.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-18 atom-11 atom-19\" d=\"M 505.7,354.7 L 497.3,341.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-12 atom-12 atom-13\" d=\"M 521.1,353.9 L 524.4,359.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-12 atom-12 atom-13\" d=\"M 524.4,359.0 L 527.8,364.2\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-13 atom-13 atom-14\" d=\"M 528.2,369.4 L 525.3,374.9\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-13 atom-13 atom-14\" d=\"M 525.3,374.9 L 522.5,380.5\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-25 atom-18 atom-13\" d=\"M 544.9,366.0 L 538.2,366.3\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-25 atom-18 atom-13\" d=\"M 538.2,366.3 L 531.5,366.7\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-14 atom-14 atom-15\" d=\"M 522.5,380.5 L 530.9,393.4\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-15 atom-15 atom-16\" d=\"M 530.9,393.4 L 537.4,393.1\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-15 atom-15 atom-16\" d=\"M 537.4,393.1 L 543.9,392.8\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-16 atom-16 atom-17\" d=\"M 547.6,390.0 L 550.4,384.5\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-16 atom-16 atom-17\" d=\"M 550.4,384.5 L 553.3,378.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-17 atom-17 atom-18\" d=\"M 553.3,378.9 L 544.9,366.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-19 atom-19 atom-20\" d=\"M 497.3,341.8 L 481.9,342.6\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-21 atom-21 atom-22\" d=\"M 476.3,383.0 L 484.7,395.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-21 atom-21 atom-22\" d=\"M 475.0,386.6 L 480.8,395.6\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-22 atom-22 atom-23\" d=\"M 484.7,395.9 L 491.5,395.5\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-22 atom-22 atom-23\" d=\"M 491.5,395.5 L 498.4,395.2\" style=\"fill:none;fill-rule:evenodd;stroke:#33CCCC;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"atom-5\" d=\"M 446.9 368.7 L 447.5 368.7 L 447.5 370.5 L 449.7 370.5 L 449.7 368.7 L 450.3 368.7 L 450.3 373.0 L 449.7 373.0 L 449.7 371.0 L 447.5 371.0 L 447.5 373.0 L 446.9 373.0 L 446.9 368.7 \" fill=\"#0000FF\"/>\n<path class=\"atom-5\" d=\"M 451.5 368.7 L 453.0 371.0 Q 453.1 371.2, 453.3 371.6 Q 453.6 372.0, 453.6 372.1 L 453.6 368.7 L 454.2 368.7 L 454.2 373.0 L 453.6 373.0 L 452.0 370.5 Q 451.8 370.2, 451.7 369.9 Q 451.5 369.5, 451.4 369.4 L 451.4 373.0 L 450.8 373.0 L 450.8 368.7 L 451.5 368.7 \" fill=\"#0000FF\"/>\n<path class=\"atom-7\" d=\"M 449.1 344.2 Q 449.1 343.2, 449.6 342.6 Q 450.1 342.0, 451.1 342.0 Q 452.1 342.0, 452.6 342.6 Q 453.1 343.2, 453.1 344.2 Q 453.1 345.3, 452.6 345.9 Q 452.0 346.5, 451.1 346.5 Q 450.1 346.5, 449.6 345.9 Q 449.1 345.3, 449.1 344.2 M 451.1 346.0 Q 451.8 346.0, 452.1 345.5 Q 452.5 345.1, 452.5 344.2 Q 452.5 343.4, 452.1 342.9 Q 451.8 342.5, 451.1 342.5 Q 450.4 342.5, 450.1 342.9 Q 449.7 343.3, 449.7 344.2 Q 449.7 345.1, 450.1 345.5 Q 450.4 346.0, 451.1 346.0 \" fill=\"#FF0000\"/>\n<path class=\"atom-8\" d=\"M 473.9 354.1 L 475.4 356.4 Q 475.5 356.7, 475.7 357.1 Q 475.9 357.5, 476.0 357.5 L 476.0 354.1 L 476.5 354.1 L 476.5 358.5 L 475.9 358.5 L 474.4 356.0 Q 474.2 355.7, 474.0 355.3 Q 473.9 355.0, 473.8 354.9 L 473.8 358.5 L 473.2 358.5 L 473.2 354.1 L 473.9 354.1 \" fill=\"#0000FF\"/>\n<path class=\"atom-13\" d=\"M 528.5 364.6 L 529.9 366.9 Q 530.1 367.1, 530.3 367.6 Q 530.5 368.0, 530.5 368.0 L 530.5 364.6 L 531.1 364.6 L 531.1 369.0 L 530.5 369.0 L 529.0 366.4 Q 528.8 366.1, 528.6 365.8 Q 528.4 365.5, 528.4 365.4 L 528.4 369.0 L 527.8 369.0 L 527.8 364.6 L 528.5 364.6 \" fill=\"#0000FF\"/>\n<path class=\"atom-16\" d=\"M 544.3 392.6 Q 544.3 391.6, 544.8 391.0 Q 545.3 390.4, 546.3 390.4 Q 547.2 390.4, 547.7 391.0 Q 548.3 391.6, 548.3 392.6 Q 548.3 393.7, 547.7 394.3 Q 547.2 394.9, 546.3 394.9 Q 545.3 394.9, 544.8 394.3 Q 544.3 393.7, 544.3 392.6 M 546.3 394.4 Q 546.9 394.4, 547.3 394.0 Q 547.6 393.5, 547.6 392.6 Q 547.6 391.8, 547.3 391.4 Q 546.9 390.9, 546.3 390.9 Q 545.6 390.9, 545.2 391.4 Q 544.9 391.8, 544.9 392.6 Q 544.9 393.5, 545.2 394.0 Q 545.6 394.4, 546.3 394.4 \" fill=\"#FF0000\"/>\n<path class=\"atom-23\" d=\"M 498.8 392.9 L 501.4 392.9 L 501.4 393.4 L 499.4 393.4 L 499.4 394.7 L 501.2 394.7 L 501.2 395.2 L 499.4 395.2 L 499.4 397.3 L 498.8 397.3 L 498.8 392.9 \" fill=\"#33CCCC\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 737.2,345.5 L 728.0,357.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-1 atom-1 atom-2\" d=\"M 728.0,357.9 L 734.1,372.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-1 atom-1 atom-2\" d=\"M 726.1,361.2 L 730.3,371.1\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-20 atom-20 atom-1\" d=\"M 712.7,356.0 L 728.0,357.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-2 atom-2 atom-3\" d=\"M 734.1,372.0 L 724.8,384.4\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-3 atom-3 atom-4\" d=\"M 724.8,384.4 L 709.5,382.5\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-3 atom-3 atom-4\" d=\"M 722.9,381.0 L 712.2,379.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-4 atom-4 atom-5\" d=\"M 709.5,382.5 L 705.9,387.4\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-4 atom-4 atom-5\" d=\"M 705.9,387.4 L 702.2,392.3\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-18 atom-4 atom-19\" d=\"M 709.5,382.5 L 703.4,368.4\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-5 atom-5 atom-6\" d=\"M 698.2,394.6 L 691.6,393.8\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-5 atom-5 atom-6\" d=\"M 691.6,393.8 L 685.0,393.1\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-6 atom-6 atom-7\" d=\"M 683.7,392.1 L 680.1,397.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-6 atom-6 atom-7\" d=\"M 680.1,397.0 L 676.5,401.9\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-6 atom-6 atom-7\" d=\"M 686.2,394.0 L 682.6,398.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-6 atom-6 atom-7\" d=\"M 682.6,398.9 L 678.9,403.7\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-7 atom-6 atom-8\" d=\"M 685.0,393.1 L 682.5,387.3\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-7 atom-6 atom-8\" d=\"M 682.5,387.3 L 680.0,381.5\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-8 atom-8 atom-9\" d=\"M 680.8,376.3 L 684.5,371.4\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-8 atom-8 atom-9\" d=\"M 684.5,371.4 L 688.1,366.5\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-21 atom-18 atom-8\" d=\"M 663.6,377.1 L 670.2,377.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-21 atom-18 atom-8\" d=\"M 670.2,377.9 L 676.9,378.6\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-9 atom-9 atom-10\" d=\"M 688.1,366.5 L 682.1,352.4\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-10 atom-10 atom-11\" d=\"M 682.1,352.4 L 666.8,350.6\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-11 atom-11 atom-12\" d=\"M 666.8,350.6 L 660.7,336.4\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-16 atom-11 atom-17\" d=\"M 666.8,350.6 L 657.5,362.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-12 atom-12 atom-13\" d=\"M 660.9,334.9 L 654.4,334.1\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-12 atom-12 atom-13\" d=\"M 654.4,334.1 L 648.0,333.3\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-12 atom-12 atom-13\" d=\"M 660.5,337.9 L 654.1,337.1\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-12 atom-12 atom-13\" d=\"M 654.1,337.1 L 647.6,336.4\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-13 atom-12 atom-14\" d=\"M 660.7,336.4 L 664.3,331.5\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-13 atom-12 atom-14\" d=\"M 664.3,331.5 L 668.0,326.6\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-14 atom-14 atom-15\" d=\"M 668.8,321.5 L 666.3,315.7\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-14 atom-14 atom-15\" d=\"M 666.3,315.7 L 663.9,309.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-15 atom-14 atom-16\" d=\"M 672.0,324.3 L 678.6,325.1\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-15 atom-14 atom-16\" d=\"M 678.6,325.1 L 685.2,325.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-17 atom-17 atom-18\" d=\"M 657.5,362.9 L 663.6,377.1\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-19 atom-19 atom-20\" d=\"M 703.4,368.4 L 712.7,356.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-19 atom-19 atom-20\" d=\"M 707.3,368.4 L 713.8,359.7\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"atom-5\" d=\"M 699.3 392.7 L 700.7 395.0 Q 700.9 395.2, 701.1 395.7 Q 701.3 396.1, 701.4 396.1 L 701.4 392.7 L 701.9 392.7 L 701.9 397.1 L 701.3 397.1 L 699.8 394.5 Q 699.6 394.2, 699.4 393.9 Q 699.3 393.6, 699.2 393.5 L 699.2 397.1 L 698.6 397.1 L 698.6 392.7 L 699.3 392.7 \" fill=\"#0000FF\"/>\n<path class=\"atom-5\" d=\"M 702.5 392.7 L 703.1 392.7 L 703.1 394.6 L 705.3 394.6 L 705.3 392.7 L 705.9 392.7 L 705.9 397.1 L 705.3 397.1 L 705.3 395.0 L 703.1 395.0 L 703.1 397.1 L 702.5 397.1 L 702.5 392.7 \" fill=\"#0000FF\"/>\n<path class=\"atom-7\" d=\"M 673.7 405.4 Q 673.7 404.4, 674.3 403.8 Q 674.8 403.2, 675.7 403.2 Q 676.7 403.2, 677.2 403.8 Q 677.7 404.4, 677.7 405.4 Q 677.7 406.5, 677.2 407.1 Q 676.7 407.7, 675.7 407.7 Q 674.8 407.7, 674.3 407.1 Q 673.7 406.5, 673.7 405.4 M 675.7 407.2 Q 676.4 407.2, 676.8 406.7 Q 677.1 406.3, 677.1 405.4 Q 677.1 404.6, 676.8 404.1 Q 676.4 403.7, 675.7 403.7 Q 675.1 403.7, 674.7 404.1 Q 674.4 404.5, 674.4 405.4 Q 674.4 406.3, 674.7 406.7 Q 675.1 407.2, 675.7 407.2 \" fill=\"#FF0000\"/>\n<path class=\"atom-8\" d=\"M 677.9 376.7 L 679.4 379.0 Q 679.5 379.2, 679.7 379.7 Q 680.0 380.1, 680.0 380.1 L 680.0 376.7 L 680.6 376.7 L 680.6 381.1 L 680.0 381.1 L 678.4 378.5 Q 678.3 378.2, 678.1 377.9 Q 677.9 377.6, 677.8 377.5 L 677.8 381.1 L 677.3 381.1 L 677.3 376.7 L 677.9 376.7 \" fill=\"#0000FF\"/>\n<path class=\"atom-13\" d=\"M 643.4 334.6 Q 643.4 333.5, 643.9 332.9 Q 644.4 332.4, 645.4 332.4 Q 646.4 332.4, 646.9 332.9 Q 647.4 333.5, 647.4 334.6 Q 647.4 335.6, 646.9 336.2 Q 646.3 336.8, 645.4 336.8 Q 644.4 336.8, 643.9 336.2 Q 643.4 335.6, 643.4 334.6 M 645.4 336.3 Q 646.1 336.3, 646.4 335.9 Q 646.8 335.5, 646.8 334.6 Q 646.8 333.7, 646.4 333.3 Q 646.1 332.8, 645.4 332.8 Q 644.7 332.8, 644.4 333.3 Q 644.0 333.7, 644.0 334.6 Q 644.0 335.5, 644.4 335.9 Q 644.7 336.3, 645.4 336.3 \" fill=\"#FF0000\"/>\n<path class=\"atom-14\" d=\"M 669.0 321.9 L 670.4 324.2 Q 670.5 324.4, 670.8 324.8 Q 671.0 325.2, 671.0 325.3 L 671.0 321.9 L 671.6 321.9 L 671.6 326.2 L 671.0 326.2 L 669.4 323.7 Q 669.3 323.4, 669.1 323.1 Q 668.9 322.7, 668.8 322.6 L 668.8 326.2 L 668.3 326.2 L 668.3 321.9 L 669.0 321.9 \" fill=\"#0000FF\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 137.5,553.1 L 134.0,548.0\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 134.0,548.0 L 130.6,542.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 134.9,554.8 L 131.5,549.7\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 131.5,549.7 L 128.0,544.6\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-1 atom-1 atom-2\" d=\"M 129.3,543.8 L 132.0,538.1\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-1 atom-1 atom-2\" d=\"M 132.0,538.1 L 134.8,532.5\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-11 atom-1 atom-12\" d=\"M 129.3,543.8 L 122.6,544.2\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-11 atom-1 atom-12\" d=\"M 122.6,544.2 L 116.0,544.7\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-2 atom-2 atom-3\" d=\"M 134.3,527.3 L 130.9,522.2\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-2 atom-2 atom-3\" d=\"M 130.9,522.2 L 127.4,517.1\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-3 atom-3 atom-4\" d=\"M 127.4,517.1 L 134.1,503.3\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-3 atom-3 atom-4\" d=\"M 125.6,513.7 L 130.4,504.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-24 atom-11 atom-3\" d=\"M 112.0,518.2 L 127.4,517.1\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-4 atom-4 atom-5\" d=\"M 134.1,503.3 L 125.5,490.5\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-5 atom-5 atom-6\" d=\"M 125.5,490.5 L 110.1,491.6\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-5 atom-5 atom-6\" d=\"M 123.4,493.7 L 112.7,494.5\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-6 atom-6 atom-7\" d=\"M 110.1,491.6 L 105.8,487.4\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-6 atom-6 atom-7\" d=\"M 105.8,487.4 L 101.4,483.2\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-26 atom-10 atom-6\" d=\"M 103.4,505.5 L 110.1,491.6\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-7 atom-7 atom-8\" d=\"M 96.7,482.2 L 91.0,485.2\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-7 atom-7 atom-8\" d=\"M 91.0,485.2 L 85.4,488.2\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-8 atom-8 atom-9\" d=\"M 85.4,488.2 L 86.6,494.4\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-8 atom-8 atom-9\" d=\"M 86.6,494.4 L 87.7,500.7\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-9 atom-9 atom-10\" d=\"M 90.5,503.7 L 97.0,504.6\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-9 atom-9 atom-10\" d=\"M 97.0,504.6 L 103.4,505.5\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-10 atom-10 atom-11\" d=\"M 103.4,505.5 L 112.0,518.2\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-10 atom-10 atom-11\" d=\"M 107.2,505.6 L 113.3,514.6\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-12 atom-12 atom-13\" d=\"M 112.2,542.3 L 108.7,537.2\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-12 atom-12 atom-13\" d=\"M 108.7,537.2 L 105.3,532.1\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-25 atom-24 atom-12\" d=\"M 107.2,558.7 L 109.9,553.1\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-25 atom-24 atom-12\" d=\"M 109.9,553.1 L 112.7,547.4\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-13 atom-13 atom-14\" d=\"M 105.3,532.1 L 89.9,533.2\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-14 atom-14 atom-15\" d=\"M 89.9,533.2 L 83.2,547.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-15 atom-15 atom-16\" d=\"M 83.2,547.0 L 67.8,548.1\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-22 atom-15 atom-23\" d=\"M 83.2,547.0 L 91.8,559.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-16 atom-16 atom-17\" d=\"M 67.8,548.1 L 64.4,543.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-16 atom-16 atom-17\" d=\"M 64.4,543.0 L 60.9,537.9\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-17 atom-17 atom-18\" d=\"M 60.4,532.8 L 63.2,527.1\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-17 atom-17 atom-18\" d=\"M 63.2,527.1 L 65.9,521.5\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-27 atom-22 atom-17\" d=\"M 43.8,536.5 L 50.5,536.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-27 atom-22 atom-17\" d=\"M 50.5,536.0 L 57.1,535.5\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-18 atom-18 atom-19\" d=\"M 65.9,521.5 L 57.3,508.7\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-19 atom-19 atom-20\" d=\"M 57.3,508.7 L 50.8,509.2\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-19 atom-19 atom-20\" d=\"M 50.8,509.2 L 44.3,509.7\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-20 atom-20 atom-21\" d=\"M 40.6,512.5 L 37.9,518.1\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-20 atom-20 atom-21\" d=\"M 37.9,518.1 L 35.2,523.7\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-21 atom-21 atom-22\" d=\"M 35.2,523.7 L 43.8,536.5\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-23 atom-23 atom-24\" d=\"M 91.8,559.8 L 107.2,558.7\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"atom-0\" d=\"M 135.9 556.5 Q 135.9 555.5, 136.5 554.9 Q 137.0 554.3, 137.9 554.3 Q 138.9 554.3, 139.4 554.9 Q 139.9 555.5, 139.9 556.5 Q 139.9 557.6, 139.4 558.2 Q 138.9 558.8, 137.9 558.8 Q 137.0 558.8, 136.5 558.2 Q 135.9 557.6, 135.9 556.5 M 137.9 558.3 Q 138.6 558.3, 139.0 557.9 Q 139.3 557.4, 139.3 556.5 Q 139.3 555.7, 139.0 555.2 Q 138.6 554.8, 137.9 554.8 Q 137.3 554.8, 136.9 555.2 Q 136.5 555.7, 136.5 556.5 Q 136.5 557.4, 136.9 557.9 Q 137.3 558.3, 137.9 558.3 \" fill=\"#FF0000\"/>\n<path class=\"atom-2\" d=\"M 135.1 527.7 L 136.5 530.0 Q 136.6 530.3, 136.9 530.7 Q 137.1 531.1, 137.1 531.1 L 137.1 527.7 L 137.7 527.7 L 137.7 532.1 L 137.1 532.1 L 135.6 529.5 Q 135.4 529.3, 135.2 528.9 Q 135.0 528.6, 135.0 528.5 L 135.0 532.1 L 134.4 532.1 L 134.4 527.7 L 135.1 527.7 \" fill=\"#0000FF\"/>\n<path class=\"atom-2\" d=\"M 138.2 527.7 L 138.8 527.7 L 138.8 529.6 L 141.0 529.6 L 141.0 527.7 L 141.6 527.7 L 141.6 532.1 L 141.0 532.1 L 141.0 530.1 L 138.8 530.1 L 138.8 532.1 L 138.2 532.1 L 138.2 527.7 \" fill=\"#0000FF\"/>\n<path class=\"atom-7\" d=\"M 97.0 480.9 Q 97.0 479.9, 97.6 479.3 Q 98.1 478.7, 99.0 478.7 Q 100.0 478.7, 100.5 479.3 Q 101.0 479.9, 101.0 480.9 Q 101.0 482.0, 100.5 482.6 Q 100.0 483.2, 99.0 483.2 Q 98.1 483.2, 97.6 482.6 Q 97.0 482.0, 97.0 480.9 M 99.0 482.7 Q 99.7 482.7, 100.1 482.2 Q 100.4 481.8, 100.4 480.9 Q 100.4 480.1, 100.1 479.6 Q 99.7 479.2, 99.0 479.2 Q 98.4 479.2, 98.0 479.6 Q 97.7 480.0, 97.7 480.9 Q 97.7 481.8, 98.0 482.2 Q 98.4 482.7, 99.0 482.7 \" fill=\"#FF0000\"/>\n<path class=\"atom-9\" d=\"M 86.1 503.3 Q 86.1 502.3, 86.6 501.7 Q 87.2 501.1, 88.1 501.1 Q 89.1 501.1, 89.6 501.7 Q 90.1 502.3, 90.1 503.3 Q 90.1 504.4, 89.6 505.0 Q 89.1 505.6, 88.1 505.6 Q 87.2 505.6, 86.6 505.0 Q 86.1 504.4, 86.1 503.3 M 88.1 505.1 Q 88.8 505.1, 89.2 504.7 Q 89.5 504.2, 89.5 503.3 Q 89.5 502.5, 89.2 502.1 Q 88.8 501.6, 88.1 501.6 Q 87.5 501.6, 87.1 502.0 Q 86.7 502.5, 86.7 503.3 Q 86.7 504.2, 87.1 504.7 Q 87.5 505.1, 88.1 505.1 \" fill=\"#FF0000\"/>\n<path class=\"atom-12\" d=\"M 113.0 542.7 L 114.4 545.0 Q 114.5 545.2, 114.8 545.6 Q 115.0 546.0, 115.0 546.1 L 115.0 542.7 L 115.6 542.7 L 115.6 547.0 L 115.0 547.0 L 113.4 544.5 Q 113.3 544.2, 113.1 543.9 Q 112.9 543.5, 112.8 543.4 L 112.8 547.0 L 112.3 547.0 L 112.3 542.7 L 113.0 542.7 \" fill=\"#0000FF\"/>\n<path class=\"atom-17\" d=\"M 58.2 533.2 L 59.6 535.5 Q 59.8 535.7, 60.0 536.1 Q 60.2 536.5, 60.2 536.6 L 60.2 533.2 L 60.8 533.2 L 60.8 537.5 L 60.2 537.5 L 58.7 535.0 Q 58.5 534.7, 58.3 534.4 Q 58.1 534.0, 58.1 533.9 L 58.1 537.5 L 57.5 537.5 L 57.5 533.2 L 58.2 533.2 \" fill=\"#0000FF\"/>\n<path class=\"atom-20\" d=\"M 39.9 509.8 Q 39.9 508.8, 40.4 508.2 Q 40.9 507.6, 41.9 507.6 Q 42.9 507.6, 43.4 508.2 Q 43.9 508.8, 43.9 509.8 Q 43.9 510.9, 43.4 511.5 Q 42.9 512.1, 41.9 512.1 Q 40.9 512.1, 40.4 511.5 Q 39.9 510.9, 39.9 509.8 M 41.9 511.6 Q 42.6 511.6, 42.9 511.2 Q 43.3 510.7, 43.3 509.8 Q 43.3 509.0, 42.9 508.6 Q 42.6 508.1, 41.9 508.1 Q 41.2 508.1, 40.9 508.5 Q 40.5 509.0, 40.5 509.8 Q 40.5 510.7, 40.9 511.2 Q 41.2 511.6, 41.9 511.6 \" fill=\"#FF0000\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 220.9,495.1 L 236.2,496.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-1 atom-1 atom-2\" d=\"M 236.2,496.9 L 238.6,502.7\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-1 atom-1 atom-2\" d=\"M 238.6,502.7 L 241.1,508.5\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-2 atom-2 atom-3\" d=\"M 244.6,511.4 L 251.1,512.1\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-2 atom-2 atom-3\" d=\"M 251.1,512.1 L 257.5,512.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-3 atom-3 atom-4\" d=\"M 257.5,512.9 L 266.8,500.6\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-20 atom-20 atom-3\" d=\"M 263.6,527.1 L 257.5,512.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-4 atom-4 atom-5\" d=\"M 266.8,500.6 L 282.1,502.4\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-5 atom-5 atom-6\" d=\"M 282.1,502.4 L 288.1,516.5\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-6 atom-6 atom-7\" d=\"M 288.1,516.5 L 284.5,521.4\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-6 atom-6 atom-7\" d=\"M 284.5,521.4 L 280.8,526.3\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-7 atom-7 atom-8\" d=\"M 280.0,531.5 L 282.5,537.3\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-7 atom-7 atom-8\" d=\"M 282.5,537.3 L 285.0,543.1\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-19 atom-7 atom-20\" d=\"M 276.9,528.6 L 270.2,527.9\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-19 atom-7 atom-20\" d=\"M 270.2,527.9 L 263.6,527.1\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-8 atom-8 atom-9\" d=\"M 283.7,542.1 L 280.1,547.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-8 atom-8 atom-9\" d=\"M 280.1,547.0 L 276.5,551.9\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-8 atom-8 atom-9\" d=\"M 286.2,544.0 L 282.6,548.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-8 atom-8 atom-9\" d=\"M 282.6,548.9 L 278.9,553.7\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-9 atom-8 atom-10\" d=\"M 285.0,543.1 L 291.6,543.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-9 atom-8 atom-10\" d=\"M 291.6,543.8 L 298.2,544.6\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-10 atom-10 atom-11\" d=\"M 302.2,542.3 L 305.9,537.4\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-10 atom-10 atom-11\" d=\"M 305.9,537.4 L 309.5,532.5\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-11 atom-11 atom-12\" d=\"M 309.5,532.5 L 324.8,534.4\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-11 atom-11 atom-12\" d=\"M 312.2,529.8 L 322.9,531.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-21 atom-18 atom-11\" d=\"M 303.4,518.4 L 309.5,532.5\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-12 atom-12 atom-13\" d=\"M 324.8,534.4 L 330.9,548.5\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-13 atom-12 atom-14\" d=\"M 324.8,534.4 L 334.1,522.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-14 atom-14 atom-15\" d=\"M 334.1,522.0 L 328.0,507.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-14 atom-14 atom-15\" d=\"M 330.3,521.1 L 326.1,511.2\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-15 atom-15 atom-16\" d=\"M 328.0,507.9 L 337.2,495.5\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-16 atom-15 atom-17\" d=\"M 328.0,507.9 L 312.7,506.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-17 atom-17 atom-18\" d=\"M 312.7,506.0 L 303.4,518.4\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-17 atom-17 atom-18\" d=\"M 313.8,509.7 L 307.3,518.4\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-18 atom-18 atom-19\" d=\"M 303.4,518.4 L 299.9,517.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-18 atom-18 atom-19\" d=\"M 299.9,517.0 L 296.3,515.6\" style=\"fill:none;fill-rule:evenodd;stroke:#00CC00;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"atom-2\" d=\"M 240.2 511.1 Q 240.2 510.0, 240.7 509.4 Q 241.3 508.9, 242.2 508.9 Q 243.2 508.9, 243.7 509.4 Q 244.2 510.0, 244.2 511.1 Q 244.2 512.1, 243.7 512.7 Q 243.2 513.3, 242.2 513.3 Q 241.3 513.3, 240.7 512.7 Q 240.2 512.1, 240.2 511.1 M 242.2 512.9 Q 242.9 512.9, 243.3 512.4 Q 243.6 512.0, 243.6 511.1 Q 243.6 510.2, 243.3 509.8 Q 242.9 509.4, 242.2 509.4 Q 241.6 509.4, 241.2 509.8 Q 240.8 510.2, 240.8 511.1 Q 240.8 512.0, 241.2 512.4 Q 241.6 512.9, 242.2 512.9 \" fill=\"#FF0000\"/>\n<path class=\"atom-7\" d=\"M 277.9 526.7 L 279.4 529.0 Q 279.5 529.2, 279.7 529.7 Q 280.0 530.1, 280.0 530.1 L 280.0 526.7 L 280.6 526.7 L 280.6 531.1 L 280.0 531.1 L 278.4 528.5 Q 278.3 528.2, 278.1 527.9 Q 277.9 527.6, 277.8 527.5 L 277.8 531.1 L 277.3 531.1 L 277.3 526.7 L 277.9 526.7 \" fill=\"#0000FF\"/>\n<path class=\"atom-9\" d=\"M 273.7 555.4 Q 273.7 554.4, 274.3 553.8 Q 274.8 553.2, 275.7 553.2 Q 276.7 553.2, 277.2 553.8 Q 277.7 554.4, 277.7 555.4 Q 277.7 556.5, 277.2 557.1 Q 276.7 557.7, 275.7 557.7 Q 274.8 557.7, 274.3 557.1 Q 273.7 556.5, 273.7 555.4 M 275.7 557.2 Q 276.4 557.2, 276.8 556.7 Q 277.1 556.3, 277.1 555.4 Q 277.1 554.6, 276.8 554.1 Q 276.4 553.7, 275.7 553.7 Q 275.1 553.7, 274.7 554.1 Q 274.4 554.5, 274.4 555.4 Q 274.4 556.3, 274.7 556.7 Q 275.1 557.2, 275.7 557.2 \" fill=\"#FF0000\"/>\n<path class=\"atom-10\" d=\"M 299.3 542.7 L 300.7 545.0 Q 300.9 545.2, 301.1 545.7 Q 301.3 546.1, 301.4 546.1 L 301.4 542.7 L 301.9 542.7 L 301.9 547.1 L 301.3 547.1 L 299.8 544.5 Q 299.6 544.2, 299.4 543.9 Q 299.3 543.6, 299.2 543.5 L 299.2 547.1 L 298.6 547.1 L 298.6 542.7 L 299.3 542.7 \" fill=\"#0000FF\"/>\n<path class=\"atom-10\" d=\"M 302.5 542.7 L 303.1 542.7 L 303.1 544.6 L 305.3 544.6 L 305.3 542.7 L 305.9 542.7 L 305.9 547.1 L 305.3 547.1 L 305.3 545.0 L 303.1 545.0 L 303.1 547.1 L 302.5 547.1 L 302.5 542.7 \" fill=\"#0000FF\"/>\n<path class=\"atom-19\" d=\"M 291.6 515.6 Q 291.6 514.5, 292.1 514.0 Q 292.6 513.4, 293.6 513.4 Q 294.5 513.4, 295.0 514.0 L 294.6 514.4 Q 294.2 513.9, 293.6 513.9 Q 292.9 513.9, 292.6 514.3 Q 292.2 514.8, 292.2 515.6 Q 292.2 516.5, 292.6 516.9 Q 293.0 517.4, 293.7 517.4 Q 294.1 517.4, 294.7 517.1 L 294.9 517.5 Q 294.6 517.7, 294.3 517.8 Q 294.0 517.9, 293.6 517.9 Q 292.6 517.9, 292.1 517.3 Q 291.6 516.7, 291.6 515.6 \" fill=\"#00CC00\"/>\n<path class=\"atom-19\" d=\"M 295.5 513.1 L 296.1 513.1 L 296.1 517.8 L 295.5 517.8 L 295.5 513.1 \" fill=\"#00CC00\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 544.5,485.7 L 540.9,490.6\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 540.9,490.6 L 537.2,495.5\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 542.1,483.9 L 539.0,488.0\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 539.0,488.0 L 535.8,492.2\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 547.0,487.6 L 543.9,491.7\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 543.9,491.7 L 540.8,495.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-1 atom-1 atom-2\" d=\"M 537.2,495.5 L 528.0,507.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-2 atom-2 atom-3\" d=\"M 528.0,507.9 L 534.1,522.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-2 atom-2 atom-3\" d=\"M 526.1,511.2 L 530.3,521.1\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-21 atom-21 atom-2\" d=\"M 512.7,506.0 L 528.0,507.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-3 atom-3 atom-4\" d=\"M 534.1,522.0 L 524.8,534.4\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-4 atom-4 atom-5\" d=\"M 524.8,534.4 L 509.5,532.5\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-4 atom-4 atom-5\" d=\"M 522.9,531.0 L 512.2,529.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-5 atom-5 atom-6\" d=\"M 509.5,532.5 L 505.9,537.4\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-5 atom-5 atom-6\" d=\"M 505.9,537.4 L 502.2,542.3\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-19 atom-5 atom-20\" d=\"M 509.5,532.5 L 503.4,518.4\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-6 atom-6 atom-7\" d=\"M 498.2,544.6 L 491.6,543.8\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-6 atom-6 atom-7\" d=\"M 491.6,543.8 L 485.0,543.1\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-7 atom-7 atom-8\" d=\"M 483.7,542.1 L 480.1,547.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-7 atom-7 atom-8\" d=\"M 480.1,547.0 L 476.5,551.9\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-7 atom-7 atom-8\" d=\"M 486.2,544.0 L 482.6,548.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-7 atom-7 atom-8\" d=\"M 482.6,548.9 L 478.9,553.7\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-8 atom-7 atom-9\" d=\"M 485.0,543.1 L 482.5,537.3\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-8 atom-7 atom-9\" d=\"M 482.5,537.3 L 480.0,531.5\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-9 atom-9 atom-10\" d=\"M 480.8,526.3 L 484.5,521.4\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-9 atom-9 atom-10\" d=\"M 484.5,521.4 L 488.1,516.5\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-22 atom-19 atom-9\" d=\"M 463.6,527.1 L 470.2,527.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-22 atom-19 atom-9\" d=\"M 470.2,527.9 L 476.9,528.6\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-10 atom-10 atom-11\" d=\"M 488.1,516.5 L 482.1,502.4\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-11 atom-11 atom-12\" d=\"M 482.1,502.4 L 466.8,500.6\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-12 atom-12 atom-13\" d=\"M 466.8,500.6 L 457.5,512.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-13 atom-13 atom-14\" d=\"M 457.5,512.9 L 442.2,511.1\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-18 atom-13 atom-19\" d=\"M 457.5,512.9 L 463.6,527.1\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-14 atom-14 atom-15\" d=\"M 442.2,511.1 L 439.7,505.3\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-14 atom-14 atom-15\" d=\"M 439.7,505.3 L 437.3,499.5\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-15 atom-15 atom-16\" d=\"M 434.1,496.7 L 427.5,495.9\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-15 atom-15 atom-16\" d=\"M 427.5,495.9 L 420.9,495.1\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-16 atom-16 atom-17\" d=\"M 420.9,495.1 L 418.4,489.3\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-16 atom-16 atom-17\" d=\"M 418.4,489.3 L 415.9,483.5\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-17 atom-16 atom-18\" d=\"M 419.6,494.2 L 416.0,499.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-17 atom-16 atom-18\" d=\"M 416.0,499.0 L 412.3,503.9\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-17 atom-16 atom-18\" d=\"M 422.1,496.0 L 418.4,500.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-17 atom-16 atom-18\" d=\"M 418.4,500.9 L 414.8,505.8\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-20 atom-20 atom-21\" d=\"M 503.4,518.4 L 512.7,506.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-20 atom-20 atom-21\" d=\"M 507.3,518.4 L 513.8,509.7\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"atom-0\" d=\"M 545.5 481.0 L 546.9 483.3 Q 547.1 483.5, 547.3 483.9 Q 547.5 484.4, 547.5 484.4 L 547.5 481.0 L 548.1 481.0 L 548.1 485.4 L 547.5 485.4 L 546.0 482.8 Q 545.8 482.5, 545.6 482.2 Q 545.4 481.9, 545.4 481.7 L 545.4 485.4 L 544.8 485.4 L 544.8 481.0 L 545.5 481.0 \" fill=\"#0000FF\"/>\n<path class=\"atom-6\" d=\"M 499.3 542.7 L 500.7 545.0 Q 500.9 545.2, 501.1 545.7 Q 501.3 546.1, 501.4 546.1 L 501.4 542.7 L 501.9 542.7 L 501.9 547.1 L 501.3 547.1 L 499.8 544.5 Q 499.6 544.2, 499.4 543.9 Q 499.3 543.6, 499.2 543.5 L 499.2 547.1 L 498.6 547.1 L 498.6 542.7 L 499.3 542.7 \" fill=\"#0000FF\"/>\n<path class=\"atom-6\" d=\"M 502.5 542.7 L 503.1 542.7 L 503.1 544.6 L 505.3 544.6 L 505.3 542.7 L 505.9 542.7 L 505.9 547.1 L 505.3 547.1 L 505.3 545.0 L 503.1 545.0 L 503.1 547.1 L 502.5 547.1 L 502.5 542.7 \" fill=\"#0000FF\"/>\n<path class=\"atom-8\" d=\"M 473.7 555.4 Q 473.7 554.4, 474.3 553.8 Q 474.8 553.2, 475.7 553.2 Q 476.7 553.2, 477.2 553.8 Q 477.7 554.4, 477.7 555.4 Q 477.7 556.5, 477.2 557.1 Q 476.7 557.7, 475.7 557.7 Q 474.8 557.7, 474.3 557.1 Q 473.7 556.5, 473.7 555.4 M 475.7 557.2 Q 476.4 557.2, 476.8 556.7 Q 477.1 556.3, 477.1 555.4 Q 477.1 554.6, 476.8 554.1 Q 476.4 553.7, 475.7 553.7 Q 475.1 553.7, 474.7 554.1 Q 474.4 554.5, 474.4 555.4 Q 474.4 556.3, 474.7 556.7 Q 475.1 557.2, 475.7 557.2 \" fill=\"#FF0000\"/>\n<path class=\"atom-9\" d=\"M 477.9 526.7 L 479.4 529.0 Q 479.5 529.2, 479.7 529.7 Q 480.0 530.1, 480.0 530.1 L 480.0 526.7 L 480.6 526.7 L 480.6 531.1 L 480.0 531.1 L 478.4 528.5 Q 478.3 528.2, 478.1 527.9 Q 477.9 527.6, 477.8 527.5 L 477.8 531.1 L 477.3 531.1 L 477.3 526.7 L 477.9 526.7 \" fill=\"#0000FF\"/>\n<path class=\"atom-15\" d=\"M 435.2 494.7 L 436.6 497.0 Q 436.8 497.3, 437.0 497.7 Q 437.2 498.1, 437.2 498.1 L 437.2 494.7 L 437.8 494.7 L 437.8 499.1 L 437.2 499.1 L 435.7 496.6 Q 435.5 496.3, 435.3 495.9 Q 435.1 495.6, 435.1 495.5 L 435.1 499.1 L 434.5 499.1 L 434.5 494.7 L 435.2 494.7 \" fill=\"#0000FF\"/>\n<path class=\"atom-15\" d=\"M 438.3 494.7 L 438.9 494.7 L 438.9 496.6 L 441.2 496.6 L 441.2 494.7 L 441.8 494.7 L 441.8 499.1 L 441.2 499.1 L 441.2 497.1 L 438.9 497.1 L 438.9 499.1 L 438.3 499.1 L 438.3 494.7 \" fill=\"#0000FF\"/>\n<path class=\"atom-17\" d=\"M 407.1 478.7 L 407.6 478.7 L 407.6 480.6 L 409.9 480.6 L 409.9 478.7 L 410.5 478.7 L 410.5 483.1 L 409.9 483.1 L 409.9 481.1 L 407.6 481.1 L 407.6 483.1 L 407.1 483.1 L 407.1 478.7 \" fill=\"#0000FF\"/>\n<path class=\"atom-17\" d=\"M 410.7 482.9 Q 410.8 482.7, 411.0 482.5 Q 411.3 482.4, 411.6 482.4 Q 412.1 482.4, 412.3 482.6 Q 412.6 482.8, 412.6 483.3 Q 412.6 483.7, 412.2 484.1 Q 411.9 484.5, 411.3 485.0 L 412.6 485.0 L 412.6 485.3 L 410.7 485.3 L 410.7 485.0 Q 411.2 484.6, 411.5 484.3 Q 411.8 484.1, 412.0 483.8 Q 412.2 483.5, 412.2 483.3 Q 412.2 483.0, 412.0 482.8 Q 411.9 482.7, 411.6 482.7 Q 411.4 482.7, 411.3 482.8 Q 411.1 482.9, 411.0 483.1 L 410.7 482.9 \" fill=\"#0000FF\"/>\n<path class=\"atom-17\" d=\"M 413.8 478.7 L 415.2 481.0 Q 415.4 481.3, 415.6 481.7 Q 415.8 482.1, 415.9 482.1 L 415.9 478.7 L 416.4 478.7 L 416.4 483.1 L 415.8 483.1 L 414.3 480.6 Q 414.1 480.3, 413.9 479.9 Q 413.7 479.6, 413.7 479.5 L 413.7 483.1 L 413.1 483.1 L 413.1 478.7 L 413.8 478.7 \" fill=\"#0000FF\"/>\n<path class=\"atom-18\" d=\"M 409.6 507.4 Q 409.6 506.4, 410.1 505.8 Q 410.7 505.2, 411.6 505.2 Q 412.6 505.2, 413.1 505.8 Q 413.6 506.4, 413.6 507.4 Q 413.6 508.5, 413.1 509.1 Q 412.6 509.7, 411.6 509.7 Q 410.7 509.7, 410.1 509.1 Q 409.6 508.5, 409.6 507.4 M 411.6 509.2 Q 412.3 509.2, 412.6 508.8 Q 413.0 508.3, 413.0 507.4 Q 413.0 506.6, 412.6 506.1 Q 412.3 505.7, 411.6 505.7 Q 411.0 505.7, 410.6 506.1 Q 410.2 506.6, 410.2 507.4 Q 410.2 508.3, 410.6 508.8 Q 411.0 509.2, 411.6 509.2 \" fill=\"#FF0000\"/>\n<path class=\"bond-0 atom-0 atom-1\" d=\"M 666.3,477.9 L 653.7,486.7\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-1 atom-1 atom-2\" d=\"M 653.7,486.7 L 654.2,493.1\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-1 atom-1 atom-2\" d=\"M 654.2,493.1 L 654.7,499.5\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-2 atom-2 atom-3\" d=\"M 652.9,503.8 L 648.1,508.0\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-2 atom-2 atom-3\" d=\"M 648.1,508.0 L 643.2,512.1\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-18 atom-18 atom-2\" d=\"M 668.1,510.1 L 662.5,506.7\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-18 atom-18 atom-2\" d=\"M 662.5,506.7 L 657.0,503.3\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-3 atom-3 atom-4\" d=\"M 643.2,512.1 L 649.2,526.3\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-4 atom-4 atom-5\" d=\"M 649.2,526.3 L 664.5,525.1\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-5 atom-5 atom-6\" d=\"M 664.5,525.1 L 674.6,536.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-17 atom-5 atom-18\" d=\"M 664.5,525.1 L 668.1,510.1\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-6 atom-6 atom-7\" d=\"M 674.6,536.8 L 681.2,535.5\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-6 atom-6 atom-7\" d=\"M 681.2,535.5 L 687.7,534.3\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-7 atom-7 atom-8\" d=\"M 691.8,536.3 L 695.8,540.9\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-7 atom-7 atom-8\" d=\"M 695.8,540.9 L 699.8,545.6\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-8 atom-8 atom-9\" d=\"M 698.3,545.1 L 696.2,551.0\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-8 atom-8 atom-9\" d=\"M 696.2,551.0 L 694.2,557.0\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-8 atom-8 atom-9\" d=\"M 701.3,546.1 L 699.2,552.1\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-8 atom-8 atom-9\" d=\"M 699.2,552.1 L 697.1,558.0\" style=\"fill:none;fill-rule:evenodd;stroke:#FF0000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-9 atom-8 atom-10\" d=\"M 699.8,545.6 L 706.3,544.3\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-9 atom-8 atom-10\" d=\"M 706.3,544.3 L 712.9,543.1\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-10 atom-10 atom-11\" d=\"M 715.8,540.1 L 717.9,534.2\" style=\"fill:none;fill-rule:evenodd;stroke:#0000FF;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-10 atom-10 atom-11\" d=\"M 717.9,534.2 L 720.0,528.2\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-11 atom-11 atom-12\" d=\"M 720.0,528.2 L 735.2,525.3\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-11 atom-11 atom-12\" d=\"M 721.7,524.7 L 732.3,522.7\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-19 atom-17 atom-11\" d=\"M 710.0,516.5 L 720.0,528.2\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-12 atom-12 atom-13\" d=\"M 735.2,525.3 L 740.3,510.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-13 atom-13 atom-14\" d=\"M 740.3,510.8 L 730.2,499.1\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-13 atom-13 atom-14\" d=\"M 736.4,511.0 L 729.4,502.8\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-14 atom-14 atom-15\" d=\"M 730.2,499.1 L 732.3,493.2\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-14 atom-14 atom-15\" d=\"M 732.3,493.2 L 734.3,487.3\" style=\"fill:none;fill-rule:evenodd;stroke:#00CC00;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-15 atom-14 atom-16\" d=\"M 730.2,499.1 L 715.1,501.9\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-16 atom-16 atom-17\" d=\"M 715.1,501.9 L 710.0,516.5\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"bond-16 atom-16 atom-17\" d=\"M 717.2,505.1 L 713.7,515.3\" style=\"fill:none;fill-rule:evenodd;stroke:#000000;stroke-width:2.0px;stroke-linecap:butt;stroke-linejoin:miter;stroke-opacity:1\"/>\n<path class=\"atom-2\" d=\"M 654.0 499.9 L 655.4 502.2 Q 655.5 502.4, 655.8 502.8 Q 656.0 503.2, 656.0 503.3 L 656.0 499.9 L 656.6 499.9 L 656.6 504.2 L 656.0 504.2 L 654.4 501.7 Q 654.3 501.4, 654.1 501.1 Q 653.9 500.7, 653.8 500.6 L 653.8 504.2 L 653.3 504.2 L 653.3 499.9 L 654.0 499.9 \" fill=\"#0000FF\"/>\n<path class=\"atom-7\" d=\"M 688.8 531.7 L 690.2 534.0 Q 690.4 534.2, 690.6 534.7 Q 690.8 535.1, 690.8 535.1 L 690.8 531.7 L 691.4 531.7 L 691.4 536.1 L 690.8 536.1 L 689.3 533.5 Q 689.1 533.2, 688.9 532.9 Q 688.7 532.6, 688.7 532.5 L 688.7 536.1 L 688.1 536.1 L 688.1 531.7 L 688.8 531.7 \" fill=\"#0000FF\"/>\n<path class=\"atom-7\" d=\"M 688.0 526.9 L 688.6 526.9 L 688.6 528.8 L 690.9 528.8 L 690.9 526.9 L 691.5 526.9 L 691.5 531.3 L 690.9 531.3 L 690.9 529.3 L 688.6 529.3 L 688.6 531.3 L 688.0 531.3 L 688.0 526.9 \" fill=\"#0000FF\"/>\n<path class=\"atom-9\" d=\"M 692.7 560.1 Q 692.7 559.1, 693.2 558.5 Q 693.7 557.9, 694.7 557.9 Q 695.7 557.9, 696.2 558.5 Q 696.7 559.1, 696.7 560.1 Q 696.7 561.2, 696.2 561.8 Q 695.7 562.4, 694.7 562.4 Q 693.7 562.4, 693.2 561.8 Q 692.7 561.2, 692.7 560.1 M 694.7 561.9 Q 695.4 561.9, 695.7 561.5 Q 696.1 561.0, 696.1 560.1 Q 696.1 559.3, 695.7 558.8 Q 695.4 558.4, 694.7 558.4 Q 694.0 558.4, 693.7 558.8 Q 693.3 559.3, 693.3 560.1 Q 693.3 561.0, 693.7 561.5 Q 694.0 561.9, 694.7 561.9 \" fill=\"#FF0000\"/>\n<path class=\"atom-10\" d=\"M 714.0 540.5 L 715.4 542.8 Q 715.5 543.1, 715.8 543.5 Q 716.0 543.9, 716.0 543.9 L 716.0 540.5 L 716.6 540.5 L 716.6 544.9 L 716.0 544.9 L 714.5 542.4 Q 714.3 542.1, 714.1 541.7 Q 713.9 541.4, 713.9 541.3 L 713.9 544.9 L 713.3 544.9 L 713.3 540.5 L 714.0 540.5 \" fill=\"#0000FF\"/>\n<path class=\"atom-10\" d=\"M 717.1 540.5 L 717.7 540.5 L 717.7 542.4 L 719.9 542.4 L 719.9 540.5 L 720.5 540.5 L 720.5 544.9 L 719.9 544.9 L 719.9 542.9 L 717.7 542.9 L 717.7 544.9 L 717.1 544.9 L 717.1 540.5 \" fill=\"#0000FF\"/>\n<path class=\"atom-15\" d=\"M 733.6 484.7 Q 733.6 483.6, 734.1 483.0 Q 734.7 482.4, 735.6 482.4 Q 736.5 482.4, 737.0 483.1 L 736.6 483.4 Q 736.2 483.0, 735.6 483.0 Q 735.0 483.0, 734.6 483.4 Q 734.3 483.8, 734.3 484.7 Q 734.3 485.5, 734.6 486.0 Q 735.0 486.4, 735.7 486.4 Q 736.2 486.4, 736.7 486.1 L 736.9 486.6 Q 736.7 486.7, 736.3 486.8 Q 736.0 486.9, 735.6 486.9 Q 734.7 486.9, 734.1 486.3 Q 733.6 485.8, 733.6 484.7 \" fill=\"#00CC00\"/>\n<path class=\"atom-15\" d=\"M 737.5 482.2 L 738.1 482.2 L 738.1 486.9 L 737.5 486.9 L 737.5 482.2 \" fill=\"#00CC00\"/>\n</svg>",
"text/plain": [
"<IPython.core.display.SVG object>"
]
},
"metadata": {},
"output_type": "display_data"
}
],
"source": [
"aligned_mols, mol_groups = partition_and_align_mols(molecules_with_confs, partition='anon-scaffold')\n",
"display(dm.to_image(aligned_mols[:16], mol_size=(200, 150)))"
]
},
{
"cell_type": "markdown",
"metadata": {},
"source": [
"Note here how molecule 12 is different in the `anon*-scaffold`. Because it actually belong to a separate cluster. "
]
},
{
"cell_type": "markdown",
"metadata": {},
"source": [
"3. Test align with custom template"
]
},
{
"cell_type": "code",
"execution_count": 14,
"metadata": {},
"outputs": [],
"source": [
"template_with_2d_coords_mdl = \"\"\"\n",
" MJ220600 \n",
"\n",
" 22 24 0 0 0 0 0 0 0 0999 V2000\n",
" -2.3616 -3.3697 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0\n",
" -1.6472 -2.9572 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0\n",
" -0.9327 -3.3697 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0\n",
" -0.9327 -4.1947 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0\n",
" -0.2183 -4.6072 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0\n",
" -0.2183 -5.4322 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0\n",
" -0.9327 -5.8447 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0\n",
" -1.6472 -5.4322 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0\n",
" -1.6472 -4.6072 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0\n",
" -1.6472 -2.1322 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0\n",
" -2.3616 -1.7197 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0\n",
" -2.3616 -0.8947 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0\n",
" -1.6472 -0.4822 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0\n",
" -1.6472 0.3427 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0\n",
" -0.9327 0.7552 0.0000 N 0 0 0 0 0 0 0 0 0 0 0 0\n",
" -0.9327 1.5802 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0\n",
" -0.2183 1.9927 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0\n",
" 0.4961 1.5802 0.0000 O 0 0 0 0 0 0 0 0 0 0 0 0\n",
" 0.4961 0.7552 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0\n",
" -0.2183 0.3427 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0\n",
" -0.9327 -0.8947 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0\n",
" -0.9327 -1.7197 0.0000 C 0 0 0 0 0 0 0 0 0 0 0 0\n",
" 1 2 2 0 0 0 0\n",
" 2 3 1 0 0 0 0\n",
" 3 4 1 0 0 0 0\n",
" 4 5 4 0 0 0 0\n",
" 5 6 4 0 0 0 0\n",
" 6 7 4 0 0 0 0\n",
" 7 8 4 0 0 0 0\n",
" 8 9 4 0 0 0 0\n",
" 4 9 4 0 0 0 0\n",
" 2 10 1 0 0 0 0\n",
" 10 11 1 0 0 0 0\n",
" 11 12 1 0 0 0 0\n",
" 12 13 1 0 0 0 0\n",
" 13 14 1 0 0 0 0\n",
" 14 15 1 0 0 0 0\n",
" 15 16 1 0 0 0 0\n",
" 16 17 1 0 0 0 0\n",
" 17 18 1 0 0 0 0\n",
" 18 19 1 0 0 0 0\n",
" 19 20 1 0 0 0 0\n",
" 15 20 1 0 0 0 0\n",
" 13 21 1 0 0 0 0\n",
" 21 22 1 0 0 0 0\n",
" 10 22 1 0 0 0 0\n",
"M END\n",
"\"\"\"\n",
"\n",
"template_with_3d_coords_mdl = \"\"\"\n",
" MJ220600 \n",
"\n",
" 22 24 0 0 0 0 0 0 0 0999 V2000\n",
" -3.0912 -2.6881 0.7272 O 0 0 0 0 0 0 0 0 0 0 0 0\n",
" -2.4306 -2.7347 0.8385 C 0 0 0 0 0 0 0 0 0 0 0 0\n",
" -2.2114 -3.4239 0.9549 N 0 0 0 0 0 0 0 0 0 0 0 0\n",
" -1.6047 -3.6636 1.2823 C 0 0 0 0 0 0 0 0 0 0 0 0\n",
" -1.2964 -4.3094 1.0362 C 0 0 0 0 0 0 0 0 0 0 0 0\n",
" -0.6845 -4.5957 1.3717 C 0 0 0 0 0 0 0 0 0 0 0 0\n",
" -0.3805 -4.2432 1.9643 C 0 0 0 0 0 0 0 0 0 0 0 0\n",
" -0.6874 -3.6030 2.2173 C 0 0 0 0 0 0 0 0 0 0 0 0\n",
" -1.2985 -3.3161 1.8823 C 0 0 0 0 0 0 0 0 0 0 0 0\n",
" -2.0101 -2.1210 0.8350 N 0 0 0 0 0 0 0 0 0 0 0 0\n",
" -1.2626 -2.1319 0.6182 C 0 0 0 0 0 0 0 0 0 0 0 0\n",
" -1.0952 -1.5604 0.0358 C 0 0 0 0 0 0 0 0 0 0 0 0\n",
" -1.342
Sign up for free to join this conversation on GitHub. Already have an account? Sign in to comment