{ "cells": [ { "cell_type": "markdown", "metadata": {}, "source": [ "# Using the on-the-fly trajectory transformations in MDAnalysis\n", "\n", "On-the-fly transformations have been introduced in version 0.18.1 of MDAnalysis. This long awaited feature brings to MDAnalysis a whole new level of functionality, allowing for more efficient workflows when analyzing and visualizing simulation trajectories.\n", "\n", "_Note:_ This notebook demonstrates some transformations that appear in MDAnalysis 0.20.0.\n", "\n", "## Why do we need transformations?\n", "When visualizing and analyzing trajectories from molecular dynamics simulations, some prior modifications are often required.\n", "Examples of the most usual modifications or transformations are removing artifacts from periodic boundary conditions, which cause some issues with some molecular viewers (PyMol for example), removing the rotation and translation of a particular molecule and/or centering it in the unit cell, which helps focus on the its actual conformational changes by removing their natural movement in solution.\n", "These transformations help us better identifying patterns in the behavior of our biological systems, and, more importantly, showing them to the world.\n", "\n", "## The advantage of using MDAnalysis for trajectory transformations\n", "Each simulation package is often bundled with tools to transform and analyze trajectories, such as GROMACS' `trjconv`. However, most of the times, the user is required to apply all the intended transformations to the whole trajectory (or the portion of interest) prior to visualization and analysis. This often requires processing huge files, sometimes more than once. Moreover, some tools such as `trjconv` do not support frame indexing for the most popular trajectory formats, requiring iterating over frames that are not needed for that particular analysis. \n", "Trajectory transformations in MDAnalysis, on the other end, have one great advantage - they are performed on-the-fly. This means that, after loading the trajectory file, the user adds a transformation workflow and the transformations are applied to each frame that is read. There is no need to iterate over the whole trajectory before performing other analysis, and, with the frame indexing provided by MDAnalysis, only the frames of interest are processed. Moreover, the way the transformations API is implemented makes it really easy to add custom transformations.\n", "Another things that really makes the \"on-the-fly\" aspect of the MDAnalysis transformations really shine is coupling it to a visualization widget such as [NGL Viewer](http://nglviewer.org/ngl/api/index.html)." ] }, { "cell_type": "markdown", "metadata": {}, "source": [ "## Using MDAnalysis transformations\n", "Now it's time to learn how to use the trajectory transformations in MDAnalysis. During the following steps, we will apply some transformations on a 1 ns trajectory of a simple 19-residue peptide embeded in a 128-DMPC membrane, showing the GROMACS `trjconv` command and the equivalent MDAnalysis code and output. To keep thinks lightweight, frames are were taken every 100 ps, and water molecules were removed.\n", "\n", "Note that in order to use the transformations in the `MDAnalysis.transformations` module we have to explicitly import it; we can then access the, say, `translate` transformation as `MDAnalysis.transformations.translate` or also as `mda.transformations.translate` if we first ran `import MDAnalysis as mda`." ] }, { "cell_type": "code", "execution_count": null, "metadata": {}, "outputs": [], "source": [ "import MDAnalysis as mda\n", "import MDAnalysis.transformations\n", "\n", "import nglview as nv\n", "\n", "# suppress harmless warnings when using nglview and trajectories\n", "# (such as the ones used here) that do not contain attributes defined\n", "# in the PDB standard\n", "import warnings\n", "warnings.filterwarnings('ignore') # some attributes are missing " ] }, { "cell_type": "markdown", "metadata": {}, "source": [ "Load a test trajectory (the [membrane peptide dataset](https://www.mdanalysis.org/MDAnalysisData/membrane_peptide.html)):" ] }, { "cell_type": "code", "execution_count": null, "metadata": {}, "outputs": [], "source": [ "from MDAnalysisData.datasets import fetch_membrane_peptide\n", "data = fetch_membrane_peptide()\n", "\n", "u = mda.Universe(data.topology, data.trajectory)" ] }, { "cell_type": "markdown", "metadata": {}, "source": [ "### Example 1: making everything whole again\n", "When performing MD simulations using periodic boundary conditions, molecules will often cross the limits of the unit cell. When this happens, some atoms of the molecule will show up on the the opposing side of the unit cell and some molecular viewers will show stretched bonds and other visual artifacts depending on the visual representation of the system. \n", "This is the case of our system. Without any modifications, when we look at the trajectory of our system, things will become very ugly, very fast:" ] }, { "cell_type": "code", "execution_count": null, "metadata": {}, "outputs": [], "source": [ "nv.show_mdanalysis(u)" ] }, { "cell_type": "markdown", "metadata": {}, "source": [ "Using `trjconv`, one way to may every molecules whole again would be:\n", "\n", " gmx trjconv -f pept_in_memb.xtc -s pept_in_memb.tpr -pbc mol -o output.xtc\n", " \n", "In MDAnalysis this can be done with the `unwrap` transformation, which takes an AtomGroup as argument. This can be done as follows:" ] }, { "cell_type": "code", "execution_count": null, "metadata": {}, "outputs": [], "source": [ "# a custom atom group can be passed as an argument. In this case we will use all the atoms\n", "# in the Universe u\n", "u = mda.Universe(data.topology, data.trajectory)\n", "ag = u.atoms\n", "\n", "# we define the transformation\n", "transformation = mda.transformations.unwrap(ag)\n", "\n", "# we add the transformation to the trajectory in it will be applied everytime we read a frame\n", "u.trajectory.add_transformations(transformation)\n", "\n", "# we can do other things with the trajectory without having to generate a file with the transformed\n", "# trajectory\n", "# for ts in u.trajectory:\n", "# analysis1()\n", "# analysis2()\n", "nv.show_mdanalysis(u)" ] }, { "cell_type": "markdown", "metadata": {}, "source": [ "as you can see, the artifacts caused by the atoms crossing the boundaries of the unit cell are now gone.\n", "\n", "### Example 2: what if we also want to center the peptide in the unit cell?\n", "In that case, using `trjconv` we would do something like this:\n", " \n", " gmx trjconv -f pept_in_memb.xtc -s pept_in_memb.tpr -pbc mol -center -o output.xtc\n", "\n", "And we choose `Protein` as the group to be centered.\n", "\n", "In MDAnalysis we use the `center_in_box` transformation. This function takes an AtomGroup as a mandatory argument. Optional arguments include `weights`, which is used to calculate the weighted center of the given AtomGroup (if weights='mass' then the center of mass is calculated), `center_to` which is used when the user needs to center the AtomGroup in a custom point instead of the center of the unit cell, and `wrap` which, if `True`, causes all the atoms of the AtomGroup to be moved to the unit cell before calculating the weighted center.\n", "This transformation can be performed as follows:" ] }, { "cell_type": "code", "execution_count": null, "metadata": {}, "outputs": [], "source": [ "u = mda.Universe(data.topology, data.trajectory)\n", "prot = u.select_atoms(\"protein\")\n", "ag = u.atoms\n", "\n", "# we will use mass as weights for the center calculation\n", "transformations = (mda.transformations.unwrap(ag),\n", " mda.transformations.center_in_box(prot, weights='mass'),\n", " mda.transformations.wrap(ag, compound='fragments'))\n", "u.trajectory.add_transformations(*transformations)\n", "\n", "nv.show_mdanalysis(u)" ] }, { "cell_type": "markdown", "metadata": {}, "source": [ "You can see that the `transformations` workflow above has three steps:\n", " - make everything molecule whole again with `unwrap` ;\n", " - center the protein in the unit cell with `center_in_box` - this causes some of the phospholipids to fall outside the unit cell ;\n", " - shift the molecules (`fragments`) back to the unit cell using `wrap`\n", " \n", "Two other centering transformations are availabe - `center_in_plane` and `center_in_axis` - and just as the names say, they are used to center molecules in the `xy`, `xz` and `yz` planes, and the `x`, `y` and `z` axes, respectively.\n", " \n", "### Example 3: what if we want to do a fitting of the protein?\n", "Fitting is useful when processing trajectories for visualization and analyses - it removes the translations and rotations of the molecule, allowing us to have a better look at the structural changes that happen in our simulations.\n", "If we want to do this using `trjconv` we would do have to do this in two steps:\n", "\n", " gmx trjconv -f pept_in_memb.xtc -s pept_in_memb.tpr -pbc mol -center -o midstep.xtc\n", " \n", " gmx trjconv -f midstep.xtc -s pept_in_memb.tpr -fit rot+trans -o output.xtc\n", "\n", "And we choose `Protein` as the group to be centered and for the least squares fitting.\n", "\n", "In MDAnalysis we just add another transformation to our workflow - `fit_rot_trans`. This transformation takes the AtomGroup to be fitted as argument, an AtomGroup to be used as reference and, by default, it behaves just as the option `-fit rot+trans`. If given a `plane` argument, the fitting is performed on a given plane. If `plane=xy` then the transformation will behave as `-fit rotxy+transxy`, but the `xz` and `yz` planes are also supported. Just as in `center_in_box`, a `weights` argument can be passed to the function, and it will dictate how much each atom of the molecule contributes to the least squares fitting. \n", "Here's what the workflow looks like:" ] }, { "cell_type": "code", "execution_count": null, "metadata": {}, "outputs": [], "source": [ "u = mda.Universe(data.topology, data.trajectory)\n", "prot = u.select_atoms(\"protein\")\n", "\n", "# we load another universe to define the reference\n", "# it uses the same input files, but this doesn't have to be always the case\n", "ref_u = mda.Universe(data.topology, data.trajectory)\n", "reference = ref_u.select_atoms(\"protein\")\n", "ag = u.atoms\n", "\n", "transformations = (mda.transformations.unwrap(ag),\n", " mda.transformations.center_in_box(prot, weights='mass'),\n", " mda.transformations.wrap(ag, compound='fragments'),\n", " mda.transformations.fit_rot_trans(prot, reference))\n", "u.trajectory.add_transformations(*transformations)\n", "\n", "nv.show_mdanalysis(u)\n" ] }, { "cell_type": "markdown", "metadata": {}, "source": [ "It looks a bit confusing with the membrane..." ] }, { "cell_type": "code", "execution_count": null, "metadata": { "scrolled": true }, "outputs": [], "source": [ "t = nv.MDAnalysisTrajectory(prot)\n", "w = nv.NGLWidget(t)\n", "w.add_line()\n", "w" ] }, { "cell_type": "markdown", "metadata": {}, "source": [ "This transformations is good when we want to see how the conformation of the protein evolves with time. \n", "\n", "But, in this case, we also have a membrane. How does the protein behave in the membrane? Doing a least squares fitting in the `xy` plane can help us have a better look. Here's how it goes:" ] }, { "cell_type": "code", "execution_count": null, "metadata": {}, "outputs": [], "source": [ "u = mda.Universe(data.topology, data.trajectory)\n", "prot = u.select_atoms(\"protein\")\n", "ref_u = mda.Universe(data.topology, data.trajectory)\n", "reference = ref_u.select_atoms(\"protein\")\n", "ag = u.atoms\n", "\n", "transformations = (mda.transformations.unwrap(ag),\n", " mda.transformations.center_in_box(prot),\n", " mda.transformations.wrap(ag, compound='fragments'),\n", " mda.transformations.fit_rot_trans(prot, reference, plane='xy', weights=\"mass\"))\n", "u.trajectory.add_transformations(*transformations)\n", "\n", "# let's hide the lipid tails to have a better view\n", "view_selection = u.select_atoms(\"protein or name P\")\n", "t = nv.MDAnalysisTrajectory(view_selection)\n", "w = nv.NGLWidget(t)\n", "w.add_line()\n", "w" ] }, { "cell_type": "markdown", "metadata": {}, "source": [ "This transformation keeps the membrane horizontal, while the protein rotation in the z-axis is removed. This becomes particularly useful when observing protein insertion.\n", "\n", "### Example 4: I want to do my own transformations...\n", "The beauty of MDAnalysis transformations is the ability to easily create custom transformations. All transformations must have the following structure:\n", " \n", "```Python\n", "def custom_transform(args): # arguments at this point are not mandatory\n", " #do some things\n", " \n", " def wrapped(ts): \n", " # this wrapped function must only take a Timestep as argument\n", " # this is where the actual changes to the timestep must be done\n", " \n", " return ts\n", " \n", " return wrapped\n", "```\n", " \n", "Let's create one here:" ] }, { "cell_type": "code", "execution_count": null, "metadata": {}, "outputs": [], "source": [ "def up_by_2():\n", " \n", " def wrapped(ts):\n", " # here's where the magic happens \n", " # we create a numpy float32 array to avoid reduce floating\n", " # point errors\n", " ts.positions += np.asarray([0,0,20])\n", " \n", " return ts\n", " \n", " return wrapped" ] }, { "cell_type": "markdown", "metadata": {}, "source": [ "Now lets add our transformation to a workflow.\n" ] }, { "cell_type": "code", "execution_count": null, "metadata": {}, "outputs": [], "source": [ "import numpy as np\n", "u = mda.Universe(data.topology, data.trajectory)\n", "\n", "# loading another universe to better see the changes made by our transformation\n", "previous = mda.Universe('pept_in_memb.tpr', 'pept_in_memb.xtc')\n", "# making the unmodified universe whole accross the trajectory\n", "previous.trajectory.add_transformations(mda.transformations.unwrap(previous.atoms))\n", "\n", "ag = u.atoms\n", "\n", "transformations = (mda.transformations.unwrap(ag),\n", " up_by_2())\n", "u.trajectory.add_transformations(*transformations)\n", "\n", "# visualization\n", "view_selection = previous.select_atoms(\"protein or name P\")\n", "t = nv.MDAnalysisTrajectory(view_selection)\n", "w = nv.NGLWidget(t)\n", "w.add_line()\n", "w.add_trajectory(u)\n", "w" ] }, { "cell_type": "markdown", "metadata": {}, "source": [ "As you can see, the atoms in the `u` Universe have been shift up by 20 angstroms.\n", "\n", "The transformations can accept arguments. Let's modify `up_by_2` so that only the peptide is translated in the z coordinate:" ] }, { "cell_type": "code", "execution_count": null, "metadata": {}, "outputs": [], "source": [ "def protein_up_by_2(agroup):\n", " \n", " def wrapped(ts):\n", " # here's where the magic happens \n", " # we create a numpy float32 array to avoid reduce floating\n", " # point errors\n", " agroup.positions += np.asarray([0,0,20])\n", " \n", " return ts\n", " \n", " return wrapped" ] }, { "cell_type": "markdown", "metadata": {}, "source": [ "And we'll see what happens. Now is a good opportunity to showcase the `center_in_axis` transformation. The `center_in_axis` transformation snaps the the weighted center of the Atomgroup to the chosen axis. This is useful to visualize particle insertion in membranes, for example." ] }, { "cell_type": "code", "execution_count": null, "metadata": {}, "outputs": [], "source": [ "u = mda.Universe(data.topology, data.trajectory)\n", "ag = u.atoms\n", "prot = u.select_atoms(\"protein\")\n", "\n", "transformations = (mda.transformations.unwrap(ag),\n", " protein_up_by_2(prot),\n", " mda.transformations.center_in_axis(prot, axis=\"z\", weights='mass'),\n", " mda.transformations.wrap(ag, compound='fragments'))\n", "u.trajectory.add_transformations(*transformations)\n", "\n", "nv.show_mdanalysis(u)" ] }, { "cell_type": "markdown", "metadata": {}, "source": [ "The two examples of custom transformations show here are very simple. But more complex things can be done, and we encourage you to try them!\n", "\n", "This has been a quick demonstration on the power of the new on-the-fly transformations of MDAnalysis. There are more transformations available for you to explore and a whole lot more for you to create for your own molecular system." ] } ], "metadata": { "kernelspec": { "display_name": "Python 3", "language": "python", "name": "python3" }, "language_info": { "codemirror_mode": { "name": "ipython", "version": 3 }, "file_extension": ".py", "mimetype": "text/x-python", "name": "python", "nbconvert_exporter": "python", "pygments_lexer": "ipython3", "version": "3.6.7" }, "widgets": { "application/vnd.jupyter.widget-state+json": { "state": { "0131be40fe22433cbf3ba79ae5357880": { "model_module": "nglview-js-widgets", "model_module_version": "1.1.5", "model_name": "NGLModel", "state": { "_camera_orientation": [ 141.38754842796328, 0, 0, 0, 0, 141.38754842796328, 0, 0, 0, 0, 141.38754842796328, 0, -32.17500066757202, -31.635000228881836, -30.564999103546143, 1 ], "_camera_str": "orthographic", "_image_data": "", "_n_dragged_files": 0, "_ngl_coordinate_resource": {}, "_ngl_full_stage_parameters": { "ambientColor": 14540253, "ambientIntensity": 0.2, "backgroundColor": "white", "cameraEyeSep": 0.3, "cameraFov": 40, "cameraType": "perspective", "clipDist": 10, "clipFar": 100, "clipNear": 0, "fogFar": 100, "fogNear": 50, "hoverTimeout": 0, "impostor": true, "lightColor": 14540253, "lightIntensity": 1, "mousePreset": "default", "panSpeed": 1, "quality": "medium", "rotateSpeed": 2, "sampleLevel": 0, "tooltip": true, "workerDefault": true, "zoomSpeed": 1.2 }, "_ngl_full_stage_parameters_embed": {}, "_ngl_msg_archive": [], "_ngl_original_stage_parameters": { "ambientColor": 14540253, "ambientIntensity": 0.2, "backgroundColor": "white", "cameraEyeSep": 0.3, "cameraFov": 40, "cameraType": "perspective", "clipDist": 10, "clipFar": 100, "clipNear": 0, "fogFar": 100, "fogNear": 50, "hoverTimeout": 0, "impostor": true, "lightColor": 14540253, "lightIntensity": 1, "mousePreset": "default", "panSpeed": 1, "quality": "medium", "rotateSpeed": 2, "sampleLevel": 0, "tooltip": true, "workerDefault": true, "zoomSpeed": 1.2 }, "_ngl_repr_dict": { "0": { "0": { "params": { "aspectRatio": 5, "assembly": "default", "capped": true, "clipCenter": { "x": 0, "y": 0, "z": 0 }, "clipNear": 0, "clipRadius": 0, "colorMode": "hcl", "colorReverse": true, "colorScale": "spectral", "colorScheme": "residueindex", "colorValue": 9474192, "defaultAssembly": "", "depthWrite": true, "diffuse": 16777215, "diffuseInterior": false, "disablePicking": false, "flatShaded": false, "interiorColor": 2236962, "interiorDarkening": 0, "lazy": false, "matrix": { "elements": [ 1, 0, 0, 0, 0, 1, 0, 0, 0, 0, 1, 0, 0, 0, 0, 1 ] }, "metalness": 0, "opacity": 1, "quality": "high", "radialSegments": 20, "radiusData": {}, "radiusScale": 0.7, "radiusSize": 1, "radiusType": "sstruc", "roughness": 0.4, "sele": "", "side": "double", "smoothSheet": false, "subdiv": 6, "tension": null, "useInteriorColor": true, "visible": true, "wireframe": false }, "type": "cartoon" }, "1": { "params": { "aspectRatio": 1, "assembly": "default", "bondScale": 0.4, "clipCenter": { "x": 0, "y": 0, "z": 0 }, "clipNear": 0, "clipRadius": 0, "colorMode": "hcl", "colorReverse": true, "colorScale": "spectral", "colorScheme": "residueindex", "colorValue": 9474192, "cylinderOnly": false, "defaultAssembly": "", "depthWrite": true, "diffuse": 16777215, "diffuseInterior": false, "disableImpostor": false, "disablePicking": false, "flatShaded": false, "interiorColor": 2236962, "interiorDarkening": 0, "lazy": false, "lineOnly": false, "linewidth": 2, "matrix": { "elements": [ 1, 0, 0, 0, 0, 1, 0, 0, 0, 0, 1, 0, 0, 0, 0, 1 ] }, "metalness": 0, "opacity": 1, "openEnded": true, "quality": "high", "radialSegments": 20, "radiusData": {}, "radiusScale": 1, "radiusSize": 0.3, "radiusType": "size", "roughness": 0.4, "sele": "", "side": "double", "sphereDetail": 2, "useInteriorColor": true, "visible": true, "wireframe": false }, "type": "base" }, "2": { "params": { "aspectRatio": 1.5, "assembly": "default", "bondScale": 0.3, "bondSpacing": 0.75, "clipCenter": { "x": 0, "y": 0, "z": 0 }, "clipNear": 0, "clipRadius": 0, "colorMode": "hcl", "colorReverse": false, "colorScale": "", "colorScheme": "element", "colorValue": 9474192, "cylinderOnly": false, "defaultAssembly": "", "depthWrite": true, "diffuse": 16777215, "diffuseInterior": false, "disableImpostor": false, "disablePicking": false, "flatShaded": false, "interiorColor": 2236962, "interiorDarkening": 0, "lazy": false, "lineOnly": false, "linewidth": 2, "matrix": { "elements": [ 1, 0, 0, 0, 0, 1, 0, 0, 0, 0, 1, 0, 0, 0, 0, 1 ] }, "metalness": 0, "multipleBond": "off", "opacity": 1, "openEnded": true, "quality": "high", "radialSegments": 20, "radiusData": {}, "radiusScale": 2, "radiusSize": 0.15, "radiusType": "size", "roughness": 0.4, "sele": "ligand", "side": "double", "sphereDetail": 2, "useInteriorColor": true, "visible": true, "wireframe": false }, "type": "ball+stick" } } }, "_ngl_serialize": false, "_ngl_version": "2.0.0-dev.33", "_scene_position": {}, "_scene_rotation": {}, "background": "white", "count": 11, "frame": 0, "layout": "IPY_MODEL_e88e27f8c22c46f58035edb19742e29e", "n_components": 1, "picked": {} } }, "03824171d0174069a103862bfd442f7b": { "model_module": "@jupyter-widgets/controls", "model_module_version": "1.3.0", "model_name": "ImageModel", "state": { "layout": "IPY_MODEL_96c0c33006f8449bb29a86baf0d42c6b", "width": "900.0" } }, "07299e9188e04a3cab1efd2ce9bfba89": { "model_module": "@jupyter-widgets/base", "model_module_version": "1.1.0", "model_name": "LayoutModel", "state": {} }, "0942beeb302d4030bb83d2924606febc": { "model_module": "@jupyter-widgets/base", "model_module_version": "1.1.0", "model_name": "LayoutModel", "state": {} }, "0b482094a7874712a6e71edfd13c159b": { "model_module": "@jupyter-widgets/base", "model_module_version": "1.1.0", "model_name": "LayoutModel", "state": {} }, "0eef620522324142aa34a178a5cb779d": { "model_module": "nglview-js-widgets", "model_module_version": "1.1.5", "model_name": "NGLModel", "state": { "_camera_orientation": [ 104.83604245631457, 21.41401283904603, 29.39219920199797, 0, 23.06918905673272, -108.49132809265396, -3.240580605368856, 0, 28.111809548043997, 9.172180794355187, -106.95164506034162, 0, -33.33799934387207, -29.790499687194824, -35.40299987792969, 1 ], "_camera_str": "orthographic", "_image_data": "", "_n_dragged_files": 0, "_ngl_coordinate_resource": {}, "_ngl_full_stage_parameters": { "ambientColor": 14540253, "ambientIntensity": 0.2, "backgroundColor": "white", "cameraEyeSep": 0.3, "cameraFov": 40, "cameraType": "perspective", "clipDist": 10, "clipFar": 100, "clipNear": 0, "fogFar": 100, "fogNear": 50, "hoverTimeout": 0, "impostor": true, "lightColor": 14540253, "lightIntensity": 1, "mousePreset": "default", "panSpeed": 1, "quality": "medium", "rotateSpeed": 2, "sampleLevel": 0, "tooltip": true, "workerDefault": true, "zoomSpeed": 1.2 }, "_ngl_full_stage_parameters_embed": {}, "_ngl_msg_archive": [], "_ngl_original_stage_parameters": { "ambientColor": 14540253, "ambientIntensity": 0.2, "backgroundColor": "white", "cameraEyeSep": 0.3, "cameraFov": 40, "cameraType": "perspective", "clipDist": 10, "clipFar": 100, "clipNear": 0, "fogFar": 100, "fogNear": 50, "hoverTimeout": 0, "impostor": true, "lightColor": 14540253, "lightIntensity": 1, "mousePreset": "default", "panSpeed": 1, "quality": "medium", "rotateSpeed": 2, "sampleLevel": 0, "tooltip": true, "workerDefault": true, "zoomSpeed": 1.2 }, "_ngl_repr_dict": { "0": { "0": { "params": { "aspectRatio": 5, "assembly": "default", "capped": true, "clipCenter": { "x": 0, "y": 0, "z": 0 }, "clipNear": 0, "clipRadius": 0, "colorMode": "hcl", "colorReverse": true, "colorScale": "spectral", "colorScheme": "residueindex", "colorValue": 9474192, "defaultAssembly": "", "depthWrite": true, "diffuse": 16777215, "diffuseInterior": false, "disablePicking": false, "flatShaded": false, "interiorColor": 2236962, "interiorDarkening": 0, "lazy": false, "matrix": { "elements": [ 1, 0, 0, 0, 0, 1, 0, 0, 0, 0, 1, 0, 0, 0, 0, 1 ] }, "metalness": 0, "opacity": 1, "quality": "high", "radialSegments": 20, "radiusData": {}, "radiusScale": 0.7, "radiusSize": 1, "radiusType": "sstruc", "roughness": 0.4, "sele": "", "side": "double", "smoothSheet": false, "subdiv": 6, "tension": null, "useInteriorColor": true, "visible": true, "wireframe": false }, "type": "cartoon" }, "1": { "params": { "aspectRatio": 1, "assembly": "default", "bondScale": 0.4, "clipCenter": { "x": 0, "y": 0, "z": 0 }, "clipNear": 0, "clipRadius": 0, "colorMode": "hcl", "colorReverse": true, "colorScale": "spectral", "colorScheme": "residueindex", "colorValue": 9474192, "cylinderOnly": false, "defaultAssembly": "", "depthWrite": true, "diffuse": 16777215, "diffuseInterior": false, "disableImpostor": false, "disablePicking": false, "flatShaded": false, "interiorColor": 2236962, "interiorDarkening": 0, "lazy": false, "lineOnly": false, "linewidth": 2, "matrix": { "elements": [ 1, 0, 0, 0, 0, 1, 0, 0, 0, 0, 1, 0, 0, 0, 0, 1 ] }, "metalness": 0, "opacity": 1, "openEnded": true, "quality": "high", "radialSegments": 20, "radiusData": {}, "radiusScale": 1, "radiusSize": 0.3, "radiusType": "size", "roughness": 0.4, "sele": "", "side": "double", "sphereDetail": 2, "useInteriorColor": true, "visible": true, "wireframe": false }, "type": "base" }, "2": { "params": { "aspectRatio": 1.5, "assembly": "default", "bondScale": 0.3, "bondSpacing": 0.75, "clipCenter": { "x": 0, "y": 0, "z": 0 }, "clipNear": 0, "clipRadius": 0, "colorMode": "hcl", "colorReverse": false, "colorScale": "", "colorScheme": "element", "colorValue": 9474192, "cylinderOnly": false, "defaultAssembly": "", "depthWrite": true, "diffuse": 16777215, "diffuseInterior": false, "disableImpostor": false, "disablePicking": false, "flatShaded": false, "interiorColor": 2236962, "interiorDarkening": 0, "lazy": false, "lineOnly": false, "linewidth": 2, "matrix": { "elements": [ 1, 0, 0, 0, 0, 1, 0, 0, 0, 0, 1, 0, 0, 0, 0, 1 ] }, "metalness": 0, "multipleBond": "off", "opacity": 1, "openEnded": true, "quality": "high", "radialSegments": 20, "radiusData": {}, "radiusScale": 2, "radiusSize": 0.15, "radiusType": "size", "roughness": 0.4, "sele": "ligand", "side": "double", "sphereDetail": 2, "useInteriorColor": true, "visible": true, "wireframe": false }, "type": "ball+stick" } } }, "_ngl_serialize": false, "_ngl_version": "2.0.0-dev.33", "_scene_position": {}, "_scene_rotation": {}, "background": "white", "count": 11, "frame": 6, "layout": "IPY_MODEL_0b482094a7874712a6e71edfd13c159b", "n_components": 1, "picked": {} } }, "0f612f0ea2c04f1e92347ba27e617ac0": { "model_module": "@jupyter-widgets/controls", "model_module_version": "1.3.0", "model_name": "ImageModel", "state": { "layout": "IPY_MODEL_c924989d21294155b96aa267947f3e0e", "width": "900.0" } }, "0ffd87f0fb804018ae6c8beaf3e4b9e2": { "model_module": "@jupyter-widgets/base", "model_module_version": "1.1.0", "model_name": "LayoutModel", "state": {} }, "1063e45f5c8141198a64127618eec233": { "model_module": "@jupyter-widgets/base", "model_module_version": "1.1.0", "model_name": "LayoutModel", "state": {} }, "161de9839c824109ad97819830138ad6": { "model_module": "@jupyter-widgets/controls", "model_module_version": "1.3.0", "model_name": "ImageModel", "state": { "layout": "IPY_MODEL_d4fcd34506214958ae1b03320a28b31e", "width": "900.0" } }, "16f36daf26c84228b80b3f1183e2b949": { "model_module": "@jupyter-widgets/base", "model_module_version": "1.1.0", "model_name": "LayoutModel", "state": {} }, "18dc1b6579fc4ea99f5f4e8f48ae6856": { "model_module": "@jupyter-widgets/base", "model_module_version": "1.1.0", "model_name": "LayoutModel", "state": {} }, "19ab5886a5f0446ca704dd2801b240a6": { "model_module": "nglview-js-widgets", "model_module_version": "1.1.5", "model_name": "NGLModel", "state": { "_camera_orientation": [ -113.21809775979573, 7.7518804078676755, -1.7056930366847716, 0, 2.12046924763102, 6.036474665020261, -113.31550327615567, 0, -7.648833163504692, -113.06992536789221, -6.166524748688316, 0, -33.1150016784668, -29.30000114440918, -30.564999103546143, 1 ], "_camera_str": "orthographic", "_image_data": "", "_n_dragged_files": 0, "_ngl_coordinate_resource": {}, "_ngl_full_stage_parameters": { "ambientColor": 14540253, "ambientIntensity": 0.2, "backgroundColor": "white", "cameraEyeSep": 0.3, "cameraFov": 40, "cameraType": "perspective", "clipDist": 10, "clipFar": 100, "clipNear": 0, "fogFar": 100, "fogNear": 50, "hoverTimeout": 0, "impostor": true, "lightColor": 14540253, "lightIntensity": 1, "mousePreset": "default", "panSpeed": 1, "quality": "medium", "rotateSpeed": 2, "sampleLevel": 0, "tooltip": true, "workerDefault": true, "zoomSpeed": 1.2 }, "_ngl_full_stage_parameters_embed": {}, "_ngl_msg_archive": [], "_ngl_original_stage_parameters": { "ambientColor": 14540253, "ambientIntensity": 0.2, "backgroundColor": "white", "cameraEyeSep": 0.3, "cameraFov": 40, "cameraType": "perspective", "clipDist": 10, "clipFar": 100, "clipNear": 0, "fogFar": 100, "fogNear": 50, "hoverTimeout": 0, "impostor": true, "lightColor": 14540253, "lightIntensity": 1, "mousePreset": "default", "panSpeed": 1, "quality": "medium", "rotateSpeed": 2, "sampleLevel": 0, "tooltip": true, "workerDefault": true, "zoomSpeed": 1.2 }, "_ngl_repr_dict": { "0": { "0": { "params": { "aspectRatio": 5, "assembly": "default", "capped": true, "clipCenter": { "x": 0, "y": 0, "z": 0 }, "clipNear": 0, "clipRadius": 0, "colorMode": "hcl", "colorReverse": true, "colorScale": "spectral", "colorScheme": "residueindex", "colorValue": 9474192, "defaultAssembly": "", "depthWrite": true, "diffuse": 16777215, "diffuseInterior": false, "disablePicking": false, "flatShaded": false, "interiorColor": 2236962, "interiorDarkening": 0, "lazy": false, "matrix": { "elements": [ 1, 0, 0, 0, 0, 1, 0, 0, 0, 0, 1, 0, 0, 0, 0, 1 ] }, "metalness": 0, "opacity": 1, "quality": "high", "radialSegments": 20, "radiusData": {}, "radiusScale": 0.7, "radiusSize": 1, "radiusType": "sstruc", "roughness": 0.4, "sele": "", "side": "double", "smoothSheet": false, "subdiv": 6, "tension": null, "useInteriorColor": true, "visible": true, "wireframe": false }, "type": "cartoon" }, "1": { "params": { "aspectRatio": 1, "assembly": "default", "bondScale": 0.4, "clipCenter": { "x": 0, "y": 0, "z": 0 }, "clipNear": 0, "clipRadius": 0, "colorMode": "hcl", "colorReverse": true, "colorScale": "spectral", "colorScheme": "residueindex", "colorValue": 9474192, "cylinderOnly": false, "defaultAssembly": "", "depthWrite": true, "diffuse": 16777215, "diffuseInterior": false, "disableImpostor": false, "disablePicking": false, "flatShaded": false, "interiorColor": 2236962, "interiorDarkening": 0, "lazy": false, "lineOnly": false, "linewidth": 2, "matrix": { "elements": [ 1, 0, 0, 0, 0, 1, 0, 0, 0, 0, 1, 0, 0, 0, 0, 1 ] }, "metalness": 0, "opacity": 1, "openEnded": true, "quality": "high", "radialSegments": 20, "radiusData": {}, "radiusScale": 1, "radiusSize": 0.3, "radiusType": "size", "roughness": 0.4, "sele": "", "side": "double", "sphereDetail": 2, "useInteriorColor": true, "visible": true, "wireframe": false }, "type": "base" }, "2": { "params": { "aspectRatio": 1.5, "assembly": "default", "bondScale": 0.3, "bondSpacing": 0.75, "clipCenter": { "x": 0, "y": 0, "z": 0 }, "clipNear": 0, "clipRadius": 0, "colorMode": "hcl", "colorReverse": false, "colorScale": "", "colorScheme": "element", "colorValue": 9474192, "cylinderOnly": false, "defaultAssembly": "", "depthWrite": true, "diffuse": 16777215, "diffuseInterior": false, "disableImpostor": false, "disablePicking": false, "flatShaded": false, "interiorColor": 2236962, "interiorDarkening": 0, "lazy": false, "lineOnly": false, "linewidth": 2, "matrix": { "elements": [ 1, 0, 0, 0, 0, 1, 0, 0, 0, 0, 1, 0, 0, 0, 0, 1 ] }, "metalness": 0, "multipleBond": "off", "opacity": 1, "openEnded": true, "quality": "high", "radialSegments": 20, "radiusData": {}, "radiusScale": 2, "radiusSize": 0.15, "radiusType": "size", "roughness": 0.4, "sele": "ligand", "side": "double", "sphereDetail": 2, "useInteriorColor": true, "visible": true, "wireframe": false }, "type": "ball+stick" } } }, "_ngl_serialize": false, "_ngl_version": "2.0.0-dev.33", "_scene_position": {}, "_scene_rotation": {}, "background": "white", "count": 11, "frame": 9, "layout": "IPY_MODEL_65ad9ca31ff0497d817708f8cf46501a", "n_components": 1, "picked": {} } }, "1e5cb330667840f893a636350fa5faf6": { "model_module": "nglview-js-widgets", "model_module_version": "1.1.5", "model_name": "NGLModel", "state": { "_camera_orientation": [ 154.0282921913179, 0, 0, 0, 0, 154.0282921913179, 0, 0, 0, 0, 154.0282921913179, 0, -55.308000564575195, -35.06250047683716, -28.174999713897705, 1 ], "_camera_str": "orthographic", "_image_data": "", "_n_dragged_files": 0, "_ngl_coordinate_resource": {}, "_ngl_full_stage_parameters": { "ambientColor": 14540253, "ambientIntensity": 0.2, "backgroundColor": "white", "cameraEyeSep": 0.3, "cameraFov": 40, "cameraType": "perspective", "clipDist": 10, "clipFar": 100, "clipNear": 0, "fogFar": 100, "fogNear": 50, "hoverTimeout": 0, "impostor": true, "lightColor": 14540253, "lightIntensity": 1, "mousePreset": "default", "panSpeed": 1, "quality": "medium", "rotateSpeed": 2, "sampleLevel": 0, "tooltip": true, "workerDefault": true, "zoomSpeed": 1.2 }, "_ngl_full_stage_parameters_embed": {}, "_ngl_msg_archive": [], "_ngl_original_stage_parameters": { "ambientColor": 14540253, "ambientIntensity": 0.2, "backgroundColor": "white", "cameraEyeSep": 0.3, "cameraFov": 40, "cameraType": "perspective", "clipDist": 10, "clipFar": 100, "clipNear": 0, "fogFar": 100, "fogNear": 50, "hoverTimeout": 0, "impostor": true, "lightColor": 14540253, "lightIntensity": 1, "mousePreset": "default", "panSpeed": 1, "quality": "medium", "rotateSpeed": 2, "sampleLevel": 0, "tooltip": true, "workerDefault": true, "zoomSpeed": 1.2 }, "_ngl_repr_dict": { "0": { "0": { "params": { "aspectRatio": 5, "assembly": "default", "capped": true, "clipCenter": { "x": 0, "y": 0, "z": 0 }, "clipNear": 0, "clipRadius": 0, "colorMode": "hcl", "colorReverse": true, "colorScale": "spectral", "colorScheme": "residueindex", "colorValue": 9474192, "defaultAssembly": "", "depthWrite": true, "diffuse": 16777215, "diffuseInterior": false, "disablePicking": false, "flatShaded": false, "interiorColor": 2236962, "interiorDarkening": 0, "lazy": false, "matrix": { "elements": [ 1, 0, 0, 0, 0, 1, 0, 0, 0, 0, 1, 0, 0, 0, 0, 1 ] }, "metalness": 0, "opacity": 1, "quality": "high", "radialSegments": 20, "radiusData": {}, "radiusScale": 0.7, "radiusSize": 1, "radiusType": "sstruc", "roughness": 0.4, "sele": "", "side": "double", "smoothSheet": false, "subdiv": 6, "tension": null, "useInteriorColor": true, "visible": true, "wireframe": false }, "type": "cartoon" }, "1": { "params": { "aspectRatio": 1, "assembly": "default", "bondScale": 0.4, "clipCenter": { "x": 0, "y": 0, "z": 0 }, "clipNear": 0, "clipRadius": 0, "colorMode": "hcl", "colorReverse": true, "colorScale": "spectral", "colorScheme": "residueindex", "colorValue": 9474192, "cylinderOnly": false, "defaultAssembly": "", "depthWrite": true, "diffuse": 16777215, "diffuseInterior": false, "disableImpostor": false, "disablePicking": false, "flatShaded": false, "interiorColor": 2236962, "interiorDarkening": 0, "lazy": false, "lineOnly": false, "linewidth": 2, "matrix": { "elements": [ 1, 0, 0, 0, 0, 1, 0, 0, 0, 0, 1, 0, 0, 0, 0, 1 ] }, "metalness": 0, "opacity": 1, "openEnded": true, "quality": "high", "radialSegments": 20, "radiusData": {}, "radiusScale": 1, "radiusSize": 0.3, "radiusType": "size", "roughness": 0.4, "sele": "", "side": "double", "sphereDetail": 2, "useInteriorColor": true, "visible": true, "wireframe": false }, "type": "base" }, "2": { "params": { "aspectRatio": 1.5, "assembly": "default", "bondScale": 0.3, "bondSpacing": 0.75, "clipCenter": { "x": 0, "y": 0, "z": 0 }, "clipNear": 0, "clipRadius": 0, "colorMode": "hcl", "colorReverse": false, "colorScale": "", "colorScheme": "element", "colorValue": 9474192, "cylinderOnly": false, "defaultAssembly": "", "depthWrite": true, "diffuse": 16777215, "diffuseInterior": false, "disableImpostor": false, "disablePicking": false, "flatShaded": false, "interiorColor": 2236962, "interiorDarkening": 0, "lazy": false, "lineOnly": false, "linewidth": 2, "matrix": { "elements": [ 1, 0, 0, 0, 0, 1, 0, 0, 0, 0, 1, 0, 0, 0, 0, 1 ] }, "metalness": 0, "multipleBond": "off", "opacity": 1, "openEnded": true, "quality": "high", "radialSegments": 20, "radiusData": {}, "radiusScale": 2, "radiusSize": 0.15, "radiusType": "size", "roughness": 0.4, "sele": "ligand", "side": "double", "sphereDetail": 2, "useInteriorColor": true, "visible": true, "wireframe": false }, "type": "ball+stick" } } }, "_ngl_serialize": false, "_ngl_version": "2.0.0-dev.33", "_scene_position": {}, "_scene_rotation": {}, "background": "white", "count": 11, "frame": 0, "layout": "IPY_MODEL_16f36daf26c84228b80b3f1183e2b949", "n_components": 1, "picked": {} } }, "22bb5034b42b488a85ca3f004fa54561": { "model_module": "@jupyter-widgets/base", "model_module_version": "1.1.0", "model_name": "LayoutModel", "state": {} }, "2aa84f0ccffc444b847d76d7b56f7e83": { "model_module": "@jupyter-widgets/base", "model_module_version": "1.1.0", "model_name": "LayoutModel", "state": {} }, "2ac70ebcdc2447f5a418aa9fba77db15": { "model_module": "@jupyter-widgets/base", "model_module_version": "1.1.0", "model_name": "LayoutModel", "state": {} }, "2b62aeb879a2422686a950bfb6c79069": { "model_module": "@jupyter-widgets/base", "model_module_version": "1.1.0", "model_name": "LayoutModel", "state": {} }, "33054ded3e674928b1b2d48cf662961c": { "model_module": "nglview-js-widgets", "model_module_version": "1.1.5", "model_name": "NGLModel", "state": { "_camera_orientation": [ -22.948744155792074, 5.829793696836067, -78.07722310722788, 0, -5.062456500037672, 81.0812727510146, 7.542072942652962, 0, 78.13072888991096, 6.96597699819648, -22.444342017608243, 0, -31.88500165939331, -29.30000114440918, -35.6879997253418, 1 ], "_camera_str": "orthographic", "_image_data": "", "_n_dragged_files": 0, "_ngl_coordinate_resource": {}, "_ngl_full_stage_parameters": { "ambientColor": 14540253, "ambientIntensity": 0.2, "backgroundColor": "white", "cameraEyeSep": 0.3, "cameraFov": 40, "cameraType": "perspective", "clipDist": 10, "clipFar": 100, "clipNear": 0, "fogFar": 100, "fogNear": 50, "hoverTimeout": 0, "impostor": true, "lightColor": 14540253, "lightIntensity": 1, "mousePreset": "default", "panSpeed": 1, "quality": "medium", "rotateSpeed": 2, "sampleLevel": 0, "tooltip": true, "workerDefault": true, "zoomSpeed": 1.2 }, "_ngl_full_stage_parameters_embed": {}, "_ngl_msg_archive": [], "_ngl_original_stage_parameters": { "ambientColor": 14540253, "ambientIntensity": 0.2, "backgroundColor": "white", "cameraEyeSep": 0.3, "cameraFov": 40, "cameraType": "perspective", "clipDist": 10, "clipFar": 100, "clipNear": 0, "fogFar": 100, "fogNear": 50, "hoverTimeout": 0, "impostor": true, "lightColor": 14540253, "lightIntensity": 1, "mousePreset": "default", "panSpeed": 1, "quality": "medium", "rotateSpeed": 2, "sampleLevel": 0, "tooltip": true, "workerDefault": true, "zoomSpeed": 1.2 }, "_ngl_repr_dict": { "0": { "0": { "params": { "aspectRatio": 5, "assembly": "default", "capped": true, "clipCenter": { "x": 0, "y": 0, "z": 0 }, "clipNear": 0, "clipRadius": 0, "colorMode": "hcl", "colorReverse": true, "colorScale": "spectral", "colorScheme": "residueindex", "colorValue": 9474192, "defaultAssembly": "", "depthWrite": true, "diffuse": 16777215, "diffuseInterior": false, "disablePicking": false, "flatShaded": false, "interiorColor": 2236962, "interiorDarkening": 0, "lazy": false, "matrix": { "elements": [ 1, 0, 0, 0, 0, 1, 0, 0, 0, 0, 1, 0, 0, 0, 0, 1 ] }, "metalness": 0, "opacity": 1, "quality": "high", "radialSegments": 20, "radiusData": {}, "radiusScale": 0.7, "radiusSize": 1, "radiusType": "sstruc", "roughness": 0.4, "sele": "", "side": "double", "smoothSheet": false, "subdiv": 6, "tension": null, "useInteriorColor": true, "visible": true, "wireframe": false }, "type": "cartoon" }, "1": { "params": { "aspectRatio": 1, "assembly": "default", "bondScale": 0.4, "clipCenter": { "x": 0, "y": 0, "z": 0 }, "clipNear": 0, "clipRadius": 0, "colorMode": "hcl", "colorReverse": true, "colorScale": "spectral", "colorScheme": "residueindex", "colorValue": 9474192, "cylinderOnly": false, "defaultAssembly": "", "depthWrite": true, "diffuse": 16777215, "diffuseInterior": false, "disableImpostor": false, "disablePicking": false, "flatShaded": false, "interiorColor": 2236962, "interiorDarkening": 0, "lazy": false, "lineOnly": false, "linewidth": 2, "matrix": { "elements": [ 1, 0, 0, 0, 0, 1, 0, 0, 0, 0, 1, 0, 0, 0, 0, 1 ] }, "metalness": 0, "opacity": 1, "openEnded": true, "quality": "high", "radialSegments": 20, "radiusData": {}, "radiusScale": 1, "radiusSize": 0.3, "radiusType": "size", "roughness": 0.4, "sele": "", "side": "double", "sphereDetail": 2, "useInteriorColor": true, "visible": true, "wireframe": false }, "type": "base" }, "2": { "params": { "aspectRatio": 1.5, "assembly": "default", "bondScale": 0.3, "bondSpacing": 0.75, "clipCenter": { "x": 0, "y": 0, "z": 0 }, "clipNear": 0, "clipRadius": 0, "colorMode": "hcl", "colorReverse": false, "colorScale": "", "colorScheme": "element", "colorValue": 9474192, "cylinderOnly": false, "defaultAssembly": "", "depthWrite": true, "diffuse": 16777215, "diffuseInterior": false, "disableImpostor": false, "disablePicking": false, "flatShaded": false, "interiorColor": 2236962, "interiorDarkening": 0, "lazy": false, "lineOnly": false, "linewidth": 2, "matrix": { "elements": [ 1, 0, 0, 0, 0, 1, 0, 0, 0, 0, 1, 0, 0, 0, 0, 1 ] }, "metalness": 0, "multipleBond": "off", "opacity": 1, "openEnded": true, "quality": "high", "radialSegments": 20, "radiusData": {}, "radiusScale": 2, "radiusSize": 0.15, "radiusType": "size", "roughness": 0.4, "sele": "ligand", "side": "double", "sphereDetail": 2, "useInteriorColor": true, "visible": true, "wireframe": false }, "type": "ball+stick" } } }, "_ngl_serialize": false, "_ngl_version": "2.0.0-dev.33", "_scene_position": {}, "_scene_rotation": {}, "background": "white", "count": 11, "frame": 0, "layout": "IPY_MODEL_d663bb43cea34d2fad28f68310aeed8e", "n_components": 1, "picked": {} } }, "3323155ec7504c92a7983b3defca6be5": { "model_module": "@jupyter-widgets/controls", "model_module_version": "1.3.0", "model_name": "ImageModel", "state": { "layout": "IPY_MODEL_5958f255cdce47bc879c12745ad9c4c4", "width": "900.0" } }, "3403e1d46e454c6a9d21003d3a8721d0": { "model_module": "@jupyter-widgets/base", "model_module_version": "1.1.0", "model_name": "LayoutModel", "state": {} }, "34132c93b5cd4a98ba119b35029e3e6f": { "model_module": "@jupyter-widgets/base", "model_module_version": "1.1.0", "model_name": "LayoutModel", "state": {} }, "35780bb5bc454e27946305bd60c6836a": { "model_module": "@jupyter-widgets/base", "model_module_version": "1.1.0", "model_name": "LayoutModel", "state": {} }, "3d58b2920b324111bfb16532a905b1cb": { "model_module": "nglview-js-widgets", "model_module_version": "1.1.5", "model_name": "NGLModel", "state": { "_camera_orientation": [ 22.20757362062134, 0.28447763240871143, 139.89627592375254, 0, -139.6449624810271, 8.536570439175986, 22.150320308653512, 0, -8.386500970235142, -141.39049228488884, 1.6188155739731225, 0, -33.1150016784668, -28.684000968933105, -19.93710994720459, 1 ], "_camera_str": "orthographic", "_image_data": "", "_n_dragged_files": 0, "_ngl_coordinate_resource": {}, "_ngl_full_stage_parameters": { "ambientColor": 14540253, "ambientIntensity": 0.2, "backgroundColor": "white", "cameraEyeSep": 0.3, "cameraFov": 40, "cameraType": "perspective", "clipDist": 10, "clipFar": 100, "clipNear": 0, "fogFar": 100, "fogNear": 50, "hoverTimeout": 0, "impostor": true, "lightColor": 14540253, "lightIntensity": 1, "mousePreset": "default", "panSpeed": 1, "quality": "medium", "rotateSpeed": 2, "sampleLevel": 0, "tooltip": true, "workerDefault": true, "zoomSpeed": 1.2 }, "_ngl_full_stage_parameters_embed": {}, "_ngl_msg_archive": [], "_ngl_original_stage_parameters": { "ambientColor": 14540253, "ambientIntensity": 0.2, "backgroundColor": "white", "cameraEyeSep": 0.3, "cameraFov": 40, "cameraType": "perspective", "clipDist": 10, "clipFar": 100, "clipNear": 0, "fogFar": 100, "fogNear": 50, "hoverTimeout": 0, "impostor": true, "lightColor": 14540253, "lightIntensity": 1, "mousePreset": "default", "panSpeed": 1, "quality": "medium", "rotateSpeed": 2, "sampleLevel": 0, "tooltip": true, "workerDefault": true, "zoomSpeed": 1.2 }, "_ngl_repr_dict": { "0": { "0": { "params": { "aspectRatio": 5, "assembly": "default", "capped": true, "clipCenter": { "x": 0, "y": 0, "z": 0 }, "clipNear": 0, "clipRadius": 0, "colorMode": "hcl", "colorReverse": true, "colorScale": "spectral", "colorScheme": "residueindex", "colorValue": 9474192, "defaultAssembly": "", "depthWrite": true, "diffuse": 16777215, "diffuseInterior": false, "disablePicking": false, "flatShaded": false, "interiorColor": 2236962, "interiorDarkening": 0, "lazy": false, "matrix": { "elements": [ 1, 0, 0, 0, 0, 1, 0, 0, 0, 0, 1, 0, 0, 0, 0, 1 ] }, "metalness": 0, "opacity": 1, "quality": "high", "radialSegments": 20, "radiusData": {}, "radiusScale": 0.7, "radiusSize": 1, "radiusType": "sstruc", "roughness": 0.4, "sele": "", "side": "double", "smoothSheet": false, "subdiv": 6, "tension": null, "useInteriorColor": true, "visible": true, "wireframe": false }, "type": "cartoon" }, "1": { "params": { "aspectRatio": 1, "assembly": "default", "bondScale": 0.4, "clipCenter": { "x": 0, "y": 0, "z": 0 }, "clipNear": 0, "clipRadius": 0, "colorMode": "hcl", "colorReverse": true, "colorScale": "spectral", "colorScheme": "residueindex", "colorValue": 9474192, "cylinderOnly": false, "defaultAssembly": "", "depthWrite": true, "diffuse": 16777215, "diffuseInterior": false, "disableImpostor": false, "disablePicking": false, "flatShaded": false, "interiorColor": 2236962, "interiorDarkening": 0, "lazy": false, "lineOnly": false, "linewidth": 2, "matrix": { "elements": [ 1, 0, 0, 0, 0, 1, 0, 0, 0, 0, 1, 0, 0, 0, 0, 1 ] }, "metalness": 0, "opacity": 1, "openEnded": true, "quality": "high", "radialSegments": 20, "radiusData": {}, "radiusScale": 1, "radiusSize": 0.3, "radiusType": "size", "roughness": 0.4, "sele": "", "side": "double", "sphereDetail": 2, "useInteriorColor": true, "visible": true, "wireframe": false }, "type": "base" }, "2": { "params": { "aspectRatio": 1.5, "assembly": "default", "bondScale": 0.3, "bondSpacing": 0.75, "clipCenter": { "x": 0, "y": 0, "z": 0 }, "clipNear": 0, "clipRadius": 0, "colorMode": "hcl", "colorReverse": false, "colorScale": "", "colorScheme": "element", "colorValue": 9474192, "cylinderOnly": false, "defaultAssembly": "", "depthWrite": true, "diffuse": 16777215, "diffuseInterior": false, "disableImpostor": false, "disablePicking": false, "flatShaded": false, "interiorColor": 2236962, "interiorDarkening": 0, "lazy": false, "lineOnly": false, "linewidth": 2, "matrix": { "elements": [ 1, 0, 0, 0, 0, 1, 0, 0, 0, 0, 1, 0, 0, 0, 0, 1 ] }, "metalness": 0, "multipleBond": "off", "opacity": 1, "openEnded": true, "quality": "high", "radialSegments": 20, "radiusData": {}, "radiusScale": 2, "radiusSize": 0.15, "radiusType": "size", "roughness": 0.4, "sele": "ligand", "side": "double", "sphereDetail": 2, "useInteriorColor": true, "visible": true, "wireframe": false }, "type": "ball+stick" } } }, "_ngl_serialize": false, "_ngl_version": "2.0.0-dev.33", "_scene_position": {}, "_scene_rotation": {}, "background": "white", "count": 11, "frame": 4, "layout": "IPY_MODEL_1063e45f5c8141198a64127618eec233", "n_components": 1, "picked": {} } }, "3e853c09445c4b4bb1d08c58e5132db9": { "model_module": "@jupyter-widgets/base", "model_module_version": "1.1.0", "model_name": "LayoutModel", "state": {} }, "3eb7ee4500ae462b8fd7b8c43034eb25": { "model_module": "nglview-js-widgets", "model_module_version": "1.1.5", "model_name": "NGLModel", "state": { "_camera_orientation": [ 68.50025893901895, 0, 0, 0, 0, 68.50025893901895, 0, 0, 0, 0, 68.50025893901895, 0, -51.43800163269043, -35.768001198768616, -35.2930006980896, 1 ], "_camera_str": "orthographic", "_image_data": "", "_n_dragged_files": 0, "_ngl_coordinate_resource": {}, "_ngl_full_stage_parameters": { "ambientColor": 14540253, "ambientIntensity": 0.2, "backgroundColor": "white", "cameraEyeSep": 0.3, "cameraFov": 40, "cameraType": "perspective", "clipDist": 10, "clipFar": 100, "clipNear": 0, "fogFar": 100, "fogNear": 50, "hoverTimeout": 0, "impostor": true, "lightColor": 14540253, "lightIntensity": 1, "mousePreset": "default", "panSpeed": 1, "quality": "medium", "rotateSpeed": 2, "sampleLevel": 0, "tooltip": true, "workerDefault": true, "zoomSpeed": 1.2 }, "_ngl_full_stage_parameters_embed": {}, "_ngl_msg_archive": [], "_ngl_original_stage_parameters": { "ambientColor": 14540253, "ambientIntensity": 0.2, "backgroundColor": "white", "cameraEyeSep": 0.3, "cameraFov": 40, "cameraType": "perspective", "clipDist": 10, "clipFar": 100, "clipNear": 0, "fogFar": 100, "fogNear": 50, "hoverTimeout": 0, "impostor": true, "lightColor": 14540253, "lightIntensity": 1, "mousePreset": "default", "panSpeed": 1, "quality": "medium", "rotateSpeed": 2, "sampleLevel": 0, "tooltip": true, "workerDefault": true, "zoomSpeed": 1.2 }, "_ngl_repr_dict": { "0": { "0": { "params": { "aspectRatio": 5, "assembly": "default", "capped": true, "clipCenter": { "x": 0, "y": 0, "z": 0 }, "clipNear": 0, "clipRadius": 0, "colorMode": "hcl", "colorReverse": true, "colorScale": "spectral", "colorScheme": "residueindex", "colorValue": 9474192, "defaultAssembly": "", "depthWrite": true, "diffuse": 16777215, "diffuseInterior": false, "disablePicking": false, "flatShaded": false, "interiorColor": 2236962, "interiorDarkening": 0, "lazy": false, "matrix": { "elements": [ 1, 0, 0, 0, 0, 1, 0, 0, 0, 0, 1, 0, 0, 0, 0, 1 ] }, "metalness": 0, "opacity": 1, "quality": "high", "radialSegments": 20, "radiusData": {}, "radiusScale": 0.7, "radiusSize": 1, "radiusType": "sstruc", "roughness": 0.4, "sele": "", "side": "double", "smoothSheet": false, "subdiv": 6, "tension": null, "useInteriorColor": true, "visible": true, "wireframe": false }, "type": "cartoon" }, "1": { "params": { "aspectRatio": 1, "assembly": "default", "bondScale": 0.4, "clipCenter": { "x": 0, "y": 0, "z": 0 }, "clipNear": 0, "clipRadius": 0, "colorMode": "hcl", "colorReverse": true, "colorScale": "spectral", "colorScheme": "residueindex", "colorValue": 9474192, "cylinderOnly": false, "defaultAssembly": "", "depthWrite": true, "diffuse": 16777215, "diffuseInterior": false, "disableImpostor": false, "disablePicking": false, "flatShaded": false, "interiorColor": 2236962, "interiorDarkening": 0, "lazy": false, "lineOnly": false, "linewidth": 2, "matrix": { "elements": [ 1, 0, 0, 0, 0, 1, 0, 0, 0, 0, 1, 0, 0, 0, 0, 1 ] }, "metalness": 0, "opacity": 1, "openEnded": true, "quality": "high", "radialSegments": 20, "radiusData": {}, "radiusScale": 1, "radiusSize": 0.3, "radiusType": "size", "roughness": 0.4, "sele": "", "side": "double", "sphereDetail": 2, "useInteriorColor": true, "visible": true, "wireframe": false }, "type": "base" }, "2": { "params": { "aspectRatio": 1.5, "assembly": "default", "bondScale": 0.3, "bondSpacing": 0.75, "clipCenter": { "x": 0, "y": 0, "z": 0 }, "clipNear": 0, "clipRadius": 0, "colorMode": "hcl", "colorReverse": false, "colorScale": "", "colorScheme": "element", "colorValue": 9474192, "cylinderOnly": false, "defaultAssembly": "", "depthWrite": true, "diffuse": 16777215, "diffuseInterior": false, "disableImpostor": false, "disablePicking": false, "flatShaded": false, "interiorColor": 2236962, "interiorDarkening": 0, "lazy": false, "lineOnly": false, "linewidth": 2, "matrix": { "elements": [ 1, 0, 0, 0, 0, 1, 0, 0, 0, 0, 1, 0, 0, 0, 0, 1 ] }, "metalness": 0, "multipleBond": "off", "opacity": 1, "openEnded": true, "quality": "high", "radialSegments": 20, "radiusData": {}, "radiusScale": 2, "radiusSize": 0.15, "radiusType": "size", "roughness": 0.4, "sele": "ligand", "side": "double", "sphereDetail": 2, "useInteriorColor": true, "visible": true, "wireframe": false }, "type": "ball+stick" }, "3": { "params": { "assembly": "default", "bondSpacing": 1, "clipCenter": { "x": 0, "y": 0, "z": 0 }, "clipNear": 0, "clipRadius": 0, "colorMode": "hcl", "colorReverse": false, "colorScale": "", "colorScheme": "element", "colorValue": 9474192, "crossSize": 0.4, "crosses": "lone", "defaultAssembly": "", "depthWrite": true, "diffuse": 16777215, "diffuseInterior": false, "disablePicking": false, "interiorColor": 2236962, "interiorDarkening": 0, "lazy": false, "lines": true, "linewidth": 2, "matrix": { "elements": [ 1, 0, 0, 0, 0, 1, 0, 0, 0, 0, 1, 0, 0, 0, 0, 1 ] }, "multipleBond": "off", "opacity": 1, "quality": "medium", "radiusData": {}, "radiusScale": 1, "radiusSize": 1, "radiusType": "vdw", "sele": "all", "useInteriorColor": false, "visible": true }, "type": "line" } } }, "_ngl_serialize": false, "_ngl_version": "2.0.0-dev.33", "_scene_position": {}, "_scene_rotation": {}, "background": "white", "count": 11, "frame": 0, "layout": "IPY_MODEL_2ac70ebcdc2447f5a418aa9fba77db15", "n_components": 1, "picked": {} } }, "42a80c9f986142d8bf82493898c09015": { "model_module": "@jupyter-widgets/base", "model_module_version": "1.1.0", "model_name": "LayoutModel", "state": {} }, "452ca7ede3c04ce7a686605ecae76c28": { "model_module": "@jupyter-widgets/controls", "model_module_version": "1.3.0", "model_name": "ImageModel", "state": { "layout": "IPY_MODEL_b7a09f8ae1af439ebb8de2a95ccc2fab", "width": "900.0" } }, "487b39f1031d4ea9a2bc2a01924ab15b": { "model_module": "@jupyter-widgets/controls", "model_module_version": "1.3.0", "model_name": "ImageModel", "state": { "layout": "IPY_MODEL_5a46bdb63b2749f09e68480250c23c50", "width": "900.0" } }, "4bef0a4956864608b7e9100244a57319": { "model_module": "nglview-js-widgets", "model_module_version": "1.1.5", "model_name": "NGLModel", "state": { "_camera_orientation": [ 24.955003165539367, 0.21132108115018822, -134.63456073836878, 0, 134.62559578790916, 1.5555185963134603, 24.955783006197667, 0, 1.5679797714855823, -136.91894496417436, 0.07572409807101757, 0, -31.88500165939331, -28.684000968933105, -30.564999103546143, 1 ], "_camera_str": "orthographic", "_image_data": "", "_n_dragged_files": 0, "_ngl_coordinate_resource": {}, "_ngl_full_stage_parameters": { "ambientColor": 14540253, "ambientIntensity": 0.2, "backgroundColor": "white", "cameraEyeSep": 0.3, "cameraFov": 40, "cameraType": "perspective", "clipDist": 10, "clipFar": 100, "clipNear": 0, "fogFar": 100, "fogNear": 50, "hoverTimeout": 0, "impostor": true, "lightColor": 14540253, "lightIntensity": 1, "mousePreset": "default", "panSpeed": 1, "quality": "medium", "rotateSpeed": 2, "sampleLevel": 0, "tooltip": true, "workerDefault": true, "zoomSpeed": 1.2 }, "_ngl_full_stage_parameters_embed": {}, "_ngl_msg_archive": [], "_ngl_original_stage_parameters": { "ambientColor": 14540253, "ambientIntensity": 0.2, "backgroundColor": "white", "cameraEyeSep": 0.3, "cameraFov": 40, "cameraType": "perspective", "clipDist": 10, "clipFar": 100, "clipNear": 0, "fogFar": 100, "fogNear": 50, "hoverTimeout": 0, "impostor": true, "lightColor": 14540253, "lightIntensity": 1, "mousePreset": "default", "panSpeed": 1, "quality": "medium", "rotateSpeed": 2, "sampleLevel": 0, "tooltip": true, "workerDefault": true, "zoomSpeed": 1.2 }, "_ngl_repr_dict": { "0": { "0": { "params": { "aspectRatio": 5, "assembly": "default", "capped": true, "clipCenter": { "x": 0, "y": 0, "z": 0 }, "clipNear": 0, "clipRadius": 0, "colorMode": "hcl", "colorReverse": true, "colorScale": "spectral", "colorScheme": "residueindex", "colorValue": 9474192, "defaultAssembly": "", "depthWrite": true, "diffuse": 16777215, "diffuseInterior": false, "disablePicking": false, "flatShaded": false, "interiorColor": 2236962, "interiorDarkening": 0, "lazy": false, "matrix": { "elements": [ 1, 0, 0, 0, 0, 1, 0, 0, 0, 0, 1, 0, 0, 0, 0, 1 ] }, "metalness": 0, "opacity": 1, "quality": "high", "radialSegments": 20, "radiusData": {}, "radiusScale": 0.7, "radiusSize": 1, "radiusType": "sstruc", "roughness": 0.4, "sele": "", "side": "double", "smoothSheet": false, "subdiv": 6, "tension": null, "useInteriorColor": true, "visible": true, "wireframe": false }, "type": "cartoon" }, "1": { "params": { "aspectRatio": 1, "assembly": "default", "bondScale": 0.4, "clipCenter": { "x": 0, "y": 0, "z": 0 }, "clipNear": 0, "clipRadius": 0, "colorMode": "hcl", "colorReverse": true, "colorScale": "spectral", "colorScheme": "residueindex", "colorValue": 9474192, "cylinderOnly": false, "defaultAssembly": "", "depthWrite": true, "diffuse": 16777215, "diffuseInterior": false, "disableImpostor": false, "disablePicking": false, "flatShaded": false, "interiorColor": 2236962, "interiorDarkening": 0, "lazy": false, "lineOnly": false, "linewidth": 2, "matrix": { "elements": [ 1, 0, 0, 0, 0, 1, 0, 0, 0, 0, 1, 0, 0, 0, 0, 1 ] }, "metalness": 0, "opacity": 1, "openEnded": true, "quality": "high", "radialSegments": 20, "radiusData": {}, "radiusScale": 1, "radiusSize": 0.3, "radiusType": "size", "roughness": 0.4, "sele": "", "side": "double", "sphereDetail": 2, "useInteriorColor": true, "visible": true, "wireframe": false }, "type": "base" }, "2": { "params": { "aspectRatio": 1.5, "assembly": "default", "bondScale": 0.3, "bondSpacing": 0.75, "clipCenter": { "x": 0, "y": 0, "z": 0 }, "clipNear": 0, "clipRadius": 0, "colorMode": "hcl", "colorReverse": false, "colorScale": "", "colorScheme": "element", "colorValue": 9474192, "cylinderOnly": false, "defaultAssembly": "", "depthWrite": true, "diffuse": 16777215, "diffuseInterior": false, "disableImpostor": false, "disablePicking": false, "flatShaded": false, "interiorColor": 2236962, "interiorDarkening": 0, "lazy": false, "lineOnly": false, "linewidth": 2, "matrix": { "elements": [ 1, 0, 0, 0, 0, 1, 0, 0, 0, 0, 1, 0, 0, 0, 0, 1 ] }, "metalness": 0, "multipleBond": "off", "opacity": 1, "openEnded": true, "quality": "high", "radialSegments": 20, "radiusData": {}, "radiusScale": 2, "radiusSize": 0.15, "radiusType": "size", "roughness": 0.4, "sele": "ligand", "side": "double", "sphereDetail": 2, "useInteriorColor": true, "visible": true, "wireframe": false }, "type": "ball+stick" } } }, "_ngl_serialize": false, "_ngl_version": "2.0.0-dev.33", "_scene_position": {}, "_scene_rotation": {}, "background": "white", "count": 11, "frame": 1, "layout": "IPY_MODEL_9b95eb58962b4e7b97fccccf52d11a15", "n_components": 1, "picked": {} } }, "53845f4e909d4f2488f21864ec24eee2": { "model_module": "nglview-js-widgets", "model_module_version": "1.1.5", "model_name": "NGLModel", "state": { "_camera_orientation": [ 134.55923251713745, 0, 0, 0, 0, 134.55923251713745, 0, 0, 0, 0, 134.55923251713745, 0, -31.88500165939331, -29.30000114440918, -35.6879997253418, 1 ], "_camera_str": "orthographic", "_image_data": "", "_n_dragged_files": 0, "_ngl_coordinate_resource": {}, "_ngl_full_stage_parameters": { "ambientColor": 14540253, "ambientIntensity": 0.2, "backgroundColor": "white", "cameraEyeSep": 0.3, "cameraFov": 40, "cameraType": "perspective", "clipDist": 10, "clipFar": 100, "clipNear": 0, "fogFar": 100, "fogNear": 50, "hoverTimeout": 0, "impostor": true, "lightColor": 14540253, "lightIntensity": 1, "mousePreset": "default", "panSpeed": 1, "quality": "medium", "rotateSpeed": 2, "sampleLevel": 0, "tooltip": true, "workerDefault": true, "zoomSpeed": 1.2 }, "_ngl_full_stage_parameters_embed": {}, "_ngl_msg_archive": [], "_ngl_original_stage_parameters": { "ambientColor": 14540253, "ambientIntensity": 0.2, "backgroundColor": "white", "cameraEyeSep": 0.3, "cameraFov": 40, "cameraType": "perspective", "clipDist": 10, "clipFar": 100, "clipNear": 0, "fogFar": 100, "fogNear": 50, "hoverTimeout": 0, "impostor": true, "lightColor": 14540253, "lightIntensity": 1, "mousePreset": "default", "panSpeed": 1, "quality": "medium", "rotateSpeed": 2, "sampleLevel": 0, "tooltip": true, "workerDefault": true, "zoomSpeed": 1.2 }, "_ngl_repr_dict": { "0": { "0": { "params": { "aspectRatio": 5, "assembly": "default", "capped": true, "clipCenter": { "x": 0, "y": 0, "z": 0 }, "clipNear": 0, "clipRadius": 0, "colorMode": "hcl", "colorReverse": true, "colorScale": "spectral", "colorScheme": "residueindex", "colorValue": 9474192, "defaultAssembly": "", "depthWrite": true, "diffuse": 16777215, "diffuseInterior": false, "disablePicking": false, "flatShaded": false, "interiorColor": 2236962, "interiorDarkening": 0, "lazy": false, "matrix": { "elements": [ 1, 0, 0, 0, 0, 1, 0, 0, 0, 0, 1, 0, 0, 0, 0, 1 ] }, "metalness": 0, "opacity": 1, "quality": "high", "radialSegments": 20, "radiusData": {}, "radiusScale": 0.7, "radiusSize": 1, "radiusType": "sstruc", "roughness": 0.4, "sele": "", "side": "double", "smoothSheet": false, "subdiv": 6, "tension": null, "useInteriorColor": true, "visible": true, "wireframe": false }, "type": "cartoon" }, "1": { "params": { "aspectRatio": 1, "assembly": "default", "bondScale": 0.4, "clipCenter": { "x": 0, "y": 0, "z": 0 }, "clipNear": 0, "clipRadius": 0, "colorMode": "hcl", "colorReverse": true, "colorScale": "spectral", "colorScheme": "residueindex", "colorValue": 9474192, "cylinderOnly": false, "defaultAssembly": "", "depthWrite": true, "diffuse": 16777215, "diffuseInterior": false, "disableImpostor": false, "disablePicking": false, "flatShaded": false, "interiorColor": 2236962, "interiorDarkening": 0, "lazy": false, "lineOnly": false, "linewidth": 2, "matrix": { "elements": [ 1, 0, 0, 0, 0, 1, 0, 0, 0, 0, 1, 0, 0, 0, 0, 1 ] }, "metalness": 0, "opacity": 1, "openEnded": true, "quality": "high", "radialSegments": 20, "radiusData": {}, "radiusScale": 1, "radiusSize": 0.3, "radiusType": "size", "roughness": 0.4, "sele": "", "side": "double", "sphereDetail": 2, "useInteriorColor": true, "visible": true, "wireframe": false }, "type": "base" }, "2": { "params": { "aspectRatio": 1.5, "assembly": "default", "bondScale": 0.3, "bondSpacing": 0.75, "clipCenter": { "x": 0, "y": 0, "z": 0 }, "clipNear": 0, "clipRadius": 0, "colorMode": "hcl", "colorReverse": false, "colorScale": "", "colorScheme": "element", "colorValue": 9474192, "cylinderOnly": false, "defaultAssembly": "", "depthWrite": true, "diffuse": 16777215, "diffuseInterior": false, "disableImpostor": false, "disablePicking": false, "flatShaded": false, "interiorColor": 2236962, "interiorDarkening": 0, "lazy": false, "lineOnly": false, "linewidth": 2, "matrix": { "elements": [ 1, 0, 0, 0, 0, 1, 0, 0, 0, 0, 1, 0, 0, 0, 0, 1 ] }, "metalness": 0, "multipleBond": "off", "opacity": 1, "openEnded": true, "quality": "high", "radialSegments": 20, "radiusData": {}, "radiusScale": 2, "radiusSize": 0.15, "radiusType": "size", "roughness": 0.4, "sele": "ligand", "side": "double", "sphereDetail": 2, "useInteriorColor": true, "visible": true, "wireframe": false }, "type": "ball+stick" } } }, "_ngl_serialize": false, "_ngl_version": "2.0.0-dev.33", "_scene_position": {}, "_scene_rotation": {}, "background": "white", "count": 11, "frame": 0, "layout": "IPY_MODEL_86ac4acbfd2b482fb4dd0b0f772011c5", "n_components": 1, "picked": {} } }, "54cd0dd7505c4c0f9fa687d0429d2af5": { "model_module": "nglview-js-widgets", "model_module_version": "1.1.5", "model_name": "NGLModel", "state": { "_camera_orientation": [ 141.38754842796328, 0, 0, 0, 0, 141.38754842796328, 0, 0, 0, 0, 141.38754842796328, 0, -32.17500066757202, -31.635000228881836, -30.564999103546143, 1 ], "_camera_str": "orthographic", "_image_data": "", "_n_dragged_files": 0, "_ngl_coordinate_resource": {}, "_ngl_full_stage_parameters": { "ambientColor": 14540253, "ambientIntensity": 0.2, "backgroundColor": "white", "cameraEyeSep": 0.3, "cameraFov": 40, "cameraType": "perspective", "clipDist": 10, "clipFar": 100, "clipNear": 0, "fogFar": 100, "fogNear": 50, "hoverTimeout": 0, "impostor": true, "lightColor": 14540253, "lightIntensity": 1, "mousePreset": "default", "panSpeed": 1, "quality": "medium", "rotateSpeed": 2, "sampleLevel": 0, "tooltip": true, "workerDefault": true, "zoomSpeed": 1.2 }, "_ngl_full_stage_parameters_embed": {}, "_ngl_msg_archive": [], "_ngl_original_stage_parameters": { "ambientColor": 14540253, "ambientIntensity": 0.2, "backgroundColor": "white", "cameraEyeSep": 0.3, "cameraFov": 40, "cameraType": "perspective", "clipDist": 10, "clipFar": 100, "clipNear": 0, "fogFar": 100, "fogNear": 50, "hoverTimeout": 0, "impostor": true, "lightColor": 14540253, "lightIntensity": 1, "mousePreset": "default", "panSpeed": 1, "quality": "medium", "rotateSpeed": 2, "sampleLevel": 0, "tooltip": true, "workerDefault": true, "zoomSpeed": 1.2 }, "_ngl_repr_dict": { "0": { "0": { "params": { "aspectRatio": 5, "assembly": "default", "capped": true, "clipCenter": { "x": 0, "y": 0, "z": 0 }, "clipNear": 0, "clipRadius": 0, "colorMode": "hcl", "colorReverse": true, "colorScale": "spectral", "colorScheme": "residueindex", "colorValue": 9474192, "defaultAssembly": "", "depthWrite": true, "diffuse": 16777215, "diffuseInterior": false, "disablePicking": false, "flatShaded": false, "interiorColor": 2236962, "interiorDarkening": 0, "lazy": false, "matrix": { "elements": [ 1, 0, 0, 0, 0, 1, 0, 0, 0, 0, 1, 0, 0, 0, 0, 1 ] }, "metalness": 0, "opacity": 1, "quality": "high", "radialSegments": 20, "radiusData": {}, "radiusScale": 0.7, "radiusSize": 1, "radiusType": "sstruc", "roughness": 0.4, "sele": "", "side": "double", "smoothSheet": false, "subdiv": 6, "tension": null, "useInteriorColor": true, "visible": true, "wireframe": false }, "type": "cartoon" }, "1": { "params": { "aspectRatio": 1, "assembly": "default", "bondScale": 0.4, "clipCenter": { "x": 0, "y": 0, "z": 0 }, "clipNear": 0, "clipRadius": 0, "colorMode": "hcl", "colorReverse": true, "colorScale": "spectral", "colorScheme": "residueindex", "colorValue": 9474192, "cylinderOnly": false, "defaultAssembly": "", "depthWrite": true, "diffuse": 16777215, "diffuseInterior": false, "disableImpostor": false, "disablePicking": false, "flatShaded": false, "interiorColor": 2236962, "interiorDarkening": 0, "lazy": false, "lineOnly": false, "linewidth": 2, "matrix": { "elements": [ 1, 0, 0, 0, 0, 1, 0, 0, 0, 0, 1, 0, 0, 0, 0, 1 ] }, "metalness": 0, "opacity": 1, "openEnded": true, "quality": "high", "radialSegments": 20, "radiusData": {}, "radiusScale": 1, "radiusSize": 0.3, "radiusType": "size", "roughness": 0.4, "sele": "", "side": "double", "sphereDetail": 2, "useInteriorColor": true, "visible": true, "wireframe": false }, "type": "base" }, "2": { "params": { "aspectRatio": 1.5, "assembly": "default", "bondScale": 0.3, "bondSpacing": 0.75, "clipCenter": { "x": 0, "y": 0, "z": 0 }, "clipNear": 0, "clipRadius": 0, "colorMode": "hcl", "colorReverse": false, "colorScale": "", "colorScheme": "element", "colorValue": 9474192, "cylinderOnly": false, "defaultAssembly": "", "depthWrite": true, "diffuse": 16777215, "diffuseInterior": false, "disableImpostor": false, "disablePicking": false, "flatShaded": false, "interiorColor": 2236962, "interiorDarkening": 0, "lazy": false, "lineOnly": false, "linewidth": 2, "matrix": { "elements": [ 1, 0, 0, 0, 0, 1, 0, 0, 0, 0, 1, 0, 0, 0, 0, 1 ] }, "metalness": 0, "multipleBond": "off", "opacity": 1, "openEnded": true, "quality": "high", "radialSegments": 20, "radiusData": {}, "radiusScale": 2, "radiusSize": 0.15, "radiusType": "size", "roughness": 0.4, "sele": "ligand", "side": "double", "sphereDetail": 2, "useInteriorColor": true, "visible": true, "wireframe": false }, "type": "ball+stick" } } }, "_ngl_serialize": false, "_ngl_version": "2.0.0-dev.33", "_scene_position": {}, "_scene_rotation": {}, "background": "white", "count": 11, "frame": 0, "layout": "IPY_MODEL_8ea119d3d4614b3882576d1fe36297bf", "n_components": 1, "picked": {} } }, "56f720e374c8479189fc6c3ec3494fcd": { "model_module": "nglview-js-widgets", "model_module_version": "1.1.5", "model_name": "NGLModel", "state": { "_camera_orientation": [ 130.85460643413222, 0, 0, 0, 0, 130.85460643413222, 0, 0, 0, 0, 130.85460643413222, 0, -37.759173278696835, -31.799999237060547, -30.564999103546143, 1 ], "_camera_str": "orthographic", "_image_data": "", "_n_dragged_files": 0, "_ngl_coordinate_resource": {}, "_ngl_full_stage_parameters": { "ambientColor": 14540253, "ambientIntensity": 0.2, "backgroundColor": "white", "cameraEyeSep": 0.3, "cameraFov": 40, "cameraType": "perspective", "clipDist": 10, "clipFar": 100, "clipNear": 0, "fogFar": 100, "fogNear": 50, "hoverTimeout": 0, "impostor": true, "lightColor": 14540253, "lightIntensity": 1, "mousePreset": "default", "panSpeed": 1, "quality": "medium", "rotateSpeed": 2, "sampleLevel": 0, "tooltip": true, "workerDefault": true, "zoomSpeed": 1.2 }, "_ngl_full_stage_parameters_embed": {}, "_ngl_msg_archive": [], "_ngl_original_stage_parameters": { "ambientColor": 14540253, "ambientIntensity": 0.2, "backgroundColor": "white", "cameraEyeSep": 0.3, "cameraFov": 40, "cameraType": "perspective", "clipDist": 10, "clipFar": 100, "clipNear": 0, "fogFar": 100, "fogNear": 50, "hoverTimeout": 0, "impostor": true, "lightColor": 14540253, "lightIntensity": 1, "mousePreset": "default", "panSpeed": 1, "quality": "medium", "rotateSpeed": 2, "sampleLevel": 0, "tooltip": true, "workerDefault": true, "zoomSpeed": 1.2 }, "_ngl_repr_dict": { "0": { "0": { "params": { "aspectRatio": 5, "assembly": "default", "capped": true, "clipCenter": { "x": 0, "y": 0, "z": 0 }, "clipNear": 0, "clipRadius": 0, "colorMode": "hcl", "colorReverse": true, "colorScale": "spectral", "colorScheme": "residueindex", "colorValue": 9474192, "defaultAssembly": "", "depthWrite": true, "diffuse": 16777215, "diffuseInterior": false, "disablePicking": false, "flatShaded": false, "interiorColor": 2236962, "interiorDarkening": 0, "lazy": false, "matrix": { "elements": [ 1, 0, 0, 0, 0, 1, 0, 0, 0, 0, 1, 0, 0, 0, 0, 1 ] }, "metalness": 0, "opacity": 1, "quality": "high", "radialSegments": 20, "radiusData": {}, "radiusScale": 0.7, "radiusSize": 1, "radiusType": "sstruc", "roughness": 0.4, "sele": "", "side": "double", "smoothSheet": false, "subdiv": 6, "tension": null, "useInteriorColor": true, "visible": true, "wireframe": false }, "type": "cartoon" }, "1": { "params": { "aspectRatio": 1, "assembly": "default", "bondScale": 0.4, "clipCenter": { "x": 0, "y": 0, "z": 0 }, "clipNear": 0, "clipRadius": 0, "colorMode": "hcl", "colorReverse": true, "colorScale": "spectral", "colorScheme": "residueindex", "colorValue": 9474192, "cylinderOnly": false, "defaultAssembly": "", "depthWrite": true, "diffuse": 16777215, "diffuseInterior": false, "disableImpostor": false, "disablePicking": false, "flatShaded": false, "interiorColor": 2236962, "interiorDarkening": 0, "lazy": false, "lineOnly": false, "linewidth": 2, "matrix": { "elements": [ 1, 0, 0, 0, 0, 1, 0, 0, 0, 0, 1, 0, 0, 0, 0, 1 ] }, "metalness": 0, "opacity": 1, "openEnded": true, "quality": "high", "radialSegments": 20, "radiusData": {}, "radiusScale": 1, "radiusSize": 0.3, "radiusType": "size", "roughness": 0.4, "sele": "", "side": "double", "sphereDetail": 2, "useInteriorColor": true, "visible": true, "wireframe": false }, "type": "base" }, "2": { "params": { "aspectRatio": 1.5, "assembly": "default", "bondScale": 0.3, "bondSpacing": 0.75, "clipCenter": { "x": 0, "y": 0, "z": 0 }, "clipNear": 0, "clipRadius": 0, "colorMode": "hcl", "colorReverse": false, "colorScale": "", "colorScheme": "element", "colorValue": 9474192, "cylinderOnly": false, "defaultAssembly": "", "depthWrite": true, "diffuse": 16777215, "diffuseInterior": false, "disableImpostor": false, "disablePicking": false, "flatShaded": false, "interiorColor": 2236962, "interiorDarkening": 0, "lazy": false, "lineOnly": false, "linewidth": 2, "matrix": { "elements": [ 1, 0, 0, 0, 0, 1, 0, 0, 0, 0, 1, 0, 0, 0, 0, 1 ] }, "metalness": 0, "multipleBond": "off", "opacity": 1, "openEnded": true, "quality": "high", "radialSegments": 20, "radiusData": {}, "radiusScale": 2, "radiusSize": 0.15, "radiusType": "size", "roughness": 0.4, "sele": "ligand", "side": "double", "sphereDetail": 2, "useInteriorColor": true, "visible": true, "wireframe": false }, "type": "ball+stick" } } }, "_ngl_serialize": false, "_ngl_version": "2.0.0-dev.33", "_scene_position": {}, "_scene_rotation": {}, "background": "white", "count": 11, "frame": 0, "layout": "IPY_MODEL_68a883ca99674a7ab2190cecf19d23d5", "n_components": 1, "picked": {} } }, "5958f255cdce47bc879c12745ad9c4c4": { "model_module": "@jupyter-widgets/base", "model_module_version": "1.1.0", "model_name": "LayoutModel", "state": {} }, "5a46bdb63b2749f09e68480250c23c50": { "model_module": "@jupyter-widgets/base", "model_module_version": "1.1.0", "model_name": "LayoutModel", "state": {} }, "5ace9e7dfc7c4083a5766d1669a0115c": { "model_module": "@jupyter-widgets/controls", "model_module_version": "1.3.0", "model_name": "ImageModel", "state": { "layout": "IPY_MODEL_5cca64833ec34a41a577bb479a5bff2f", "width": "900.0" } }, "5cca64833ec34a41a577bb479a5bff2f": { "model_module": "@jupyter-widgets/base", "model_module_version": "1.1.0", "model_name": "LayoutModel", "state": {} }, "5d0c8dfd171d4fb2ae41a30a2e43bb38": { "model_module": "@jupyter-widgets/base", "model_module_version": "1.1.0", "model_name": "LayoutModel", "state": {} }, "5da5b715ca444ab08ffc548fbb438134": { "model_module": "@jupyter-widgets/controls", "model_module_version": "1.3.0", "model_name": "ImageModel", "state": { "layout": "IPY_MODEL_fbc735e76997480ebc993072d0c99fcd", "width": "900.0" } }, "5e6243889d104ccda0f58b3a7c8b4d91": { "model_module": "@jupyter-widgets/controls", "model_module_version": "1.3.0", "model_name": "ImageModel", "state": { "layout": "IPY_MODEL_c5021148cd5b41c4b13df7d0095f9b6f", "width": "900.0" } }, "6165d45778b24446a453c10df7e24cf4": { "model_module": "@jupyter-widgets/base", "model_module_version": "1.1.0", "model_name": "LayoutModel", "state": {} }, "61dd63abc3e141bdad39502c04173d6d": { "model_module": "@jupyter-widgets/base", "model_module_version": "1.1.0", "model_name": "LayoutModel", "state": {} }, "65236690496541269c4e92f8edc9a42a": { "model_module": "@jupyter-widgets/controls", "model_module_version": "1.3.0", "model_name": "ImageModel", "state": { "layout": "IPY_MODEL_5d0c8dfd171d4fb2ae41a30a2e43bb38", "width": "900.0" } }, "65ad9ca31ff0497d817708f8cf46501a": { "model_module": "@jupyter-widgets/base", "model_module_version": "1.1.0", "model_name": "LayoutModel", "state": {} }, "66e191007246473a876c05919fb1dfae": { "model_module": "@jupyter-widgets/controls", "model_module_version": "1.3.0", "model_name": "ImageModel", "state": { "layout": "IPY_MODEL_6165d45778b24446a453c10df7e24cf4", "width": "900.0" } }, "68a883ca99674a7ab2190cecf19d23d5": { "model_module": "@jupyter-widgets/base", "model_module_version": "1.1.0", "model_name": "LayoutModel", "state": {} }, "68fde71d5bf849ecba1644c85e896243": { "model_module": "@jupyter-widgets/base", "model_module_version": "1.1.0", "model_name": "LayoutModel", "state": {} }, "6c9472eb07a04c2096533d05b1a235b3": { "model_module": "nglview-js-widgets", "model_module_version": "1.1.5", "model_name": "NGLModel", "state": { "_camera_orientation": [ 141.38754842796328, 0, 0, 0, 0, 141.38754842796328, 0, 0, 0, 0, 141.38754842796328, 0, -32.17500066757202, -31.635000228881836, -30.564999103546143, 1 ], "_camera_str": "orthographic", "_image_data": "", "_n_dragged_files": 0, "_ngl_coordinate_resource": {}, "_ngl_full_stage_parameters": { "ambientColor": 14540253, "ambientIntensity": 0.2, "backgroundColor": "white", "cameraEyeSep": 0.3, "cameraFov": 40, "cameraType": "perspective", "clipDist": 10, "clipFar": 100, "clipNear": 0, "fogFar": 100, "fogNear": 50, "hoverTimeout": 0, "impostor": true, "lightColor": 14540253, "lightIntensity": 1, "mousePreset": "default", "panSpeed": 1, "quality": "medium", "rotateSpeed": 2, "sampleLevel": 0, "tooltip": true, "workerDefault": true, "zoomSpeed": 1.2 }, "_ngl_full_stage_parameters_embed": {}, "_ngl_msg_archive": [], "_ngl_original_stage_parameters": { "ambientColor": 14540253, "ambientIntensity": 0.2, "backgroundColor": "white", "cameraEyeSep": 0.3, "cameraFov": 40, "cameraType": "perspective", "clipDist": 10, "clipFar": 100, "clipNear": 0, "fogFar": 100, "fogNear": 50, "hoverTimeout": 0, "impostor": true, "lightColor": 14540253, "lightIntensity": 1, "mousePreset": "default", "panSpeed": 1, "quality": "medium", "rotateSpeed": 2, "sampleLevel": 0, "tooltip": true, "workerDefault": true, "zoomSpeed": 1.2 }, "_ngl_repr_dict": { "0": { "0": { "params": { "aspectRatio": 5, "assembly": "default", "capped": true, "clipCenter": { "x": 0, "y": 0, "z": 0 }, "clipNear": 0, "clipRadius": 0, "colorMode": "hcl", "colorReverse": true, "colorScale": "spectral", "colorScheme": "residueindex", "colorValue": 9474192, "defaultAssembly": "", "depthWrite": true, "diffuse": 16777215, "diffuseInterior": false, "disablePicking": false, "flatShaded": false, "interiorColor": 2236962, "interiorDarkening": 0, "lazy": false, "matrix": { "elements": [ 1, 0, 0, 0, 0, 1, 0, 0, 0, 0, 1, 0, 0, 0, 0, 1 ] }, "metalness": 0, "opacity": 1, "quality": "high", "radialSegments": 20, "radiusData": {}, "radiusScale": 0.7, "radiusSize": 1, "radiusType": "sstruc", "roughness": 0.4, "sele": "", "side": "double", "smoothSheet": false, "subdiv": 6, "tension": null, "useInteriorColor": true, "visible": true, "wireframe": false }, "type": "cartoon" }, "1": { "params": { "aspectRatio": 1, "assembly": "default", "bondScale": 0.4, "clipCenter": { "x": 0, "y": 0, "z": 0 }, "clipNear": 0, "clipRadius": 0, "colorMode": "hcl", "colorReverse": true, "colorScale": "spectral", "colorScheme": "residueindex", "colorValue": 9474192, "cylinderOnly": false, "defaultAssembly": "", "depthWrite": true, "diffuse": 16777215, "diffuseInterior": false, "disableImpostor": false, "disablePicking": false, "flatShaded": false, "interiorColor": 2236962, "interiorDarkening": 0, "lazy": false, "lineOnly": false, "linewidth": 2, "matrix": { "elements": [ 1, 0, 0, 0, 0, 1, 0, 0, 0, 0, 1, 0, 0, 0, 0, 1 ] }, "metalness": 0, "opacity": 1, "openEnded": true, "quality": "high", "radialSegments": 20, "radiusData": {}, "radiusScale": 1, "radiusSize": 0.3, "radiusType": "size", "roughness": 0.4, "sele": "", "side": "double", "sphereDetail": 2, "useInteriorColor": true, "visible": true, "wireframe": false }, "type": "base" }, "2": { "params": { "aspectRatio": 1.5, "assembly": "default", "bondScale": 0.3, "bondSpacing": 0.75, "clipCenter": { "x": 0, "y": 0, "z": 0 }, "clipNear": 0, "clipRadius": 0, "colorMode": "hcl", "colorReverse": false, "colorScale": "", "colorScheme": "element", "colorValue": 9474192, "cylinderOnly": false, "defaultAssembly": "", "depthWrite": true, "diffuse": 16777215, "diffuseInterior": false, "disableImpostor": false, "disablePicking": false, "flatShaded": false, "interiorColor": 2236962, "interiorDarkening": 0, "lazy": false, "lineOnly": false, "linewidth": 2, "matrix": { "elements": [ 1, 0, 0, 0, 0, 1, 0, 0, 0, 0, 1, 0, 0, 0, 0, 1 ] }, "metalness": 0, "multipleBond": "off", "opacity": 1, "openEnded": true, "quality": "high", "radialSegments": 20, "radiusData": {}, "radiusScale": 2, "radiusSize": 0.15, "radiusType": "size", "roughness": 0.4, "sele": "ligand", "side": "double", "sphereDetail": 2, "useInteriorColor": true, "visible": true, "wireframe": false }, "type": "ball+stick" } } }, "_ngl_serialize": false, "_ngl_version": "2.0.0-dev.33", "_scene_position": {}, "_scene_rotation": {}, "background": "white", "count": 11, "frame": 0, "layout": "IPY_MODEL_9affd5de41644e6e8fe164cc3da348c0", "n_components": 1, "picked": {} } }, "6eda528f8c1d4aa387fa3bb30c0a46b7": { "model_module": "nglview-js-widgets", "model_module_version": "1.1.5", "model_name": "NGLModel", "state": { "_camera_orientation": [ 182.49880021419347, 0, 0, 0, 0, 182.49880021419347, 0, 0, 0, 0, 182.49880021419347, 0, -33.1150016784668, -28.684000968933105, -19.93710994720459, 1 ], "_camera_str": "orthographic", "_image_data": "", "_n_dragged_files": 0, "_ngl_coordinate_resource": {}, "_ngl_full_stage_parameters": { "ambientColor": 14540253, "ambientIntensity": 0.2, "backgroundColor": "white", "cameraEyeSep": 0.3, "cameraFov": 40, "cameraType": "perspective", "clipDist": 10, "clipFar": 100, "clipNear": 0, "fogFar": 100, "fogNear": 50, "hoverTimeout": 0, "impostor": true, "lightColor": 14540253, "lightIntensity": 1, "mousePreset": "default", "panSpeed": 1, "quality": "medium", "rotateSpeed": 2, "sampleLevel": 0, "tooltip": true, "workerDefault": true, "zoomSpeed": 1.2 }, "_ngl_full_stage_parameters_embed": {}, "_ngl_msg_archive": [], "_ngl_original_stage_parameters": { "ambientColor": 14540253, "ambientIntensity": 0.2, "backgroundColor": "white", "cameraEyeSep": 0.3, "cameraFov": 40, "cameraType": "perspective", "clipDist": 10, "clipFar": 100, "clipNear": 0, "fogFar": 100, "fogNear": 50, "hoverTimeout": 0, "impostor": true, "lightColor": 14540253, "lightIntensity": 1, "mousePreset": "default", "panSpeed": 1, "quality": "medium", "rotateSpeed": 2, "sampleLevel": 0, "tooltip": true, "workerDefault": true, "zoomSpeed": 1.2 }, "_ngl_repr_dict": { "0": { "0": { "params": { "aspectRatio": 5, "assembly": "default", "capped": true, "clipCenter": { "x": 0, "y": 0, "z": 0 }, "clipNear": 0, "clipRadius": 0, "colorMode": "hcl", "colorReverse": true, "colorScale": "spectral", "colorScheme": "residueindex", "colorValue": 9474192, "defaultAssembly": "", "depthWrite": true, "diffuse": 16777215, "diffuseInterior": false, "disablePicking": false, "flatShaded": false, "interiorColor": 2236962, "interiorDarkening": 0, "lazy": false, "matrix": { "elements": [ 1, 0, 0, 0, 0, 1, 0, 0, 0, 0, 1, 0, 0, 0, 0, 1 ] }, "metalness": 0, "opacity": 1, "quality": "high", "radialSegments": 20, "radiusData": {}, "radiusScale": 0.7, "radiusSize": 1, "radiusType": "sstruc", "roughness": 0.4, "sele": "", "side": "double", "smoothSheet": false, "subdiv": 6, "tension": null, "useInteriorColor": true, "visible": true, "wireframe": false }, "type": "cartoon" }, "1": { "params": { "aspectRatio": 1, "assembly": "default", "bondScale": 0.4, "clipCenter": { "x": 0, "y": 0, "z": 0 }, "clipNear": 0, "clipRadius": 0, "colorMode": "hcl", "colorReverse": true, "colorScale": "spectral", "colorScheme": "residueindex", "colorValue": 9474192, "cylinderOnly": false, "defaultAssembly": "", "depthWrite": true, "diffuse": 16777215, "diffuseInterior": false, "disableImpostor": false, "disablePicking": false, "flatShaded": false, "interiorColor": 2236962, "interiorDarkening": 0, "lazy": false, "lineOnly": false, "linewidth": 2, "matrix": { "elements": [ 1, 0, 0, 0, 0, 1, 0, 0, 0, 0, 1, 0, 0, 0, 0, 1 ] }, "metalness": 0, "opacity": 1, "openEnded": true, "quality": "high", "radialSegments": 20, "radiusData": {}, "radiusScale": 1, "radiusSize": 0.3, "radiusType": "size", "roughness": 0.4, "sele": "", "side": "double", "sphereDetail": 2, "useInteriorColor": true, "visible": true, "wireframe": false }, "type": "base" }, "2": { "params": { "aspectRatio": 1.5, "assembly": "default", "bondScale": 0.3, "bondSpacing": 0.75, "clipCenter": { "x": 0, "y": 0, "z": 0 }, "clipNear": 0, "clipRadius": 0, "colorMode": "hcl", "colorReverse": false, "colorScale": "", "colorScheme": "element", "colorValue": 9474192, "cylinderOnly": false, "defaultAssembly": "", "depthWrite": true, "diffuse": 16777215, "diffuseInterior": false, "disableImpostor": false, "disablePicking": false, "flatShaded": false, "interiorColor": 2236962, "interiorDarkening": 0, "lazy": false, "lineOnly": false, "linewidth": 2, "matrix": { "elements": [ 1, 0, 0, 0, 0, 1, 0, 0, 0, 0, 1, 0, 0, 0, 0, 1 ] }, "metalness": 0, "multipleBond": "off", "opacity": 1, "openEnded": true, "quality": "high", "radialSegments": 20, "radiusData": {}, "radiusScale": 2, "radiusSize": 0.15, "radiusType": "size", "roughness": 0.4, "sele": "ligand", "side": "double", "sphereDetail": 2, "useInteriorColor": true, "visible": true, "wireframe": false }, "type": "ball+stick" } } }, "_ngl_serialize": false, "_ngl_version": "2.0.0-dev.33", "_scene_position": {}, "_scene_rotation": {}, "background": "white", "count": 11, "frame": 0, "layout": "IPY_MODEL_883ce0ce413740ee94d2932aca373373", "n_components": 1, "picked": {} } }, "717fddb0b5ff45a29a88928743070004": { "model_module": "nglview-js-widgets", "model_module_version": "1.1.5", "model_name": "NGLModel", "state": { "_camera_orientation": [ 198.5901609177948, 0, 0, 0, 0, 198.5901609177948, 0, 0, 0, 0, 198.5901609177948, 0, -37.759173278696835, -31.799999237060547, -30.564999103546143, 1 ], "_camera_str": "orthographic", "_image_data": "", "_n_dragged_files": 0, "_ngl_coordinate_resource": {}, "_ngl_full_stage_parameters": { "ambientColor": 14540253, "ambientIntensity": 0.2, "backgroundColor": "white", "cameraEyeSep": 0.3, "cameraFov": 40, "cameraType": "perspective", "clipDist": 10, "clipFar": 100, "clipNear": 0, "fogFar": 100, "fogNear": 50, "hoverTimeout": 0, "impostor": true, "lightColor": 14540253, "lightIntensity": 1, "mousePreset": "default", "panSpeed": 1, "quality": "medium", "rotateSpeed": 2, "sampleLevel": 0, "tooltip": true, "workerDefault": true, "zoomSpeed": 1.2 }, "_ngl_full_stage_parameters_embed": {}, "_ngl_msg_archive": [], "_ngl_original_stage_parameters": { "ambientColor": 14540253, "ambientIntensity": 0.2, "backgroundColor": "white", "cameraEyeSep": 0.3, "cameraFov": 40, "cameraType": "perspective", "clipDist": 10, "clipFar": 100, "clipNear": 0, "fogFar": 100, "fogNear": 50, "hoverTimeout": 0, "impostor": true, "lightColor": 14540253, "lightIntensity": 1, "mousePreset": "default", "panSpeed": 1, "quality": "medium", "rotateSpeed": 2, "sampleLevel": 0, "tooltip": true, "workerDefault": true, "zoomSpeed": 1.2 }, "_ngl_repr_dict": { "0": { "0": { "params": { "aspectRatio": 5, "assembly": "default", "capped": true, "clipCenter": { "x": 0, "y": 0, "z": 0 }, "clipNear": 0, "clipRadius": 0, "colorMode": "hcl", "colorReverse": true, "colorScale": "spectral", "colorScheme": "residueindex", "colorValue": 9474192, "defaultAssembly": "", "depthWrite": true, "diffuse": 16777215, "diffuseInterior": false, "disablePicking": false, "flatShaded": false, "interiorColor": 2236962, "interiorDarkening": 0, "lazy": false, "matrix": { "elements": [ 1, 0, 0, 0, 0, 1, 0, 0, 0, 0, 1, 0, 0, 0, 0, 1 ] }, "metalness": 0, "opacity": 1, "quality": "high", "radialSegments": 20, "radiusData": {}, "radiusScale": 0.7, "radiusSize": 1, "radiusType": "sstruc", "roughness": 0.4, "sele": "", "side": "double", "smoothSheet": false, "subdiv": 6, "tension": null, "useInteriorColor": true, "visible": true, "wireframe": false }, "type": "cartoon" }, "1": { "params": { "aspectRatio": 1, "assembly": "default", "bondScale": 0.4, "clipCenter": { "x": 0, "y": 0, "z": 0 }, "clipNear": 0, "clipRadius": 0, "colorMode": "hcl", "colorReverse": true, "colorScale": "spectral", "colorScheme": "residueindex", "colorValue": 9474192, "cylinderOnly": false, "defaultAssembly": "", "depthWrite": true, "diffuse": 16777215, "diffuseInterior": false, "disableImpostor": false, "disablePicking": false, "flatShaded": false, "interiorColor": 2236962, "interiorDarkening": 0, "lazy": false, "lineOnly": false, "linewidth": 2, "matrix": { "elements": [ 1, 0, 0, 0, 0, 1, 0, 0, 0, 0, 1, 0, 0, 0, 0, 1 ] }, "metalness": 0, "opacity": 1, "openEnded": true, "quality": "high", "radialSegments": 20, "radiusData": {}, "radiusScale": 1, "radiusSize": 0.3, "radiusType": "size", "roughness": 0.4, "sele": "", "side": "double", "sphereDetail": 2, "useInteriorColor": true, "visible": true, "wireframe": false }, "type": "base" }, "2": { "params": { "aspectRatio": 1.5, "assembly": "default", "bondScale": 0.3, "bondSpacing": 0.75, "clipCenter": { "x": 0, "y": 0, "z": 0 }, "clipNear": 0, "clipRadius": 0, "colorMode": "hcl", "colorReverse": false, "colorScale": "", "colorScheme": "element", "colorValue": 9474192, "cylinderOnly": false, "defaultAssembly": "", "depthWrite": true, "diffuse": 16777215, "diffuseInterior": false, "disableImpostor": false, "disablePicking": false, "flatShaded": false, "interiorColor": 2236962, "interiorDarkening": 0, "lazy": false, "lineOnly": false, "linewidth": 2, "matrix": { "elements": [ 1, 0, 0, 0, 0, 1, 0, 0, 0, 0, 1, 0, 0, 0, 0, 1 ] }, "metalness": 0, "multipleBond": "off", "opacity": 1, "openEnded": true, "quality": "high", "radialSegments": 20, "radiusData": {}, "radiusScale": 2, "radiusSize": 0.15, "radiusType": "size", "roughness": 0.4, "sele": "ligand", "side": "double", "sphereDetail": 2, "useInteriorColor": true, "visible": true, "wireframe": false }, "type": "ball+stick" } } }, "_ngl_serialize": false, "_ngl_version": "2.0.0-dev.33", "_scene_position": {}, "_scene_rotation": {}, "background": "white", "count": 11, "frame": 0, "layout": "IPY_MODEL_8ae641036721408f8aac20e1ee1fb3e5", "n_components": 1, "picked": {} } }, "743050f3b12d4394bf712b30f5e21a4b": { "model_module": "@jupyter-widgets/base", "model_module_version": "1.1.0", "model_name": "LayoutModel", "state": {} }, "74ebdcc8a9c4438a9ea12d065b637b9f": { "model_module": "@jupyter-widgets/controls", "model_module_version": "1.3.0", "model_name": "ImageModel", "state": { "layout": "IPY_MODEL_2b62aeb879a2422686a950bfb6c79069", "width": "900.0" } }, "75d37abf7c874960b4bbc92bac73611c": { "model_module": "nglview-js-widgets", "model_module_version": "1.1.5", "model_name": "NGLModel", "state": { "_camera_orientation": [ 142.31654849556446, 2.8513849732628422, -10.82093074987718, 0, 10.899642812660739, -4.06315248733799, 142.2811002651844, 0, 2.53391497801401, -142.66948976515317, -4.268357914386583, 0, -37.45944833888211, -29.46491901767424, -29.333337439423595, 1 ], "_camera_str": "orthographic", "_image_data": "", "_n_dragged_files": 0, "_ngl_coordinate_resource": {}, "_ngl_full_stage_parameters": { "ambientColor": 14540253, "ambientIntensity": 0.2, "backgroundColor": "white", "cameraEyeSep": 0.3, "cameraFov": 40, "cameraType": "perspective", "clipDist": 10, "clipFar": 100, "clipNear": 0, "fogFar": 100, "fogNear": 50, "hoverTimeout": 0, "impostor": true, "lightColor": 14540253, "lightIntensity": 1, "mousePreset": "default", "panSpeed": 1, "quality": "medium", "rotateSpeed": 2, "sampleLevel": 0, "tooltip": true, "workerDefault": true, "zoomSpeed": 1.2 }, "_ngl_full_stage_parameters_embed": {}, "_ngl_msg_archive": [], "_ngl_original_stage_parameters": { "ambientColor": 14540253, "ambientIntensity": 0.2, "backgroundColor": "white", "cameraEyeSep": 0.3, "cameraFov": 40, "cameraType": "perspective", "clipDist": 10, "clipFar": 100, "clipNear": 0, "fogFar": 100, "fogNear": 50, "hoverTimeout": 0, "impostor": true, "lightColor": 14540253, "lightIntensity": 1, "mousePreset": "default", "panSpeed": 1, "quality": "medium", "rotateSpeed": 2, "sampleLevel": 0, "tooltip": true, "workerDefault": true, "zoomSpeed": 1.2 }, "_ngl_repr_dict": { "0": { "0": { "params": { "aspectRatio": 5, "assembly": "default", "capped": true, "clipCenter": { "x": 0, "y": 0, "z": 0 }, "clipNear": 0, "clipRadius": 0, "colorMode": "hcl", "colorReverse": true, "colorScale": "spectral", "colorScheme": "residueindex", "colorValue": 9474192, "defaultAssembly": "", "depthWrite": true, "diffuse": 16777215, "diffuseInterior": false, "disablePicking": false, "flatShaded": false, "interiorColor": 2236962, "interiorDarkening": 0, "lazy": false, "matrix": { "elements": [ 1, 0, 0, 0, 0, 1, 0, 0, 0, 0, 1, 0, 0, 0, 0, 1 ] }, "metalness": 0, "opacity": 1, "quality": "high", "radialSegments": 20, "radiusData": {}, "radiusScale": 0.7, "radiusSize": 1, "radiusType": "sstruc", "roughness": 0.4, "sele": "", "side": "double", "smoothSheet": false, "subdiv": 6, "tension": null, "useInteriorColor": true, "visible": true, "wireframe": false }, "type": "cartoon" }, "1": { "params": { "aspectRatio": 1, "assembly": "default", "bondScale": 0.4, "clipCenter": { "x": 0, "y": 0, "z": 0 }, "clipNear": 0, "clipRadius": 0, "colorMode": "hcl", "colorReverse": true, "colorScale": "spectral", "colorScheme": "residueindex", "colorValue": 9474192, "cylinderOnly": false, "defaultAssembly": "", "depthWrite": true, "diffuse": 16777215, "diffuseInterior": false, "disableImpostor": false, "disablePicking": false, "flatShaded": false, "interiorColor": 2236962, "interiorDarkening": 0, "lazy": false, "lineOnly": false, "linewidth": 2, "matrix": { "elements": [ 1, 0, 0, 0, 0, 1, 0, 0, 0, 0, 1, 0, 0, 0, 0, 1 ] }, "metalness": 0, "opacity": 1, "openEnded": true, "quality": "high", "radialSegments": 20, "radiusData": {}, "radiusScale": 1, "radiusSize": 0.3, "radiusType": "size", "roughness": 0.4, "sele": "", "side": "double", "sphereDetail": 2, "useInteriorColor": true, "visible": true, "wireframe": false }, "type": "base" }, "2": { "params": { "aspectRatio": 1.5, "assembly": "default", "bondScale": 0.3, "bondSpacing": 0.75, "clipCenter": { "x": 0, "y": 0, "z": 0 }, "clipNear": 0, "clipRadius": 0, "colorMode": "hcl", "colorReverse": false, "colorScale": "", "colorScheme": "element", "colorValue": 9474192, "cylinderOnly": false, "defaultAssembly": "", "depthWrite": true, "diffuse": 16777215, "diffuseInterior": false, "disableImpostor": false, "disablePicking": false, "flatShaded": false, "interiorColor": 2236962, "interiorDarkening": 0, "lazy": false, "lineOnly": false, "linewidth": 2, "matrix": { "elements": [ 1, 0, 0, 0, 0, 1, 0, 0, 0, 0, 1, 0, 0, 0, 0, 1 ] }, "metalness": 0, "multipleBond": "off", "opacity": 1, "openEnded": true, "quality": "high", "radialSegments": 20, "radiusData": {}, "radiusScale": 2, "radiusSize": 0.15, "radiusType": "size", "roughness": 0.4, "sele": "ligand", "side": "double", "sphereDetail": 2, "useInteriorColor": true, "visible": true, "wireframe": false }, "type": "ball+stick" } } }, "_ngl_serialize": false, "_ngl_version": "2.0.0-dev.33", "_scene_position": {}, "_scene_rotation": {}, "background": "white", "count": 11, "frame": 1, "layout": "IPY_MODEL_34132c93b5cd4a98ba119b35029e3e6f", "n_components": 1, "picked": {} } }, "763954023f96406ca26592c80727f527": { "model_module": "@jupyter-widgets/base", "model_module_version": "1.1.0", "model_name": "LayoutModel", "state": {} }, "7683624e5ae64756ac938f4b27ee0fd3": { "model_module": "@jupyter-widgets/controls", "model_module_version": "1.3.0", "model_name": "ImageModel", "state": { "layout": "IPY_MODEL_3e853c09445c4b4bb1d08c58e5132db9", "width": "900.0" } }, "7a11b6ce981b471299cf6ca9382d91a6": { "model_module": "@jupyter-widgets/base", "model_module_version": "1.1.0", "model_name": "LayoutModel", "state": {} }, "7c2d596f20144475bc2662bdf00e7fe9": { "model_module": "nglview-js-widgets", "model_module_version": "1.1.5", "model_name": "NGLModel", "state": { "_camera_orientation": [ -155.9144054702982, 21.29172530889145, -1.754957351189527, 0, 21.30083189637556, 153.93572744958027, -24.815028716108348, 0, -1.6407322926467938, -24.822842766888005, -155.39257945476265, 0, -33.1150016784668, -29.30000114440918, -30.564999103546143, 1 ], "_camera_str": "orthographic", "_image_data": "", "_n_dragged_files": 0, "_ngl_coordinate_resource": {}, "_ngl_full_stage_parameters": { "ambientColor": 14540253, "ambientIntensity": 0.2, "backgroundColor": "white", "cameraEyeSep": 0.3, "cameraFov": 40, "cameraType": "perspective", "clipDist": 10, "clipFar": 100, "clipNear": 0, "fogFar": 100, "fogNear": 50, "hoverTimeout": 0, "impostor": true, "lightColor": 14540253, "lightIntensity": 1, "mousePreset": "default", "panSpeed": 1, "quality": "medium", "rotateSpeed": 2, "sampleLevel": 0, "tooltip": true, "workerDefault": true, "zoomSpeed": 1.2 }, "_ngl_full_stage_parameters_embed": {}, "_ngl_msg_archive": [], "_ngl_original_stage_parameters": { "ambientColor": 14540253, "ambientIntensity": 0.2, "backgroundColor": "white", "cameraEyeSep": 0.3, "cameraFov": 40, "cameraType": "perspective", "clipDist": 10, "clipFar": 100, "clipNear": 0, "fogFar": 100, "fogNear": 50, "hoverTimeout": 0, "impostor": true, "lightColor": 14540253, "lightIntensity": 1, "mousePreset": "default", "panSpeed": 1, "quality": "medium", "rotateSpeed": 2, "sampleLevel": 0, "tooltip": true, "workerDefault": true, "zoomSpeed": 1.2 }, "_ngl_repr_dict": { "0": { "0": { "params": { "aspectRatio": 5, "assembly": "default", "capped": true, "clipCenter": { "x": 0, "y": 0, "z": 0 }, "clipNear": 0, "clipRadius": 0, "colorMode": "hcl", "colorReverse": true, "colorScale": "spectral", "colorScheme": "residueindex", "colorValue": 9474192, "defaultAssembly": "", "depthWrite": true, "diffuse": 16777215, "diffuseInterior": false, "disablePicking": false, "flatShaded": false, "interiorColor": 2236962, "interiorDarkening": 0, "lazy": false, "matrix": { "elements": [ 1, 0, 0, 0, 0, 1, 0, 0, 0, 0, 1, 0, 0, 0, 0, 1 ] }, "metalness": 0, "opacity": 1, "quality": "high", "radialSegments": 20, "radiusData": {}, "radiusScale": 0.7, "radiusSize": 1, "radiusType": "sstruc", "roughness": 0.4, "sele": "", "side": "double", "smoothSheet": false, "subdiv": 6, "tension": null, "useInteriorColor": true, "visible": true, "wireframe": false }, "type": "cartoon" }, "1": { "params": { "aspectRatio": 1, "assembly": "default", "bondScale": 0.4, "clipCenter": { "x": 0, "y": 0, "z": 0 }, "clipNear": 0, "clipRadius": 0, "colorMode": "hcl", "colorReverse": true, "colorScale": "spectral", "colorScheme": "residueindex", "colorValue": 9474192, "cylinderOnly": false, "defaultAssembly": "", "depthWrite": true, "diffuse": 16777215, "diffuseInterior": false, "disableImpostor": false, "disablePicking": false, "flatShaded": false, "interiorColor": 2236962, "interiorDarkening": 0, "lazy": false, "lineOnly": false, "linewidth": 2, "matrix": { "elements": [ 1, 0, 0, 0, 0, 1, 0, 0, 0, 0, 1, 0, 0, 0, 0, 1 ] }, "metalness": 0, "opacity": 1, "openEnded": true, "quality": "high", "radialSegments": 20, "radiusData": {}, "radiusScale": 1, "radiusSize": 0.3, "radiusType": "size", "roughness": 0.4, "sele": "", "side": "double", "sphereDetail": 2, "useInteriorColor": true, "visible": true, "wireframe": false }, "type": "base" }, "2": { "params": { "aspectRatio": 1.5, "assembly": "default", "bondScale": 0.3, "bondSpacing": 0.75, "clipCenter": { "x": 0, "y": 0, "z": 0 }, "clipNear": 0, "clipRadius": 0, "colorMode": "hcl", "colorReverse": false, "colorScale": "", "colorScheme": "element", "colorValue": 9474192, "cylinderOnly": false, "defaultAssembly": "", "depthWrite": true, "diffuse": 16777215, "diffuseInterior": false, "disableImpostor": false, "disablePicking": false, "flatShaded": false, "interiorColor": 2236962, "interiorDarkening": 0, "lazy": false, "lineOnly": false, "linewidth": 2, "matrix": { "elements": [ 1, 0, 0, 0, 0, 1, 0, 0, 0, 0, 1, 0, 0, 0, 0, 1 ] }, "metalness": 0, "multipleBond": "off", "opacity": 1, "openEnded": true, "quality": "high", "radialSegments": 20, "radiusData": {}, "radiusScale": 2, "radiusSize": 0.15, "radiusType": "size", "roughness": 0.4, "sele": "ligand", "side": "double", "sphereDetail": 2, "useInteriorColor": true, "visible": true, "wireframe": false }, "type": "ball+stick" } } }, "_ngl_serialize": false, "_ngl_version": "2.0.0-dev.33", "_scene_position": {}, "_scene_rotation": {}, "background": "white", "count": 11, "frame": 5, "layout": "IPY_MODEL_b608df0e63b04ac79fb9f3feb4d0bc5c", "n_components": 1, "picked": {} } }, "84db5839b2814125b0aba56bc487a3f3": { "model_module": "@jupyter-widgets/controls", "model_module_version": "1.3.0", "model_name": "ImageModel", "state": { "layout": "IPY_MODEL_f08c478f91b14996a14bd2bf5672b7fe", "width": "900.0" } }, "85c7c8fff81c463a9a103b2ed309ff0d": { "model_module": "@jupyter-widgets/base", "model_module_version": "1.1.0", "model_name": "LayoutModel", "state": {} }, "86ac4acbfd2b482fb4dd0b0f772011c5": { "model_module": "@jupyter-widgets/base", "model_module_version": "1.1.0", "model_name": "LayoutModel", "state": {} }, "883ce0ce413740ee94d2932aca373373": { "model_module": "@jupyter-widgets/base", "model_module_version": "1.1.0", "model_name": "LayoutModel", "state": {} }, "8ae641036721408f8aac20e1ee1fb3e5": { "model_module": "@jupyter-widgets/base", "model_module_version": "1.1.0", "model_name": "LayoutModel", "state": {} }, "8ea119d3d4614b3882576d1fe36297bf": { "model_module": "@jupyter-widgets/base", "model_module_version": "1.1.0", "model_name": "LayoutModel", "state": {} }, "8ed509cbd39940feba1db1dc4c6b9658": { "model_module": "nglview-js-widgets", "model_module_version": "1.1.5", "model_name": "NGLModel", "state": { "_camera_orientation": [ 130.85460643413222, 0, 0, 0, 0, 130.85460643413222, 0, 0, 0, 0, 130.85460643413222, 0, -37.759173278696835, -31.799999237060547, -30.564999103546143, 1 ], "_camera_str": "orthographic", "_image_data": "", "_n_dragged_files": 0, "_ngl_coordinate_resource": {}, "_ngl_full_stage_parameters": { "ambientColor": 14540253, "ambientIntensity": 0.2, "backgroundColor": "white", "cameraEyeSep": 0.3, "cameraFov": 40, "cameraType": "perspective", "clipDist": 10, "clipFar": 100, "clipNear": 0, "fogFar": 100, "fogNear": 50, "hoverTimeout": 0, "impostor": true, "lightColor": 14540253, "lightIntensity": 1, "mousePreset": "default", "panSpeed": 1, "quality": "medium", "rotateSpeed": 2, "sampleLevel": 0, "tooltip": true, "workerDefault": true, "zoomSpeed": 1.2 }, "_ngl_full_stage_parameters_embed": {}, "_ngl_msg_archive": [], "_ngl_original_stage_parameters": { "ambientColor": 14540253, "ambientIntensity": 0.2, "backgroundColor": "white", "cameraEyeSep": 0.3, "cameraFov": 40, "cameraType": "perspective", "clipDist": 10, "clipFar": 100, "clipNear": 0, "fogFar": 100, "fogNear": 50, "hoverTimeout": 0, "impostor": true, "lightColor": 14540253, "lightIntensity": 1, "mousePreset": "default", "panSpeed": 1, "quality": "medium", "rotateSpeed": 2, "sampleLevel": 0, "tooltip": true, "workerDefault": true, "zoomSpeed": 1.2 }, "_ngl_repr_dict": { "0": { "0": { "params": { "aspectRatio": 5, "assembly": "default", "capped": true, "clipCenter": { "x": 0, "y": 0, "z": 0 }, "clipNear": 0, "clipRadius": 0, "colorMode": "hcl", "colorReverse": true, "colorScale": "spectral", "colorScheme": "residueindex", "colorValue": 9474192, "defaultAssembly": "", "depthWrite": true, "diffuse": 16777215, "diffuseInterior": false, "disablePicking": false, "flatShaded": false, "interiorColor": 2236962, "interiorDarkening": 0, "lazy": false, "matrix": { "elements": [ 1, 0, 0, 0, 0, 1, 0, 0, 0, 0, 1, 0, 0, 0, 0, 1 ] }, "metalness": 0, "opacity": 1, "quality": "high", "radialSegments": 20, "radiusData": {}, "radiusScale": 0.7, "radiusSize": 1, "radiusType": "sstruc", "roughness": 0.4, "sele": "", "side": "double", "smoothSheet": false, "subdiv": 6, "tension": null, "useInteriorColor": true, "visible": true, "wireframe": false }, "type": "cartoon" }, "1": { "params": { "aspectRatio": 1, "assembly": "default", "bondScale": 0.4, "clipCenter": { "x": 0, "y": 0, "z": 0 }, "clipNear": 0, "clipRadius": 0, "colorMode": "hcl", "colorReverse": true, "colorScale": "spectral", "colorScheme": "residueindex", "colorValue": 9474192, "cylinderOnly": false, "defaultAssembly": "", "depthWrite": true, "diffuse": 16777215, "diffuseInterior": false, "disableImpostor": false, "disablePicking": false, "flatShaded": false, "interiorColor": 2236962, "interiorDarkening": 0, "lazy": false, "lineOnly": false, "linewidth": 2, "matrix": { "elements": [ 1, 0, 0, 0, 0, 1, 0, 0, 0, 0, 1, 0, 0, 0, 0, 1 ] }, "metalness": 0, "opacity": 1, "openEnded": true, "quality": "high", "radialSegments": 20, "radiusData": {}, "radiusScale": 1, "radiusSize": 0.3, "radiusType": "size", "roughness": 0.4, "sele": "", "side": "double", "sphereDetail": 2, "useInteriorColor": true, "visible": true, "wireframe": false }, "type": "base" }, "2": { "params": { "aspectRatio": 1.5, "assembly": "default", "bondScale": 0.3, "bondSpacing": 0.75, "clipCenter": { "x": 0, "y": 0, "z": 0 }, "clipNear": 0, "clipRadius": 0, "colorMode": "hcl", "colorReverse": false, "colorScale": "", "colorScheme": "element", "colorValue": 9474192, "cylinderOnly": false, "defaultAssembly": "", "depthWrite": true, "diffuse": 16777215, "diffuseInterior": false, "disableImpostor": false, "disablePicking": false, "flatShaded": false, "interiorColor": 2236962, "interiorDarkening": 0, "lazy": false, "lineOnly": false, "linewidth": 2, "matrix": { "elements": [ 1, 0, 0, 0, 0, 1, 0, 0, 0, 0, 1, 0, 0, 0, 0, 1 ] }, "metalness": 0, "multipleBond": "off", "opacity": 1, "openEnded": true, "quality": "high", "radialSegments": 20, "radiusData": {}, "radiusScale": 2, "radiusSize": 0.15, "radiusType": "size", "roughness": 0.4, "sele": "ligand", "side": "double", "sphereDetail": 2, "useInteriorColor": true, "visible": true, "wireframe": false }, "type": "ball+stick" } } }, "_ngl_serialize": false, "_ngl_version": "2.0.0-dev.33", "_scene_position": {}, "_scene_rotation": {}, "background": "white", "count": 11, "frame": 0, "layout": "IPY_MODEL_bdabd5f714304d3f91651bc5a2e9587f", "n_components": 1, "picked": {} } }, "90a320c4a0244ce0aaa01fc1fa6dce7e": { "model_module": "@jupyter-widgets/controls", "model_module_version": "1.3.0", "model_name": "ImageModel", "state": { "layout": "IPY_MODEL_e5fb22e37ff24950a01a13048804b693", "width": "900.0" } }, "926428a05f6049a2bee146f8edef2be0": { "model_module": "nglview-js-widgets", "model_module_version": "1.1.5", "model_name": "NGLModel", "state": { "_camera_orientation": [ 136.92794386642316, 0, 0, 0, 0, 136.92794386642316, 0, 0, 0, 0, 136.92794386642316, 0, -33.1150016784668, -28.684000968933105, -35.6879997253418, 1 ], "_camera_str": "orthographic", "_image_data": "", "_n_dragged_files": 0, "_ngl_coordinate_resource": {}, "_ngl_full_stage_parameters": { "ambientColor": 14540253, "ambientIntensity": 0.2, "backgroundColor": "white", "cameraEyeSep": 0.3, "cameraFov": 40, "cameraType": "perspective", "clipDist": 10, "clipFar": 100, "clipNear": 0, "fogFar": 100, "fogNear": 50, "hoverTimeout": 0, "impostor": true, "lightColor": 14540253, "lightIntensity": 1, "mousePreset": "default", "panSpeed": 1, "quality": "medium", "rotateSpeed": 2, "sampleLevel": 0, "tooltip": true, "workerDefault": true, "zoomSpeed": 1.2 }, "_ngl_full_stage_parameters_embed": {}, "_ngl_msg_archive": [], "_ngl_original_stage_parameters": { "ambientColor": 14540253, "ambientIntensity": 0.2, "backgroundColor": "white", "cameraEyeSep": 0.3, "cameraFov": 40, "cameraType": "perspective", "clipDist": 10, "clipFar": 100, "clipNear": 0, "fogFar": 100, "fogNear": 50, "hoverTimeout": 0, "impostor": true, "lightColor": 14540253, "lightIntensity": 1, "mousePreset": "default", "panSpeed": 1, "quality": "medium", "rotateSpeed": 2, "sampleLevel": 0, "tooltip": true, "workerDefault": true, "zoomSpeed": 1.2 }, "_ngl_repr_dict": { "0": { "0": { "params": { "aspectRatio": 5, "assembly": "default", "capped": true, "clipCenter": { "x": 0, "y": 0, "z": 0 }, "clipNear": 0, "clipRadius": 0, "colorMode": "hcl", "colorReverse": true, "colorScale": "spectral", "colorScheme": "residueindex", "colorValue": 9474192, "defaultAssembly": "", "depthWrite": true, "diffuse": 16777215, "diffuseInterior": false, "disablePicking": false, "flatShaded": false, "interiorColor": 2236962, "interiorDarkening": 0, "lazy": false, "matrix": { "elements": [ 1, 0, 0, 0, 0, 1, 0, 0, 0, 0, 1, 0, 0, 0, 0, 1 ] }, "metalness": 0, "opacity": 1, "quality": "high", "radialSegments": 20, "radiusData": {}, "radiusScale": 0.7, "radiusSize": 1, "radiusType": "sstruc", "roughness": 0.4, "sele": "", "side": "double", "smoothSheet": false, "subdiv": 6, "tension": null, "useInteriorColor": true, "visible": true, "wireframe": false }, "type": "cartoon" }, "1": { "params": { "aspectRatio": 1, "assembly": "default", "bondScale": 0.4, "clipCenter": { "x": 0, "y": 0, "z": 0 }, "clipNear": 0, "clipRadius": 0, "colorMode": "hcl", "colorReverse": true, "colorScale": "spectral", "colorScheme": "residueindex", "colorValue": 9474192, "cylinderOnly": false, "defaultAssembly": "", "depthWrite": true, "diffuse": 16777215, "diffuseInterior": false, "disableImpostor": false, "disablePicking": false, "flatShaded": false, "interiorColor": 2236962, "interiorDarkening": 0, "lazy": false, "lineOnly": false, "linewidth": 2, "matrix": { "elements": [ 1, 0, 0, 0, 0, 1, 0, 0, 0, 0, 1, 0, 0, 0, 0, 1 ] }, "metalness": 0, "opacity": 1, "openEnded": true, "quality": "high", "radialSegments": 20, "radiusData": {}, "radiusScale": 1, "radiusSize": 0.3, "radiusType": "size", "roughness": 0.4, "sele": "", "side": "double", "sphereDetail": 2, "useInteriorColor": true, "visible": true, "wireframe": false }, "type": "base" }, "2": { "params": { "aspectRatio": 1.5, "assembly": "default", "bondScale": 0.3, "bondSpacing": 0.75, "clipCenter": { "x": 0, "y": 0, "z": 0 }, "clipNear": 0, "clipRadius": 0, "colorMode": "hcl", "colorReverse": false, "colorScale": "", "colorScheme": "element", "colorValue": 9474192, "cylinderOnly": false, "defaultAssembly": "", "depthWrite": true, "diffuse": 16777215, "diffuseInterior": false, "disableImpostor": false, "disablePicking": false, "flatShaded": false, "interiorColor": 2236962, "interiorDarkening": 0, "lazy": false, "lineOnly": false, "linewidth": 2, "matrix": { "elements": [ 1, 0, 0, 0, 0, 1, 0, 0, 0, 0, 1, 0, 0, 0, 0, 1 ] }, "metalness": 0, "multipleBond": "off", "opacity": 1, "openEnded": true, "quality": "high", "radialSegments": 20, "radiusData": {}, "radiusScale": 2, "radiusSize": 0.15, "radiusType": "size", "roughness": 0.4, "sele": "ligand", "side": "double", "sphereDetail": 2, "useInteriorColor": true, "visible": true, "wireframe": false }, "type": "ball+stick" } } }, "_ngl_serialize": false, "_ngl_version": "2.0.0-dev.33", "_scene_position": {}, "_scene_rotation": {}, "background": "white", "count": 11, "frame": 0, "layout": "IPY_MODEL_07299e9188e04a3cab1efd2ce9bfba89", "n_components": 1, "picked": {} } }, "94748aa0328f495095fdb42b187f378f": { "model_module": "@jupyter-widgets/controls", "model_module_version": "1.3.0", "model_name": "ImageModel", "state": { "layout": "IPY_MODEL_61dd63abc3e141bdad39502c04173d6d", "width": "900.0" } }, "96c0c33006f8449bb29a86baf0d42c6b": { "model_module": "@jupyter-widgets/base", "model_module_version": "1.1.0", "model_name": "LayoutModel", "state": {} }, "96e59a0ee2114d9ea5a01928a10e4694": { "model_module": "@jupyter-widgets/controls", "model_module_version": "1.3.0", "model_name": "ImageModel", "state": { "layout": "IPY_MODEL_9937feeb16ef451e811983a9340793de", "width": "900.0" } }, "9937feeb16ef451e811983a9340793de": { "model_module": "@jupyter-widgets/base", "model_module_version": "1.1.0", "model_name": "LayoutModel", "state": {} }, "997991c6cd83470e9c1f70b5332d5105": { "model_module": "@jupyter-widgets/base", "model_module_version": "1.1.0", "model_name": "LayoutModel", "state": {} }, "9affd5de41644e6e8fe164cc3da348c0": { "model_module": "@jupyter-widgets/base", "model_module_version": "1.1.0", "model_name": "LayoutModel", "state": {} }, "9b95eb58962b4e7b97fccccf52d11a15": { "model_module": "@jupyter-widgets/base", "model_module_version": "1.1.0", "model_name": "LayoutModel", "state": {} }, "9e31f14bd4bf4c7ba815b9d1fa8450d6": { "model_module": "@jupyter-widgets/controls", "model_module_version": "1.3.0", "model_name": "ImageModel", "state": { "layout": "IPY_MODEL_0ffd87f0fb804018ae6c8beaf3e4b9e2", "width": "900.0" } }, "9eb8c63fa6b349868780dc627687cf34": { "model_module": "nglview-js-widgets", "model_module_version": "1.1.5", "model_name": "NGLModel", "state": { "_camera_orientation": [ 124.45464469581162, 0, 0, 0, 0, 124.45464469581162, 0, 0, 0, 0, 124.45464469581162, 0, -33.1150016784668, -28.684000968933105, -35.6879997253418, 1 ], "_camera_str": "orthographic", "_image_data": "", "_n_dragged_files": 0, "_ngl_coordinate_resource": {}, "_ngl_full_stage_parameters": { "ambientColor": 14540253, "ambientIntensity": 0.2, "backgroundColor": "white", "cameraEyeSep": 0.3, "cameraFov": 40, "cameraType": "perspective", "clipDist": 10, "clipFar": 100, "clipNear": 0, "fogFar": 100, "fogNear": 50, "hoverTimeout": 0, "impostor": true, "lightColor": 14540253, "lightIntensity": 1, "mousePreset": "default", "panSpeed": 1, "quality": "medium", "rotateSpeed": 2, "sampleLevel": 0, "tooltip": true, "workerDefault": true, "zoomSpeed": 1.2 }, "_ngl_full_stage_parameters_embed": {}, "_ngl_msg_archive": [], "_ngl_original_stage_parameters": { "ambientColor": 14540253, "ambientIntensity": 0.2, "backgroundColor": "white", "cameraEyeSep": 0.3, "cameraFov": 40, "cameraType": "perspective", "clipDist": 10, "clipFar": 100, "clipNear": 0, "fogFar": 100, "fogNear": 50, "hoverTimeout": 0, "impostor": true, "lightColor": 14540253, "lightIntensity": 1, "mousePreset": "default", "panSpeed": 1, "quality": "medium", "rotateSpeed": 2, "sampleLevel": 0, "tooltip": true, "workerDefault": true, "zoomSpeed": 1.2 }, "_ngl_repr_dict": { "0": { "0": { "params": { "aspectRatio": 5, "assembly": "default", "capped": true, "clipCenter": { "x": 0, "y": 0, "z": 0 }, "clipNear": 0, "clipRadius": 0, "colorMode": "hcl", "colorReverse": true, "colorScale": "spectral", "colorScheme": "residueindex", "colorValue": 9474192, "defaultAssembly": "", "depthWrite": true, "diffuse": 16777215, "diffuseInterior": false, "disablePicking": false, "flatShaded": false, "interiorColor": 2236962, "interiorDarkening": 0, "lazy": false, "matrix": { "elements": [ 1, 0, 0, 0, 0, 1, 0, 0, 0, 0, 1, 0, 0, 0, 0, 1 ] }, "metalness": 0, "opacity": 1, "quality": "high", "radialSegments": 20, "radiusData": {}, "radiusScale": 0.7, "radiusSize": 1, "radiusType": "sstruc", "roughness": 0.4, "sele": "", "side": "double", "smoothSheet": false, "subdiv": 6, "tension": null, "useInteriorColor": true, "visible": true, "wireframe": false }, "type": "cartoon" }, "1": { "params": { "aspectRatio": 1, "assembly": "default", "bondScale": 0.4, "clipCenter": { "x": 0, "y": 0, "z": 0 }, "clipNear": 0, "clipRadius": 0, "colorMode": "hcl", "colorReverse": true, "colorScale": "spectral", "colorScheme": "residueindex", "colorValue": 9474192, "cylinderOnly": false, "defaultAssembly": "", "depthWrite": true, "diffuse": 16777215, "diffuseInterior": false, "disableImpostor": false, "disablePicking": false, "flatShaded": false, "interiorColor": 2236962, "interiorDarkening": 0, "lazy": false, "lineOnly": false, "linewidth": 2, "matrix": { "elements": [ 1, 0, 0, 0, 0, 1, 0, 0, 0, 0, 1, 0, 0, 0, 0, 1 ] }, "metalness": 0, "opacity": 1, "openEnded": true, "quality": "high", "radialSegments": 20, "radiusData": {}, "radiusScale": 1, "radiusSize": 0.3, "radiusType": "size", "roughness": 0.4, "sele": "", "side": "double", "sphereDetail": 2, "useInteriorColor": true, "visible": true, "wireframe": false }, "type": "base" }, "2": { "params": { "aspectRatio": 1.5, "assembly": "default", "bondScale": 0.3, "bondSpacing": 0.75, "clipCenter": { "x": 0, "y": 0, "z": 0 }, "clipNear": 0, "clipRadius": 0, "colorMode": "hcl", "colorReverse": false, "colorScale": "", "colorScheme": "element", "colorValue": 9474192, "cylinderOnly": false, "defaultAssembly": "", "depthWrite": true, "diffuse": 16777215, "diffuseInterior": false, "disableImpostor": false, "disablePicking": false, "flatShaded": false, "interiorColor": 2236962, "interiorDarkening": 0, "lazy": false, "lineOnly": false, "linewidth": 2, "matrix": { "elements": [ 1, 0, 0, 0, 0, 1, 0, 0, 0, 0, 1, 0, 0, 0, 0, 1 ] }, "metalness": 0, "multipleBond": "off", "opacity": 1, "openEnded": true, "quality": "high", "radialSegments": 20, "radiusData": {}, "radiusScale": 2, "radiusSize": 0.15, "radiusType": "size", "roughness": 0.4, "sele": "ligand", "side": "double", "sphereDetail": 2, "useInteriorColor": true, "visible": true, "wireframe": false }, "type": "ball+stick" } } }, "_ngl_serialize": false, "_ngl_version": "2.0.0-dev.33", "_scene_position": {}, "_scene_rotation": {}, "background": "white", "count": 11, "frame": 0, "layout": "IPY_MODEL_fc1b830a8f5c4ba592f63e5930df787b", "n_components": 1, "picked": {} } }, "ac5c54240d734639b585274f7a8c6fa2": { "model_module": "@jupyter-widgets/controls", "model_module_version": "1.3.0", "model_name": "ImageModel", "state": { "layout": "IPY_MODEL_7a11b6ce981b471299cf6ca9382d91a6", "width": "900.0" } }, "ad30b56b5ef14903975bb8f39cc5309f": { "model_module": "@jupyter-widgets/base", "model_module_version": "1.1.0", "model_name": "LayoutModel", "state": {} }, "b2ddc9f454c940e5b8588c0dca706dba": { "model_module": "@jupyter-widgets/controls", "model_module_version": "1.3.0", "model_name": "ImageModel", "state": { "layout": "IPY_MODEL_68fde71d5bf849ecba1644c85e896243", "width": "900.0" } }, "b47077bf31014ab1ab78540f58b87a4f": { "model_module": "@jupyter-widgets/controls", "model_module_version": "1.3.0", "model_name": "ImageModel", "state": { "layout": "IPY_MODEL_0942beeb302d4030bb83d2924606febc", "width": "900.0" } }, "b608df0e63b04ac79fb9f3feb4d0bc5c": { "model_module": "@jupyter-widgets/base", "model_module_version": "1.1.0", "model_name": "LayoutModel", "state": {} }, "b69c4864d1ce429cabec44e368dc31c6": { "model_module": "nglview-js-widgets", "model_module_version": "1.1.5", "model_name": "NGLModel", "state": { "_camera_orientation": [ 57.32255639904561, 0, 0, 0, 0, 57.32255639904561, 0, 0, 0, 0, 57.32255639904561, 0, -55.106557846069336, -34.22588539123535, -28.32262134552002, 1 ], "_camera_str": "orthographic", "_image_data": "", "_n_dragged_files": 0, "_ngl_coordinate_resource": {}, "_ngl_full_stage_parameters": { "ambientColor": 14540253, "ambientIntensity": 0.2, "backgroundColor": "white", "cameraEyeSep": 0.3, "cameraFov": 40, "cameraType": "perspective", "clipDist": 10, "clipFar": 100, "clipNear": 0, "fogFar": 100, "fogNear": 50, "hoverTimeout": 0, "impostor": true, "lightColor": 14540253, "lightIntensity": 1, "mousePreset": "default", "panSpeed": 1, "quality": "medium", "rotateSpeed": 2, "sampleLevel": 0, "tooltip": true, "workerDefault": true, "zoomSpeed": 1.2 }, "_ngl_full_stage_parameters_embed": {}, "_ngl_msg_archive": [], "_ngl_original_stage_parameters": { "ambientColor": 14540253, "ambientIntensity": 0.2, "backgroundColor": "white", "cameraEyeSep": 0.3, "cameraFov": 40, "cameraType": "perspective", "clipDist": 10, "clipFar": 100, "clipNear": 0, "fogFar": 100, "fogNear": 50, "hoverTimeout": 0, "impostor": true, "lightColor": 14540253, "lightIntensity": 1, "mousePreset": "default", "panSpeed": 1, "quality": "medium", "rotateSpeed": 2, "sampleLevel": 0, "tooltip": true, "workerDefault": true, "zoomSpeed": 1.2 }, "_ngl_repr_dict": { "0": { "0": { "params": { "aspectRatio": 5, "assembly": "default", "capped": true, "clipCenter": { "x": 0, "y": 0, "z": 0 }, "clipNear": 0, "clipRadius": 0, "colorMode": "hcl", "colorReverse": true, "colorScale": "spectral", "colorScheme": "residueindex", "colorValue": 9474192, "defaultAssembly": "", "depthWrite": true, "diffuse": 16777215, "diffuseInterior": false, "disablePicking": false, "flatShaded": false, "interiorColor": 2236962, "interiorDarkening": 0, "lazy": false, "matrix": { "elements": [ 1, 0, 0, 0, 0, 1, 0, 0, 0, 0, 1, 0, 0, 0, 0, 1 ] }, "metalness": 0, "opacity": 1, "quality": "high", "radialSegments": 20, "radiusData": {}, "radiusScale": 0.7, "radiusSize": 1, "radiusType": "sstruc", "roughness": 0.4, "sele": "", "side": "double", "smoothSheet": false, "subdiv": 6, "tension": null, "useInteriorColor": true, "visible": true, "wireframe": false }, "type": "cartoon" }, "1": { "params": { "aspectRatio": 1, "assembly": "default", "bondScale": 0.4, "clipCenter": { "x": 0, "y": 0, "z": 0 }, "clipNear": 0, "clipRadius": 0, "colorMode": "hcl", "colorReverse": true, "colorScale": "spectral", "colorScheme": "residueindex", "colorValue": 9474192, "cylinderOnly": false, "defaultAssembly": "", "depthWrite": true, "diffuse": 16777215, "diffuseInterior": false, "disableImpostor": false, "disablePicking": false, "flatShaded": false, "interiorColor": 2236962, "interiorDarkening": 0, "lazy": false, "lineOnly": false, "linewidth": 2, "matrix": { "elements": [ 1, 0, 0, 0, 0, 1, 0, 0, 0, 0, 1, 0, 0, 0, 0, 1 ] }, "metalness": 0, "opacity": 1, "openEnded": true, "quality": "high", "radialSegments": 20, "radiusData": {}, "radiusScale": 1, "radiusSize": 0.3, "radiusType": "size", "roughness": 0.4, "sele": "", "side": "double", "sphereDetail": 2, "useInteriorColor": true, "visible": true, "wireframe": false }, "type": "base" }, "2": { "params": { "aspectRatio": 1.5, "assembly": "default", "bondScale": 0.3, "bondSpacing": 0.75, "clipCenter": { "x": 0, "y": 0, "z": 0 }, "clipNear": 0, "clipRadius": 0, "colorMode": "hcl", "colorReverse": false, "colorScale": "", "colorScheme": "element", "colorValue": 9474192, "cylinderOnly": false, "defaultAssembly": "", "depthWrite": true, "diffuse": 16777215, "diffuseInterior": false, "disableImpostor": false, "disablePicking": false, "flatShaded": false, "interiorColor": 2236962, "interiorDarkening": 0, "lazy": false, "lineOnly": false, "linewidth": 2, "matrix": { "elements": [ 1, 0, 0, 0, 0, 1, 0, 0, 0, 0, 1, 0, 0, 0, 0, 1 ] }, "metalness": 0, "multipleBond": "off", "opacity": 1, "openEnded": true, "quality": "high", "radialSegments": 20, "radiusData": {}, "radiusScale": 2, "radiusSize": 0.15, "radiusType": "size", "roughness": 0.4, "sele": "ligand", "side": "double", "sphereDetail": 2, "useInteriorColor": true, "visible": true, "wireframe": false }, "type": "ball+stick" }, "3": { "params": { "assembly": "default", "bondSpacing": 1, "clipCenter": { "x": 0, "y": 0, "z": 0 }, "clipNear": 0, "clipRadius": 0, "colorMode": "hcl", "colorReverse": false, "colorScale": "", "colorScheme": "element", "colorValue": 9474192, "crossSize": 0.4, "crosses": "lone", "defaultAssembly": "", "depthWrite": true, "diffuse": 16777215, "diffuseInterior": false, "disablePicking": false, "interiorColor": 2236962, "interiorDarkening": 0, "lazy": false, "lines": true, "linewidth": 2, "matrix": { "elements": [ 1, 0, 0, 0, 0, 1, 0, 0, 0, 0, 1, 0, 0, 0, 0, 1 ] }, "multipleBond": "off", "opacity": 1, "quality": "medium", "radiusData": {}, "radiusScale": 1, "radiusSize": 1, "radiusType": "vdw", "sele": "all", "useInteriorColor": false, "visible": true }, "type": "line" } } }, "_ngl_serialize": false, "_ngl_version": "2.0.0-dev.33", "_scene_position": {}, "_scene_rotation": {}, "background": "white", "count": 11, "frame": 0, "layout": "IPY_MODEL_85c7c8fff81c463a9a103b2ed309ff0d", "n_components": 1, "picked": {} } }, "b7a09f8ae1af439ebb8de2a95ccc2fab": { "model_module": "@jupyter-widgets/base", "model_module_version": "1.1.0", "model_name": "LayoutModel", "state": {} }, "bab244d87d294dc2affeab3419f11e51": { "model_module": "@jupyter-widgets/controls", "model_module_version": "1.3.0", "model_name": "ImageModel", "state": { "layout": "IPY_MODEL_f92dc1a65b564471b8e32e985a108585", "width": "900.0" } }, "bb9a3309809048a58d5a3090a830c59f": { "model_module": "@jupyter-widgets/base", "model_module_version": "1.1.0", "model_name": "LayoutModel", "state": {} }, "bdabd5f714304d3f91651bc5a2e9587f": { "model_module": "@jupyter-widgets/base", "model_module_version": "1.1.0", "model_name": "LayoutModel", "state": {} }, "bfd69d1066764bf29bd3b0fd17281efc": { "model_module": "nglview-js-widgets", "model_module_version": "1.1.5", "model_name": "NGLModel", "state": { "_camera_orientation": [ -4.751141034653902, -12.232648690546036, -133.91779575726204, 0, 133.8339114846358, -13.50249857775931, -3.5147865485311005, 0, -13.118607059934156, -133.32003560520343, 12.643469090236081, 0, -31.88500165939331, -29.30000114440918, -35.6879997253418, 1 ], "_camera_str": "orthographic", "_image_data": "", "_n_dragged_files": 0, "_ngl_coordinate_resource": {}, "_ngl_full_stage_parameters": { "ambientColor": 14540253, "ambientIntensity": 0.2, "backgroundColor": "white", "cameraEyeSep": 0.3, "cameraFov": 40, "cameraType": "perspective", "clipDist": 10, "clipFar": 100, "clipNear": 0, "fogFar": 100, "fogNear": 50, "hoverTimeout": 0, "impostor": true, "lightColor": 14540253, "lightIntensity": 1, "mousePreset": "default", "panSpeed": 1, "quality": "medium", "rotateSpeed": 2, "sampleLevel": 0, "tooltip": true, "workerDefault": true, "zoomSpeed": 1.2 }, "_ngl_full_stage_parameters_embed": {}, "_ngl_msg_archive": [], "_ngl_original_stage_parameters": { "ambientColor": 14540253, "ambientIntensity": 0.2, "backgroundColor": "white", "cameraEyeSep": 0.3, "cameraFov": 40, "cameraType": "perspective", "clipDist": 10, "clipFar": 100, "clipNear": 0, "fogFar": 100, "fogNear": 50, "hoverTimeout": 0, "impostor": true, "lightColor": 14540253, "lightIntensity": 1, "mousePreset": "default", "panSpeed": 1, "quality": "medium", "rotateSpeed": 2, "sampleLevel": 0, "tooltip": true, "workerDefault": true, "zoomSpeed": 1.2 }, "_ngl_repr_dict": { "0": { "0": { "params": { "aspectRatio": 5, "assembly": "default", "capped": true, "clipCenter": { "x": 0, "y": 0, "z": 0 }, "clipNear": 0, "clipRadius": 0, "colorMode": "hcl", "colorReverse": true, "colorScale": "spectral", "colorScheme": "residueindex", "colorValue": 9474192, "defaultAssembly": "", "depthWrite": true, "diffuse": 16777215, "diffuseInterior": false, "disablePicking": false, "flatShaded": false, "interiorColor": 2236962, "interiorDarkening": 0, "lazy": false, "matrix": { "elements": [ 1, 0, 0, 0, 0, 1, 0, 0, 0, 0, 1, 0, 0, 0, 0, 1 ] }, "metalness": 0, "opacity": 1, "quality": "high", "radialSegments": 20, "radiusData": {}, "radiusScale": 0.7, "radiusSize": 1, "radiusType": "sstruc", "roughness": 0.4, "sele": "", "side": "double", "smoothSheet": false, "subdiv": 6, "tension": null, "useInteriorColor": true, "visible": true, "wireframe": false }, "type": "cartoon" }, "1": { "params": { "aspectRatio": 1, "assembly": "default", "bondScale": 0.4, "clipCenter": { "x": 0, "y": 0, "z": 0 }, "clipNear": 0, "clipRadius": 0, "colorMode": "hcl", "colorReverse": true, "colorScale": "spectral", "colorScheme": "residueindex", "colorValue": 9474192, "cylinderOnly": false, "defaultAssembly": "", "depthWrite": true, "diffuse": 16777215, "diffuseInterior": false, "disableImpostor": false, "disablePicking": false, "flatShaded": false, "interiorColor": 2236962, "interiorDarkening": 0, "lazy": false, "lineOnly": false, "linewidth": 2, "matrix": { "elements": [ 1, 0, 0, 0, 0, 1, 0, 0, 0, 0, 1, 0, 0, 0, 0, 1 ] }, "metalness": 0, "opacity": 1, "openEnded": true, "quality": "high", "radialSegments": 20, "radiusData": {}, "radiusScale": 1, "radiusSize": 0.3, "radiusType": "size", "roughness": 0.4, "sele": "", "side": "double", "sphereDetail": 2, "useInteriorColor": true, "visible": true, "wireframe": false }, "type": "base" }, "2": { "params": { "aspectRatio": 1.5, "assembly": "default", "bondScale": 0.3, "bondSpacing": 0.75, "clipCenter": { "x": 0, "y": 0, "z": 0 }, "clipNear": 0, "clipRadius": 0, "colorMode": "hcl", "colorReverse": false, "colorScale": "", "colorScheme": "element", "colorValue": 9474192, "cylinderOnly": false, "defaultAssembly": "", "depthWrite": true, "diffuse": 16777215, "diffuseInterior": false, "disableImpostor": false, "disablePicking": false, "flatShaded": false, "interiorColor": 2236962, "interiorDarkening": 0, "lazy": false, "lineOnly": false, "linewidth": 2, "matrix": { "elements": [ 1, 0, 0, 0, 0, 1, 0, 0, 0, 0, 1, 0, 0, 0, 0, 1 ] }, "metalness": 0, "multipleBond": "off", "opacity": 1, "openEnded": true, "quality": "high", "radialSegments": 20, "radiusData": {}, "radiusScale": 2, "radiusSize": 0.15, "radiusType": "size", "roughness": 0.4, "sele": "ligand", "side": "double", "sphereDetail": 2, "useInteriorColor": true, "visible": true, "wireframe": false }, "type": "ball+stick" } } }, "_ngl_serialize": false, "_ngl_version": "2.0.0-dev.33", "_scene_position": {}, "_scene_rotation": {}, "background": "white", "count": 11, "frame": 3, "layout": "IPY_MODEL_763954023f96406ca26592c80727f527", "n_components": 1, "picked": {} } }, "c29041f1e8bd4d049512b5e182fe21bb": { "model_module": "@jupyter-widgets/base", "model_module_version": "1.1.0", "model_name": "LayoutModel", "state": {} }, "c3f2df4ef9a74cae8ba4b8fde82e88b3": { "model_module": "@jupyter-widgets/controls", "model_module_version": "1.3.0", "model_name": "ImageModel", "state": { "layout": "IPY_MODEL_22bb5034b42b488a85ca3f004fa54561", "width": "900.0" } }, "c5021148cd5b41c4b13df7d0095f9b6f": { "model_module": "@jupyter-widgets/base", "model_module_version": "1.1.0", "model_name": "LayoutModel", "state": {} }, "c924989d21294155b96aa267947f3e0e": { "model_module": "@jupyter-widgets/base", "model_module_version": "1.1.0", "model_name": "LayoutModel", "state": {} }, "cc9ad054c1df4a5fbee8c50021a48d1b": { "model_module": "nglview-js-widgets", "model_module_version": "1.1.5", "model_name": "NGLModel", "state": { "_camera_orientation": [ 93.06736949075498, -17.68165513523509, -66.06562722024547, 0, -67.22794334620714, -3.1657125403192587, -93.85747274355099, 0, 12.55833037331064, 114.08847719224717, -12.843325209778031, 0, -31.88500165939331, -28.684000968933105, -30.564999103546143, 1 ], "_camera_str": "orthographic", "_image_data": "", "_n_dragged_files": 0, "_ngl_coordinate_resource": {}, "_ngl_full_stage_parameters": { "ambientColor": 14540253, "ambientIntensity": 0.2, "backgroundColor": "white", "cameraEyeSep": 0.3, "cameraFov": 40, "cameraType": "perspective", "clipDist": 10, "clipFar": 100, "clipNear": 0, "fogFar": 100, "fogNear": 50, "hoverTimeout": 0, "impostor": true, "lightColor": 14540253, "lightIntensity": 1, "mousePreset": "default", "panSpeed": 1, "quality": "medium", "rotateSpeed": 2, "sampleLevel": 0, "tooltip": true, "workerDefault": true, "zoomSpeed": 1.2 }, "_ngl_full_stage_parameters_embed": {}, "_ngl_msg_archive": [], "_ngl_original_stage_parameters": { "ambientColor": 14540253, "ambientIntensity": 0.2, "backgroundColor": "white", "cameraEyeSep": 0.3, "cameraFov": 40, "cameraType": "perspective", "clipDist": 10, "clipFar": 100, "clipNear": 0, "fogFar": 100, "fogNear": 50, "hoverTimeout": 0, "impostor": true, "lightColor": 14540253, "lightIntensity": 1, "mousePreset": "default", "panSpeed": 1, "quality": "medium", "rotateSpeed": 2, "sampleLevel": 0, "tooltip": true, "workerDefault": true, "zoomSpeed": 1.2 }, "_ngl_repr_dict": { "0": { "0": { "params": { "aspectRatio": 5, "assembly": "default", "capped": true, "clipCenter": { "x": 0, "y": 0, "z": 0 }, "clipNear": 0, "clipRadius": 0, "colorMode": "hcl", "colorReverse": true, "colorScale": "spectral", "colorScheme": "residueindex", "colorValue": 9474192, "defaultAssembly": "", "depthWrite": true, "diffuse": 16777215, "diffuseInterior": false, "disablePicking": false, "flatShaded": false, "interiorColor": 2236962, "interiorDarkening": 0, "lazy": false, "matrix": { "elements": [ 1, 0, 0, 0, 0, 1, 0, 0, 0, 0, 1, 0, 0, 0, 0, 1 ] }, "metalness": 0, "opacity": 1, "quality": "high", "radialSegments": 20, "radiusData": {}, "radiusScale": 0.7, "radiusSize": 1, "radiusType": "sstruc", "roughness": 0.4, "sele": "", "side": "double", "smoothSheet": false, "subdiv": 6, "tension": null, "useInteriorColor": true, "visible": true, "wireframe": false }, "type": "cartoon" }, "1": { "params": { "aspectRatio": 1, "assembly": "default", "bondScale": 0.4, "clipCenter": { "x": 0, "y": 0, "z": 0 }, "clipNear": 0, "clipRadius": 0, "colorMode": "hcl", "colorReverse": true, "colorScale": "spectral", "colorScheme": "residueindex", "colorValue": 9474192, "cylinderOnly": false, "defaultAssembly": "", "depthWrite": true, "diffuse": 16777215, "diffuseInterior": false, "disableImpostor": false, "disablePicking": false, "flatShaded": false, "interiorColor": 2236962, "interiorDarkening": 0, "lazy": false, "lineOnly": false, "linewidth": 2, "matrix": { "elements": [ 1, 0, 0, 0, 0, 1, 0, 0, 0, 0, 1, 0, 0, 0, 0, 1 ] }, "metalness": 0, "opacity": 1, "openEnded": true, "quality": "high", "radialSegments": 20, "radiusData": {}, "radiusScale": 1, "radiusSize": 0.3, "radiusType": "size", "roughness": 0.4, "sele": "", "side": "double", "sphereDetail": 2, "useInteriorColor": true, "visible": true, "wireframe": false }, "type": "base" }, "2": { "params": { "aspectRatio": 1.5, "assembly": "default", "bondScale": 0.3, "bondSpacing": 0.75, "clipCenter": { "x": 0, "y": 0, "z": 0 }, "clipNear": 0, "clipRadius": 0, "colorMode": "hcl", "colorReverse": false, "colorScale": "", "colorScheme": "element", "colorValue": 9474192, "cylinderOnly": false, "defaultAssembly": "", "depthWrite": true, "diffuse": 16777215, "diffuseInterior": false, "disableImpostor": false, "disablePicking": false, "flatShaded": false, "interiorColor": 2236962, "interiorDarkening": 0, "lazy": false, "lineOnly": false, "linewidth": 2, "matrix": { "elements": [ 1, 0, 0, 0, 0, 1, 0, 0, 0, 0, 1, 0, 0, 0, 0, 1 ] }, "metalness": 0, "multipleBond": "off", "opacity": 1, "openEnded": true, "quality": "high", "radialSegments": 20, "radiusData": {}, "radiusScale": 2, "radiusSize": 0.15, "radiusType": "size", "roughness": 0.4, "sele": "ligand", "side": "double", "sphereDetail": 2, "useInteriorColor": true, "visible": true, "wireframe": false }, "type": "ball+stick" } } }, "_ngl_serialize": false, "_ngl_version": "2.0.0-dev.33", "_scene_position": {}, "_scene_rotation": {}, "background": "white", "count": 11, "frame": 7, "layout": "IPY_MODEL_743050f3b12d4394bf712b30f5e21a4b", "n_components": 1, "picked": {} } }, "cd17a0ebdbd6465b9431e21b7651a77f": { "model_module": "@jupyter-widgets/controls", "model_module_version": "1.3.0", "model_name": "ImageModel", "state": { "layout": "IPY_MODEL_ad30b56b5ef14903975bb8f39cc5309f", "width": "900.0" } }, "cdd285ecba134429b4a6c78c08105fd0": { "model_module": "@jupyter-widgets/controls", "model_module_version": "1.3.0", "model_name": "ImageModel", "state": { "layout": "IPY_MODEL_18dc1b6579fc4ea99f5f4e8f48ae6856", "width": "900.0" } }, "d0c07fbf0a4b467bb5162679c1da7df4": { "model_module": "@jupyter-widgets/controls", "model_module_version": "1.3.0", "model_name": "ImageModel", "state": { "layout": "IPY_MODEL_eac49750d3034c39ab349839382f450a", "width": "900.0" } }, "d2fc62ac2ba4455a857b0873546125f9": { "model_module": "@jupyter-widgets/controls", "model_module_version": "1.3.0", "model_name": "ImageModel", "state": { "layout": "IPY_MODEL_997991c6cd83470e9c1f70b5332d5105", "width": "900.0" } }, "d429ca2f38c949de99585057de45b3c5": { "model_module": "nglview-js-widgets", "model_module_version": "1.1.5", "model_name": "NGLModel", "state": { "_camera_orientation": [ -7.780053090642953, -15.584351307874194, -140.20168609616866, 0, 141.05509588214503, 0.8194021260243528, -7.918492396030022, 0, 1.686628464393674, -140.4149941796065, 15.514467762526099, 0, -27.025002479553223, -23.820002555847168, -39.79854202270508, 1 ], "_camera_str": "orthographic", "_image_data": "", "_n_dragged_files": 0, "_ngl_coordinate_resource": {}, "_ngl_full_stage_parameters": { "ambientColor": 14540253, "ambientIntensity": 0.2, "backgroundColor": "white", "cameraEyeSep": 0.3, "cameraFov": 40, "cameraType": "perspective", "clipDist": 10, "clipFar": 100, "clipNear": 0, "fogFar": 100, "fogNear": 50, "hoverTimeout": 0, "impostor": true, "lightColor": 14540253, "lightIntensity": 1, "mousePreset": "default", "panSpeed": 1, "quality": "medium", "rotateSpeed": 2, "sampleLevel": 0, "tooltip": true, "workerDefault": true, "zoomSpeed": 1.2 }, "_ngl_full_stage_parameters_embed": {}, "_ngl_msg_archive": [], "_ngl_original_stage_parameters": { "ambientColor": 14540253, "ambientIntensity": 0.2, "backgroundColor": "white", "cameraEyeSep": 0.3, "cameraFov": 40, "cameraType": "perspective", "clipDist": 10, "clipFar": 100, "clipNear": 0, "fogFar": 100, "fogNear": 50, "hoverTimeout": 0, "impostor": true, "lightColor": 14540253, "lightIntensity": 1, "mousePreset": "default", "panSpeed": 1, "quality": "medium", "rotateSpeed": 2, "sampleLevel": 0, "tooltip": true, "workerDefault": true, "zoomSpeed": 1.2 }, "_ngl_repr_dict": { "0": { "0": { "params": { "aspectRatio": 5, "assembly": "default", "capped": true, "clipCenter": { "x": 0, "y": 0, "z": 0 }, "clipNear": 0, "clipRadius": 0, "colorMode": "hcl", "colorReverse": true, "colorScale": "spectral", "colorScheme": "residueindex", "colorValue": 9474192, "defaultAssembly": "", "depthWrite": true, "diffuse": 16777215, "diffuseInterior": false, "disablePicking": false, "flatShaded": false, "interiorColor": 2236962, "interiorDarkening": 0, "lazy": false, "matrix": { "elements": [ 1, 0, 0, 0, 0, 1, 0, 0, 0, 0, 1, 0, 0, 0, 0, 1 ] }, "metalness": 0, "opacity": 1, "quality": "high", "radialSegments": 20, "radiusData": {}, "radiusScale": 0.7, "radiusSize": 1, "radiusType": "sstruc", "roughness": 0.4, "sele": "", "side": "double", "smoothSheet": false, "subdiv": 6, "tension": null, "useInteriorColor": true, "visible": true, "wireframe": false }, "type": "cartoon" }, "1": { "params": { "aspectRatio": 1, "assembly": "default", "bondScale": 0.4, "clipCenter": { "x": 0, "y": 0, "z": 0 }, "clipNear": 0, "clipRadius": 0, "colorMode": "hcl", "colorReverse": true, "colorScale": "spectral", "colorScheme": "residueindex", "colorValue": 9474192, "cylinderOnly": false, "defaultAssembly": "", "depthWrite": true, "diffuse": 16777215, "diffuseInterior": false, "disableImpostor": false, "disablePicking": false, "flatShaded": false, "interiorColor": 2236962, "interiorDarkening": 0, "lazy": false, "lineOnly": false, "linewidth": 2, "matrix": { "elements": [ 1, 0, 0, 0, 0, 1, 0, 0, 0, 0, 1, 0, 0, 0, 0, 1 ] }, "metalness": 0, "opacity": 1, "openEnded": true, "quality": "high", "radialSegments": 20, "radiusData": {}, "radiusScale": 1, "radiusSize": 0.3, "radiusType": "size", "roughness": 0.4, "sele": "", "side": "double", "sphereDetail": 2, "useInteriorColor": true, "visible": true, "wireframe": false }, "type": "base" }, "2": { "params": { "aspectRatio": 1.5, "assembly": "default", "bondScale": 0.3, "bondSpacing": 0.75, "clipCenter": { "x": 0, "y": 0, "z": 0 }, "clipNear": 0, "clipRadius": 0, "colorMode": "hcl", "colorReverse": false, "colorScale": "", "colorScheme": "element", "colorValue": 9474192, "cylinderOnly": false, "defaultAssembly": "", "depthWrite": true, "diffuse": 16777215, "diffuseInterior": false, "disableImpostor": false, "disablePicking": false, "flatShaded": false, "interiorColor": 2236962, "interiorDarkening": 0, "lazy": false, "lineOnly": false, "linewidth": 2, "matrix": { "elements": [ 1, 0, 0, 0, 0, 1, 0, 0, 0, 0, 1, 0, 0, 0, 0, 1 ] }, "metalness": 0, "multipleBond": "off", "opacity": 1, "openEnded": true, "quality": "high", "radialSegments": 20, "radiusData": {}, "radiusScale": 2, "radiusSize": 0.15, "radiusType": "size", "roughness": 0.4, "sele": "ligand", "side": "double", "sphereDetail": 2, "useInteriorColor": true, "visible": true, "wireframe": false }, "type": "ball+stick" } } }, "_ngl_serialize": false, "_ngl_version": "2.0.0-dev.33", "_scene_position": {}, "_scene_rotation": {}, "background": "white", "count": 11, "frame": 2, "layout": "IPY_MODEL_bb9a3309809048a58d5a3090a830c59f", "n_components": 1, "picked": { "bond": { "atomIndex1": 4163, "atomIndex2": 4164, "bondOrder": 1 } } } }, "d4fcd34506214958ae1b03320a28b31e": { "model_module": "@jupyter-widgets/base", "model_module_version": "1.1.0", "model_name": "LayoutModel", "state": {} }, "d663bb43cea34d2fad28f68310aeed8e": { "model_module": "@jupyter-widgets/base", "model_module_version": "1.1.0", "model_name": "LayoutModel", "state": {} }, "d6deb6a6b6614389addf1385a9b8c348": { "model_module": "nglview-js-widgets", "model_module_version": "1.1.5", "model_name": "NGLModel", "state": { "_camera_orientation": [ 154.0282921913179, 0, 0, 0, 0, 154.0282921913179, 0, 0, 0, 0, 154.0282921913179, 0, -55.308000564575195, -35.06250047683716, -28.174999713897705, 1 ], "_camera_str": "orthographic", "_image_data": "", "_n_dragged_files": 0, "_ngl_coordinate_resource": {}, "_ngl_full_stage_parameters": { "ambientColor": 14540253, "ambientIntensity": 0.2, "backgroundColor": "white", "cameraEyeSep": 0.3, "cameraFov": 40, "cameraType": "perspective", "clipDist": 10, "clipFar": 100, "clipNear": 0, "fogFar": 100, "fogNear": 50, "hoverTimeout": 0, "impostor": true, "lightColor": 14540253, "lightIntensity": 1, "mousePreset": "default", "panSpeed": 1, "quality": "medium", "rotateSpeed": 2, "sampleLevel": 0, "tooltip": true, "workerDefault": true, "zoomSpeed": 1.2 }, "_ngl_full_stage_parameters_embed": {}, "_ngl_msg_archive": [], "_ngl_original_stage_parameters": { "ambientColor": 14540253, "ambientIntensity": 0.2, "backgroundColor": "white", "cameraEyeSep": 0.3, "cameraFov": 40, "cameraType": "perspective", "clipDist": 10, "clipFar": 100, "clipNear": 0, "fogFar": 100, "fogNear": 50, "hoverTimeout": 0, "impostor": true, "lightColor": 14540253, "lightIntensity": 1, "mousePreset": "default", "panSpeed": 1, "quality": "medium", "rotateSpeed": 2, "sampleLevel": 0, "tooltip": true, "workerDefault": true, "zoomSpeed": 1.2 }, "_ngl_repr_dict": { "0": { "0": { "params": { "aspectRatio": 5, "assembly": "default", "capped": true, "clipCenter": { "x": 0, "y": 0, "z": 0 }, "clipNear": 0, "clipRadius": 0, "colorMode": "hcl", "colorReverse": true, "colorScale": "spectral", "colorScheme": "residueindex", "colorValue": 9474192, "defaultAssembly": "", "depthWrite": true, "diffuse": 16777215, "diffuseInterior": false, "disablePicking": false, "flatShaded": false, "interiorColor": 2236962, "interiorDarkening": 0, "lazy": false, "matrix": { "elements": [ 1, 0, 0, 0, 0, 1, 0, 0, 0, 0, 1, 0, 0, 0, 0, 1 ] }, "metalness": 0, "opacity": 1, "quality": "high", "radialSegments": 20, "radiusData": {}, "radiusScale": 0.7, "radiusSize": 1, "radiusType": "sstruc", "roughness": 0.4, "sele": "", "side": "double", "smoothSheet": false, "subdiv": 6, "tension": null, "useInteriorColor": true, "visible": true, "wireframe": false }, "type": "cartoon" }, "1": { "params": { "aspectRatio": 1, "assembly": "default", "bondScale": 0.4, "clipCenter": { "x": 0, "y": 0, "z": 0 }, "clipNear": 0, "clipRadius": 0, "colorMode": "hcl", "colorReverse": true, "colorScale": "spectral", "colorScheme": "residueindex", "colorValue": 9474192, "cylinderOnly": false, "defaultAssembly": "", "depthWrite": true, "diffuse": 16777215, "diffuseInterior": false, "disableImpostor": false, "disablePicking": false, "flatShaded": false, "interiorColor": 2236962, "interiorDarkening": 0, "lazy": false, "lineOnly": false, "linewidth": 2, "matrix": { "elements": [ 1, 0, 0, 0, 0, 1, 0, 0, 0, 0, 1, 0, 0, 0, 0, 1 ] }, "metalness": 0, "opacity": 1, "openEnded": true, "quality": "high", "radialSegments": 20, "radiusData": {}, "radiusScale": 1, "radiusSize": 0.3, "radiusType": "size", "roughness": 0.4, "sele": "", "side": "double", "sphereDetail": 2, "useInteriorColor": true, "visible": true, "wireframe": false }, "type": "base" }, "2": { "params": { "aspectRatio": 1.5, "assembly": "default", "bondScale": 0.3, "bondSpacing": 0.75, "clipCenter": { "x": 0, "y": 0, "z": 0 }, "clipNear": 0, "clipRadius": 0, "colorMode": "hcl", "colorReverse": false, "colorScale": "", "colorScheme": "element", "colorValue": 9474192, "cylinderOnly": false, "defaultAssembly": "", "depthWrite": true, "diffuse": 16777215, "diffuseInterior": false, "disableImpostor": false, "disablePicking": false, "flatShaded": false, "interiorColor": 2236962, "interiorDarkening": 0, "lazy": false, "lineOnly": false, "linewidth": 2, "matrix": { "elements": [ 1, 0, 0, 0, 0, 1, 0, 0, 0, 0, 1, 0, 0, 0, 0, 1 ] }, "metalness": 0, "multipleBond": "off", "opacity": 1, "openEnded": true, "quality": "high", "radialSegments": 20, "radiusData": {}, "radiusScale": 2, "radiusSize": 0.15, "radiusType": "size", "roughness": 0.4, "sele": "ligand", "side": "double", "sphereDetail": 2, "useInteriorColor": true, "visible": true, "wireframe": false }, "type": "ball+stick" } } }, "_ngl_serialize": false, "_ngl_version": "2.0.0-dev.33", "_scene_position": {}, "_scene_rotation": {}, "background": "white", "count": 11, "frame": 0, "layout": "IPY_MODEL_35780bb5bc454e27946305bd60c6836a", "n_components": 1, "picked": {} } }, "d8a806ec68724d12adac92ab07f1f288": { "model_module": "@jupyter-widgets/base", "model_module_version": "1.1.0", "model_name": "LayoutModel", "state": {} }, "db0e0680e3aa41db80fed62149a998e8": { "model_module": "nglview-js-widgets", "model_module_version": "1.1.5", "model_name": "NGLModel", "state": { "_camera_orientation": [ 105.07975825085148, 13.149751442270679, -86.80201741753733, 0, 79.29543410740638, 43.889075987439185, 102.64134120076666, 0, 37.67944161563381, -129.03524646692713, 26.065813502723078, 0, -32.044702876312215, -27.768062897015856, -35.637362117307646, 1 ], "_camera_str": "orthographic", "_image_data": "", "_n_dragged_files": 0, "_ngl_coordinate_resource": {}, "_ngl_full_stage_parameters": { "ambientColor": 14540253, "ambientIntensity": 0.2, "backgroundColor": "white", "cameraEyeSep": 0.3, "cameraFov": 40, "cameraType": "perspective", "clipDist": 10, "clipFar": 100, "clipNear": 0, "fogFar": 100, "fogNear": 50, "hoverTimeout": 0, "impostor": true, "lightColor": 14540253, "lightIntensity": 1, "mousePreset": "default", "panSpeed": 1, "quality": "medium", "rotateSpeed": 2, "sampleLevel": 0, "tooltip": true, "workerDefault": true, "zoomSpeed": 1.2 }, "_ngl_full_stage_parameters_embed": {}, "_ngl_msg_archive": [], "_ngl_original_stage_parameters": { "ambientColor": 14540253, "ambientIntensity": 0.2, "backgroundColor": "white", "cameraEyeSep": 0.3, "cameraFov": 40, "cameraType": "perspective", "clipDist": 10, "clipFar": 100, "clipNear": 0, "fogFar": 100, "fogNear": 50, "hoverTimeout": 0, "impostor": true, "lightColor": 14540253, "lightIntensity": 1, "mousePreset": "default", "panSpeed": 1, "quality": "medium", "rotateSpeed": 2, "sampleLevel": 0, "tooltip": true, "workerDefault": true, "zoomSpeed": 1.2 }, "_ngl_repr_dict": { "0": { "0": { "params": { "aspectRatio": 5, "assembly": "default", "capped": true, "clipCenter": { "x": 0, "y": 0, "z": 0 }, "clipNear": 0, "clipRadius": 0, "colorMode": "hcl", "colorReverse": true, "colorScale": "spectral", "colorScheme": "residueindex", "colorValue": 9474192, "defaultAssembly": "", "depthWrite": true, "diffuse": 16777215, "diffuseInterior": false, "disablePicking": false, "flatShaded": false, "interiorColor": 2236962, "interiorDarkening": 0, "lazy": false, "matrix": { "elements": [ 1, 0, 0, 0, 0, 1, 0, 0, 0, 0, 1, 0, 0, 0, 0, 1 ] }, "metalness": 0, "opacity": 1, "quality": "high", "radialSegments": 20, "radiusData": {}, "radiusScale": 0.7, "radiusSize": 1, "radiusType": "sstruc", "roughness": 0.4, "sele": "", "side": "double", "smoothSheet": false, "subdiv": 6, "tension": null, "useInteriorColor": true, "visible": true, "wireframe": false }, "type": "cartoon" }, "1": { "params": { "aspectRatio": 1, "assembly": "default", "bondScale": 0.4, "clipCenter": { "x": 0, "y": 0, "z": 0 }, "clipNear": 0, "clipRadius": 0, "colorMode": "hcl", "colorReverse": true, "colorScale": "spectral", "colorScheme": "residueindex", "colorValue": 9474192, "cylinderOnly": false, "defaultAssembly": "", "depthWrite": true, "diffuse": 16777215, "diffuseInterior": false, "disableImpostor": false, "disablePicking": false, "flatShaded": false, "interiorColor": 2236962, "interiorDarkening": 0, "lazy": false, "lineOnly": false, "linewidth": 2, "matrix": { "elements": [ 1, 0, 0, 0, 0, 1, 0, 0, 0, 0, 1, 0, 0, 0, 0, 1 ] }, "metalness": 0, "opacity": 1, "openEnded": true, "quality": "high", "radialSegments": 20, "radiusData": {}, "radiusScale": 1, "radiusSize": 0.3, "radiusType": "size", "roughness": 0.4, "sele": "", "side": "double", "sphereDetail": 2, "useInteriorColor": true, "visible": true, "wireframe": false }, "type": "base" }, "2": { "params": { "aspectRatio": 1.5, "assembly": "default", "bondScale": 0.3, "bondSpacing": 0.75, "clipCenter": { "x": 0, "y": 0, "z": 0 }, "clipNear": 0, "clipRadius": 0, "colorMode": "hcl", "colorReverse": false, "colorScale": "", "colorScheme": "element", "colorValue": 9474192, "cylinderOnly": false, "defaultAssembly": "", "depthWrite": true, "diffuse": 16777215, "diffuseInterior": false, "disableImpostor": false, "disablePicking": false, "flatShaded": false, "interiorColor": 2236962, "interiorDarkening": 0, "lazy": false, "lineOnly": false, "linewidth": 2, "matrix": { "elements": [ 1, 0, 0, 0, 0, 1, 0, 0, 0, 0, 1, 0, 0, 0, 0, 1 ] }, "metalness": 0, "multipleBond": "off", "opacity": 1, "openEnded": true, "quality": "high", "radialSegments": 20, "radiusData": {}, "radiusScale": 2, "radiusSize": 0.15, "radiusType": "size", "roughness": 0.4, "sele": "ligand", "side": "double", "sphereDetail": 2, "useInteriorColor": true, "visible": true, "wireframe": false }, "type": "ball+stick" } } }, "_ngl_serialize": false, "_ngl_version": "2.0.0-dev.33", "_scene_position": {}, "_scene_rotation": {}, "background": "white", "count": 11, "frame": 4, "layout": "IPY_MODEL_d8a806ec68724d12adac92ab07f1f288", "n_components": 1, "picked": {} } }, "e1c3ba42a853477b8b65e4095c0d9715": { "model_module": "@jupyter-widgets/controls", "model_module_version": "1.3.0", "model_name": "ImageModel", "state": { "layout": "IPY_MODEL_2aa84f0ccffc444b847d76d7b56f7e83", "width": "900.0" } }, "e5fb22e37ff24950a01a13048804b693": { "model_module": "@jupyter-widgets/base", "model_module_version": "1.1.0", "model_name": "LayoutModel", "state": {} }, "e88e27f8c22c46f58035edb19742e29e": { "model_module": "@jupyter-widgets/base", "model_module_version": "1.1.0", "model_name": "LayoutModel", "state": {} }, "e9f7a7a436d547fe82e70168bd73baa9": { "model_module": "nglview-js-widgets", "model_module_version": "1.1.5", "model_name": "NGLModel", "state": { "_camera_orientation": [ 134.2024446924757, 0, 0, 0, 0, 134.2024446924757, 0, 0, 0, 0, 134.2024446924757, 0, -51.43800163269043, -35.768001198768616, -35.2930006980896, 1 ], "_camera_str": "orthographic", "_image_data": "", "_n_dragged_files": 0, "_ngl_coordinate_resource": {}, "_ngl_full_stage_parameters": { "ambientColor": 14540253, "ambientIntensity": 0.2, "backgroundColor": "white", "cameraEyeSep": 0.3, "cameraFov": 40, "cameraType": "perspective", "clipDist": 10, "clipFar": 100, "clipNear": 0, "fogFar": 100, "fogNear": 50, "hoverTimeout": 0, "impostor": true, "lightColor": 14540253, "lightIntensity": 1, "mousePreset": "default", "panSpeed": 1, "quality": "medium", "rotateSpeed": 2, "sampleLevel": 0, "tooltip": true, "workerDefault": true, "zoomSpeed": 1.2 }, "_ngl_full_stage_parameters_embed": {}, "_ngl_msg_archive": [], "_ngl_original_stage_parameters": { "ambientColor": 14540253, "ambientIntensity": 0.2, "backgroundColor": "white", "cameraEyeSep": 0.3, "cameraFov": 40, "cameraType": "perspective", "clipDist": 10, "clipFar": 100, "clipNear": 0, "fogFar": 100, "fogNear": 50, "hoverTimeout": 0, "impostor": true, "lightColor": 14540253, "lightIntensity": 1, "mousePreset": "default", "panSpeed": 1, "quality": "medium", "rotateSpeed": 2, "sampleLevel": 0, "tooltip": true, "workerDefault": true, "zoomSpeed": 1.2 }, "_ngl_repr_dict": { "0": { "0": { "params": { "aspectRatio": 5, "assembly": "default", "capped": true, "clipCenter": { "x": 0, "y": 0, "z": 0 }, "clipNear": 0, "clipRadius": 0, "colorMode": "hcl", "colorReverse": true, "colorScale": "spectral", "colorScheme": "residueindex", "colorValue": 9474192, "defaultAssembly": "", "depthWrite": true, "diffuse": 16777215, "diffuseInterior": false, "disablePicking": false, "flatShaded": false, "interiorColor": 2236962, "interiorDarkening": 0, "lazy": false, "matrix": { "elements": [ 1, 0, 0, 0, 0, 1, 0, 0, 0, 0, 1, 0, 0, 0, 0, 1 ] }, "metalness": 0, "opacity": 1, "quality": "high", "radialSegments": 20, "radiusData": {}, "radiusScale": 0.7, "radiusSize": 1, "radiusType": "sstruc", "roughness": 0.4, "sele": "", "side": "double", "smoothSheet": false, "subdiv": 6, "tension": null, "useInteriorColor": true, "visible": true, "wireframe": false }, "type": "cartoon" }, "1": { "params": { "aspectRatio": 1, "assembly": "default", "bondScale": 0.4, "clipCenter": { "x": 0, "y": 0, "z": 0 }, "clipNear": 0, "clipRadius": 0, "colorMode": "hcl", "colorReverse": true, "colorScale": "spectral", "colorScheme": "residueindex", "colorValue": 9474192, "cylinderOnly": false, "defaultAssembly": "", "depthWrite": true, "diffuse": 16777215, "diffuseInterior": false, "disableImpostor": false, "disablePicking": false, "flatShaded": false, "interiorColor": 2236962, "interiorDarkening": 0, "lazy": false, "lineOnly": false, "linewidth": 2, "matrix": { "elements": [ 1, 0, 0, 0, 0, 1, 0, 0, 0, 0, 1, 0, 0, 0, 0, 1 ] }, "metalness": 0, "opacity": 1, "openEnded": true, "quality": "high", "radialSegments": 20, "radiusData": {}, "radiusScale": 1, "radiusSize": 0.3, "radiusType": "size", "roughness": 0.4, "sele": "", "side": "double", "sphereDetail": 2, "useInteriorColor": true, "visible": true, "wireframe": false }, "type": "base" }, "2": { "params": { "aspectRatio": 1.5, "assembly": "default", "bondScale": 0.3, "bondSpacing": 0.75, "clipCenter": { "x": 0, "y": 0, "z": 0 }, "clipNear": 0, "clipRadius": 0, "colorMode": "hcl", "colorReverse": false, "colorScale": "", "colorScheme": "element", "colorValue": 9474192, "cylinderOnly": false, "defaultAssembly": "", "depthWrite": true, "diffuse": 16777215, "diffuseInterior": false, "disableImpostor": false, "disablePicking": false, "flatShaded": false, "interiorColor": 2236962, "interiorDarkening": 0, "lazy": false, "lineOnly": false, "linewidth": 2, "matrix": { "elements": [ 1, 0, 0, 0, 0, 1, 0, 0, 0, 0, 1, 0, 0, 0, 0, 1 ] }, "metalness": 0, "multipleBond": "off", "opacity": 1, "openEnded": true, "quality": "high", "radialSegments": 20, "radiusData": {}, "radiusScale": 2, "radiusSize": 0.15, "radiusType": "size", "roughness": 0.4, "sele": "ligand", "side": "double", "sphereDetail": 2, "useInteriorColor": true, "visible": true, "wireframe": false }, "type": "ball+stick" }, "3": { "params": { "assembly": "default", "bondSpacing": 1, "clipCenter": { "x": 0, "y": 0, "z": 0 }, "clipNear": 0, "clipRadius": 0, "colorMode": "hcl", "colorReverse": false, "colorScale": "", "colorScheme": "element", "colorValue": 9474192, "crossSize": 0.4, "crosses": "lone", "defaultAssembly": "", "depthWrite": true, "diffuse": 16777215, "diffuseInterior": false, "disablePicking": false, "interiorColor": 2236962, "interiorDarkening": 0, "lazy": false, "lines": true, "linewidth": 2, "matrix": { "elements": [ 1, 0, 0, 0, 0, 1, 0, 0, 0, 0, 1, 0, 0, 0, 0, 1 ] }, "multipleBond": "off", "opacity": 1, "quality": "medium", "radiusData": {}, "radiusScale": 1, "radiusSize": 1, "radiusType": "vdw", "sele": "all", "useInteriorColor": false, "visible": true }, "type": "line" } } }, "_ngl_serialize": false, "_ngl_version": "2.0.0-dev.33", "_scene_position": {}, "_scene_rotation": {}, "background": "white", "count": 11, "frame": 0, "layout": "IPY_MODEL_c29041f1e8bd4d049512b5e182fe21bb", "n_components": 1, "picked": {} } }, "eac49750d3034c39ab349839382f450a": { "model_module": "@jupyter-widgets/base", "model_module_version": "1.1.0", "model_name": "LayoutModel", "state": {} }, "ecb2acde0fa748b18c2bc21f6be178dd": { "model_module": "nglview-js-widgets", "model_module_version": "1.1.5", "model_name": "NGLModel", "state": { "_camera_orientation": [ 3.9394637595341426, 13.240771081641203, -133.84823369044588, 0, 134.49887505284164, -1.2327449460060083, 3.8366658728148044, 0, -0.8486992452226529, -133.90052044956053, -13.270922670616796, 0, -31.88500165939331, -29.30000114440918, -35.6879997253418, 1 ], "_camera_str": "orthographic", "_image_data": "", "_n_dragged_files": 0, "_ngl_coordinate_resource": {}, "_ngl_full_stage_parameters": { "ambientColor": 14540253, "ambientIntensity": 0.2, "backgroundColor": "white", "cameraEyeSep": 0.3, "cameraFov": 40, "cameraType": "perspective", "clipDist": 10, "clipFar": 100, "clipNear": 0, "fogFar": 100, "fogNear": 50, "hoverTimeout": 0, "impostor": true, "lightColor": 14540253, "lightIntensity": 1, "mousePreset": "default", "panSpeed": 1, "quality": "medium", "rotateSpeed": 2, "sampleLevel": 0, "tooltip": true, "workerDefault": true, "zoomSpeed": 1.2 }, "_ngl_full_stage_parameters_embed": {}, "_ngl_msg_archive": [], "_ngl_original_stage_parameters": { "ambientColor": 14540253, "ambientIntensity": 0.2, "backgroundColor": "white", "cameraEyeSep": 0.3, "cameraFov": 40, "cameraType": "perspective", "clipDist": 10, "clipFar": 100, "clipNear": 0, "fogFar": 100, "fogNear": 50, "hoverTimeout": 0, "impostor": true, "lightColor": 14540253, "lightIntensity": 1, "mousePreset": "default", "panSpeed": 1, "quality": "medium", "rotateSpeed": 2, "sampleLevel": 0, "tooltip": true, "workerDefault": true, "zoomSpeed": 1.2 }, "_ngl_repr_dict": { "0": { "0": { "params": { "aspectRatio": 5, "assembly": "default", "capped": true, "clipCenter": { "x": 0, "y": 0, "z": 0 }, "clipNear": 0, "clipRadius": 0, "colorMode": "hcl", "colorReverse": true, "colorScale": "spectral", "colorScheme": "residueindex", "colorValue": 9474192, "defaultAssembly": "", "depthWrite": true, "diffuse": 16777215, "diffuseInterior": false, "disablePicking": false, "flatShaded": false, "interiorColor": 2236962, "interiorDarkening": 0, "lazy": false, "matrix": { "elements": [ 1, 0, 0, 0, 0, 1, 0, 0, 0, 0, 1, 0, 0, 0, 0, 1 ] }, "metalness": 0, "opacity": 1, "quality": "high", "radialSegments": 20, "radiusData": {}, "radiusScale": 0.7, "radiusSize": 1, "radiusType": "sstruc", "roughness": 0.4, "sele": "", "side": "double", "smoothSheet": false, "subdiv": 6, "tension": null, "useInteriorColor": true, "visible": true, "wireframe": false }, "type": "cartoon" }, "1": { "params": { "aspectRatio": 1, "assembly": "default", "bondScale": 0.4, "clipCenter": { "x": 0, "y": 0, "z": 0 }, "clipNear": 0, "clipRadius": 0, "colorMode": "hcl", "colorReverse": true, "colorScale": "spectral", "colorScheme": "residueindex", "colorValue": 9474192, "cylinderOnly": false, "defaultAssembly": "", "depthWrite": true, "diffuse": 16777215, "diffuseInterior": false, "disableImpostor": false, "disablePicking": false, "flatShaded": false, "interiorColor": 2236962, "interiorDarkening": 0, "lazy": false, "lineOnly": false, "linewidth": 2, "matrix": { "elements": [ 1, 0, 0, 0, 0, 1, 0, 0, 0, 0, 1, 0, 0, 0, 0, 1 ] }, "metalness": 0, "opacity": 1, "openEnded": true, "quality": "high", "radialSegments": 20, "radiusData": {}, "radiusScale": 1, "radiusSize": 0.3, "radiusType": "size", "roughness": 0.4, "sele": "", "side": "double", "sphereDetail": 2, "useInteriorColor": true, "visible": true, "wireframe": false }, "type": "base" }, "2": { "params": { "aspectRatio": 1.5, "assembly": "default", "bondScale": 0.3, "bondSpacing": 0.75, "clipCenter": { "x": 0, "y": 0, "z": 0 }, "clipNear": 0, "clipRadius": 0, "colorMode": "hcl", "colorReverse": false, "colorScale": "", "colorScheme": "element", "colorValue": 9474192, "cylinderOnly": false, "defaultAssembly": "", "depthWrite": true, "diffuse": 16777215, "diffuseInterior": false, "disableImpostor": false, "disablePicking": false, "flatShaded": false, "interiorColor": 2236962, "interiorDarkening": 0, "lazy": false, "lineOnly": false, "linewidth": 2, "matrix": { "elements": [ 1, 0, 0, 0, 0, 1, 0, 0, 0, 0, 1, 0, 0, 0, 0, 1 ] }, "metalness": 0, "multipleBond": "off", "opacity": 1, "openEnded": true, "quality": "high", "radialSegments": 20, "radiusData": {}, "radiusScale": 2, "radiusSize": 0.15, "radiusType": "size", "roughness": 0.4, "sele": "ligand", "side": "double", "sphereDetail": 2, "useInteriorColor": true, "visible": true, "wireframe": false }, "type": "ball+stick" } } }, "_ngl_serialize": false, "_ngl_version": "2.0.0-dev.33", "_scene_position": {}, "_scene_rotation": {}, "background": "white", "count": 11, "frame": 5, "layout": "IPY_MODEL_3403e1d46e454c6a9d21003d3a8721d0", "n_components": 1, "picked": {} } }, "f08c478f91b14996a14bd2bf5672b7fe": { "model_module": "@jupyter-widgets/base", "model_module_version": "1.1.0", "model_name": "LayoutModel", "state": {} }, "f92dc1a65b564471b8e32e985a108585": { "model_module": "@jupyter-widgets/base", "model_module_version": "1.1.0", "model_name": "LayoutModel", "state": {} }, "fbc735e76997480ebc993072d0c99fcd": { "model_module": "@jupyter-widgets/base", "model_module_version": "1.1.0", "model_name": "LayoutModel", "state": {} }, "fc1b830a8f5c4ba592f63e5930df787b": { "model_module": "@jupyter-widgets/base", "model_module_version": "1.1.0", "model_name": "LayoutModel", "state": {} }, "fd31b4e89e8a46cbb2c2e1bd3d020543": { "model_module": "nglview-js-widgets", "model_module_version": "1.1.5", "model_name": "NGLModel", "state": { "_camera_orientation": [ 23.10238884638627, 0, 0, 0, 0, 23.10238884638627, 0, 0, 0, 0, 23.10238884638627, 0, -55.106557846069336, -34.22588539123535, -28.32262134552002, 1 ], "_camera_str": "orthographic", "_image_data": "", "_n_dragged_files": 0, "_ngl_coordinate_resource": {}, "_ngl_full_stage_parameters": { "ambientColor": 14540253, "ambientIntensity": 0.2, "backgroundColor": "white", "cameraEyeSep": 0.3, "cameraFov": 40, "cameraType": "perspective", "clipDist": 10, "clipFar": 100, "clipNear": 0, "fogFar": 100, "fogNear": 50, "hoverTimeout": 0, "impostor": true, "lightColor": 14540253, "lightIntensity": 1, "mousePreset": "default", "panSpeed": 1, "quality": "medium", "rotateSpeed": 2, "sampleLevel": 0, "tooltip": true, "workerDefault": true, "zoomSpeed": 1.2 }, "_ngl_full_stage_parameters_embed": {}, "_ngl_msg_archive": [], "_ngl_original_stage_parameters": { "ambientColor": 14540253, "ambientIntensity": 0.2, "backgroundColor": "white", "cameraEyeSep": 0.3, "cameraFov": 40, "cameraType": "perspective", "clipDist": 10, "clipFar": 100, "clipNear": 0, "fogFar": 100, "fogNear": 50, "hoverTimeout": 0, "impostor": true, "lightColor": 14540253, "lightIntensity": 1, "mousePreset": "default", "panSpeed": 1, "quality": "medium", "rotateSpeed": 2, "sampleLevel": 0, "tooltip": true, "workerDefault": true, "zoomSpeed": 1.2 }, "_ngl_repr_dict": { "0": { "0": { "params": { "aspectRatio": 5, "assembly": "default", "capped": true, "clipCenter": { "x": 0, "y": 0, "z": 0 }, "clipNear": 0, "clipRadius": 0, "colorMode": "hcl", "colorReverse": true, "colorScale": "spectral", "colorScheme": "residueindex", "colorValue": 9474192, "defaultAssembly": "", "depthWrite": true, "diffuse": 16777215, "diffuseInterior": false, "disablePicking": false, "flatShaded": false, "interiorColor": 2236962, "interiorDarkening": 0, "lazy": false, "matrix": { "elements": [ 1, 0, 0, 0, 0, 1, 0, 0, 0, 0, 1, 0, 0, 0, 0, 1 ] }, "metalness": 0, "opacity": 1, "quality": "high", "radialSegments": 20, "radiusData": {}, "radiusScale": 0.7, "radiusSize": 1, "radiusType": "sstruc", "roughness": 0.4, "sele": "", "side": "double", "smoothSheet": false, "subdiv": 6, "tension": null, "useInteriorColor": true, "visible": true, "wireframe": false }, "type": "cartoon" }, "1": { "params": { "aspectRatio": 1, "assembly": "default", "bondScale": 0.4, "clipCenter": { "x": 0, "y": 0, "z": 0 }, "clipNear": 0, "clipRadius": 0, "colorMode": "hcl", "colorReverse": true, "colorScale": "spectral", "colorScheme": "residueindex", "colorValue": 9474192, "cylinderOnly": false, "defaultAssembly": "", "depthWrite": true, "diffuse": 16777215, "diffuseInterior": false, "disableImpostor": false, "disablePicking": false, "flatShaded": false, "interiorColor": 2236962, "interiorDarkening": 0, "lazy": false, "lineOnly": false, "linewidth": 2, "matrix": { "elements": [ 1, 0, 0, 0, 0, 1, 0, 0, 0, 0, 1, 0, 0, 0, 0, 1 ] }, "metalness": 0, "opacity": 1, "openEnded": true, "quality": "high", "radialSegments": 20, "radiusData": {}, "radiusScale": 1, "radiusSize": 0.3, "radiusType": "size", "roughness": 0.4, "sele": "", "side": "double", "sphereDetail": 2, "useInteriorColor": true, "visible": true, "wireframe": false }, "type": "base" }, "2": { "params": { "aspectRatio": 1.5, "assembly": "default", "bondScale": 0.3, "bondSpacing": 0.75, "clipCenter": { "x": 0, "y": 0, "z": 0 }, "clipNear": 0, "clipRadius": 0, "colorMode": "hcl", "colorReverse": false, "colorScale": "", "colorScheme": "element", "colorValue": 9474192, "cylinderOnly": false, "defaultAssembly": "", "depthWrite": true, "diffuse": 16777215, "diffuseInterior": false, "disableImpostor": false, "disablePicking": false, "flatShaded": false, "interiorColor": 2236962, "interiorDarkening": 0, "lazy": false, "lineOnly": false, "linewidth": 2, "matrix": { "elements": [ 1, 0, 0, 0, 0, 1, 0, 0, 0, 0, 1, 0, 0, 0, 0, 1 ] }, "metalness": 0, "multipleBond": "off", "opacity": 1, "openEnded": true, "quality": "high", "radialSegments": 20, "radiusData": {}, "radiusScale": 2, "radiusSize": 0.15, "radiusType": "size", "roughness": 0.4, "sele": "ligand", "side": "double", "sphereDetail": 2, "useInteriorColor": true, "visible": true, "wireframe": false }, "type": "ball+stick" }, "3": { "params": { "assembly": "default", "bondSpacing": 1, "clipCenter": { "x": 0, "y": 0, "z": 0 }, "clipNear": 0, "clipRadius": 0, "colorMode": "hcl", "colorReverse": false, "colorScale": "", "colorScheme": "element", "colorValue": 9474192, "crossSize": 0.4, "crosses": "lone", "defaultAssembly": "", "depthWrite": true, "diffuse": 16777215, "diffuseInterior": false, "disablePicking": false, "interiorColor": 2236962, "interiorDarkening": 0, "lazy": false, "lines": true, "linewidth": 2, "matrix": { "elements": [ 1, 0, 0, 0, 0, 1, 0, 0, 0, 0, 1, 0, 0, 0, 0, 1 ] }, "multipleBond": "off", "opacity": 1, "quality": "medium", "radiusData": {}, "radiusScale": 1, "radiusSize": 1, "radiusType": "vdw", "sele": "all", "useInteriorColor": false, "visible": true }, "type": "line" } } }, "_ngl_serialize": false, "_ngl_version": "2.0.0-dev.33", "_scene_position": {}, "_scene_rotation": {}, "background": "white", "count": 11, "frame": 0, "layout": "IPY_MODEL_42a80c9f986142d8bf82493898c09015", "n_components": 1, "picked": {} } } }, "version_major": 2, "version_minor": 0 } } }, "nbformat": 4, "nbformat_minor": 2 }